IMP logo
IMP Reference Guide  2.5.0
The Integrative Modeling Platform
IMP::Object Class Reference

Common base class for heavy weight IMP objects. More...

#include <IMP/Object.h>

Inherits IMP::NonCopyable.

Inherited by IMP::algebra::DynamicNearestNeighbor3D, IMP::algebra::NearestNeighborD< D >, IMP::algebra::VectorKDMetric, IMP::atom::CHARMMResidueTopologyBase, IMP::atom::CHARMMSegmentTopology, IMP::atom::CHARMMTopology, IMP::atom::ForceFieldParameters, IMP::atom::Mol2Selector, IMP::atom::PDBSelector, IMP::atom::SmoothingFunction, IMP::Configuration, IMP::ConfigurationSet, IMP::core::ClosePairsFinder, IMP::core::DataObject< Data >, IMP::display::Geometry, IMP::display::Writer, IMP::domino::AssignmentContainer, IMP::domino::AssignmentsTable, IMP::domino::ParticleStates, IMP::domino::ParticleStatesTable, IMP::domino::RestraintCache, IMP::domino::SubsetFilter, IMP::domino::SubsetFilterTable, IMP::em2d::CollisionCrossSection, IMP::em2d::Image, IMP::em2d::ImageReaderWriter, IMP::em2d::ProjectionFinder, IMP::em2d::ScoreFunction, IMP::em::CoarseCC, IMP::em::DensityMap, IMP::em::EnvelopeScore, IMP::em::MapReaderWriter, IMP::em::PCAAligner, IMP::example::ExampleObject, IMP::isd::BivariateFunction, IMP::isd::CrossLinkData, IMP::isd::CysteineCrossLinkData, IMP::isd::FNormal, IMP::isd::FretData, IMP::isd::GaussianProcessInterpolation, IMP::isd::MultivariateFNormalSufficient, IMP::isd::UnivariateFunction, IMP::isd::vonMises, IMP::isd::vonMisesSufficient, IMP::kinematics::DOF, IMP::kinematics::DOFsSampler, IMP::kinematics::Joint, IMP::kinematics::KinematicForest, IMP::kinematics::LocalPlanner, IMP::kmeans::KMeans, IMP::Model, IMP::ModelObject, IMP::mpi::ReplicaExchange, IMP::multifit::AssemblyHeader, IMP::multifit::ComponentHeader, IMP::multifit::Ensemble, IMP::multifit::FFTFitting, IMP::multifit::FFTFittingOutput, IMP::multifit::ProbabilisticAnchorGraph, IMP::multifit::ProteomicsData, IMP::multifit::ProteomicsEMAlignmentAtomic, IMP::multifit::SettingsData, IMP::PairModifier, IMP::PairPredicate, IMP::PairScore, IMP::QuadModifier, IMP::QuadPredicate, IMP::QuadScore, IMP::Refiner, IMP::rmf::LoadLink, IMP::rmf::SaveLink, IMP::rotamer::RotamerCalculator, IMP::rotamer::RotamerLibrary, IMP::Sampler, IMP::saxs::ChiFreeScore, IMP::saxs::ChiScore, IMP::saxs::ChiScoreLog, IMP::saxs::DerivativeCalculator, IMP::saxs::Profile, IMP::saxs::ProfileFitter< ScoringFunctionT >, IMP::saxs::RatioVolatilityScore, IMP::saxs::RigidBodiesProfileHandler, IMP::SingletonModifier, IMP::SingletonPredicate, IMP::SingletonScore, IMP::statistics::Embedding, IMP::statistics::Metric, IMP::statistics::PartitionalClustering, IMP::TripletModifier, IMP::TripletPredicate, IMP::TripletScore, IMP::UnaryFunction, IMP::Undecorator, and log.DummyObject.

Detailed Description

Common base class for heavy weight IMP objects.

The base class for non value-type classes in IMP. Anything inheriting from Object has the following properties:

  • has embedded information about the module and version which can be accessed using Object::get_version_info(). This information can be used to log what version of software is used to compute a result.
  • it has a local logging level which can override the global one allowing fine grained logging control.
  • in Python, there is a method Class::get_from(Object *o) that attempts to cast o to an object of type Class and throws an exception if it fails.
  • the object keeps track of whether it has been been used. See the Object::set_was_used() method for an explanation.
  • It is reference counted

Types inheriting from Object should always be created using new in C++ and passed using pointers and stored using Pointer objects. Note that you have to be careful of cycles and so must use WeakPointer objects to break cycles. IMP_NEW() can help shorten creating a ref counted pointer. See Pointer for more information.

See example::ExampleObject for a simple example.

Reference counting is a technique for managing memory and automatically freeing memory (destroying objects) when it is no longer needed. In reference counting, each object has a reference count, which tracks how many different places are using the object. When this count goes to 0, the object is freed.

Python internally reference counts everything. C++, on the other hand, requires extra steps be taken to ensure that objects are reference counted properly.

In IMP, reference counting is done through the Pointer, PointerMember and Object classes. The former should be used instead of a raw C++ pointer when storing a pointer to any object inheriting from Object.

Any time one is using reference counting, one needs to be aware of cycles, since if, for example, object A contains an IMP::Pointer to object B and object B contains an Pointer to object A, their reference counts will never go to 0 even if both A and B are no longer used. To avoid this, use an WeakPointer in one of A or B.

Functions that create new objects should follow the following pattern

  ObjectType *create_object(arguments) {
     IMP_NEW(ObjectType, ret, (args));
     do_stuff;
     return ret.release();
   }

using Pointer::release() to safely return the new object without freeing it.

Definition at line 106 of file Object.h.

Public Member Functions

virtual void clear_caches ()
 
CheckLevel get_check_level () const
 
LogLevel get_log_level () const
 
virtual VersionInfo get_version_info () const
 Get information about the module and version of the object. More...
 
void set_check_level (CheckLevel l)
 
void set_log_level (LogLevel l)
 Set the logging level used in this object. More...
 
void set_was_used (bool tf) const
 
void show (std::ostream &out=std::cout) const
 

Protected Member Functions

 Object (std::string name)
 Construct an object with the given name. More...
 
virtual void do_destroy ()
 

Names

All objects have names to aid in debugging and inspection of the state of the system. These names are not necessarily unique and should not be used to store data or as keys into a table. Use the address of the object instead since objects cannot be copied.

const std::string & get_name () const
 
void set_name (std::string name)
 
virtual std::string get_type_name () const
 

Constructor & Destructor Documentation

IMP::Object::Object ( std::string  name)
protected

Construct an object with the given name.

An instance of "%1%" in the string will be replaced by a unique index.

Member Function Documentation

virtual void IMP::Object::clear_caches ( )
virtual

Objects can have internal caches. This method resets them returning the object to its just-initialized state.

Reimplemented in IMP::core::ExcludedVolumeRestraint, and IMP::core::MinimumRestraint.

Definition at line 227 of file Object.h.

virtual void IMP::Object::do_destroy ( )
protectedvirtual

Override this method to take action on destruction.

Reimplemented in IMP::container::ExclusiveConsecutivePairContainer, IMP::display::PymolWriter, and IMP::display::ChimeraWriter.

Definition at line 231 of file Object.h.

virtual VersionInfo IMP::Object::get_version_info ( ) const
virtual

Get information about the module and version of the object.

Reimplemented in IMP::isd::GeneralizedGuinierPorodFunction, IMP::atom::WritePDBOptimizerState, IMP::atom::CHARMMResidueTopology, IMP::isd::Covariance1DFunction, IMP::em::DensityMap, IMP::atom::CHARMMPatch, IMP::domino::CappedAssignmentContainer, IMP::atom::CHARMMIdealResidueTopology, IMP::atom::SelectionGeometry, IMP::domino::HeapAssignmentContainer, IMP::domino::ProbabilisticSubsetFilterTable, IMP::Model, IMP::atom::CHARMMResidueTopologyBase, IMP::atom::NotPDBSelector, IMP::domino::RangeViewAssignmentContainer, IMP::atom::CHARMMParameters, IMP::domino::PairListSubsetFilterTable, IMP::atom::OrPDBSelector, IMP::domino::ReadAssignmentContainer, IMP::atom::BondGeometry, IMP::atom::BondsGeometry, IMP::domino::ListSubsetFilterTable, IMP::atom::AndPDBSelector, IMP::domino::PermutationStates, IMP::isd::Linear1DFunction, IMP::domino::WriteAssignmentContainer, IMP::atom::PPDBSelector, IMP::atom::BackbonePDBSelector, IMP::domino::RecursiveStates, IMP::domino::EquivalenceAndExclusionSubsetFilterTable, IMP::atom::CHARMMTopology, IMP::saxs::Profile, IMP::core::MonteCarloWithBasinHopping, IMP::domino::EquivalenceSubsetFilterTable, IMP::domino::ReadHDF5AssignmentContainer, IMP::atom::NonWaterPDBSelector, IMP::domino::EqualitySubsetFilterTable, IMP::isd::MultivariateFNormalSufficient, IMP::domino::RestraintCache, IMP::domino::CompoundStates, IMP::atom::HierarchiesGeometry, IMP::core::MonteCarloWithLocalOptimization, IMP::domino::ExclusionSubsetFilterTable, IMP::domino::NestedRigidBodyStates, IMP::domino::WriteHDF5AssignmentContainer, IMP::atom::NonWaterNonHydrogenPDBSelector, IMP::atom::HierarchyGeometry, IMP::algebra::DynamicNearestNeighbor3D, IMP::container::ExclusiveConsecutivePairFilter, IMP::atom::HydrogenPDBSelector, IMP::multifit::ProteomicsData, IMP::misc::MetricClosePairsFinder< LowerBound, UpperBound >, IMP::domino::RigidBodyStates, IMP::core::SoftSpherePairScore, IMP::atom::WaterPDBSelector, IMP::container::ExclusiveConsecutivePairContainer, IMP::rmf::HierarchySaveLink, IMP::core::EdgePairGeometry, IMP::core::EdgePairsGeometry, IMP::core::WeightedSphereDistancePairScore, IMP::em2d::ProjectionFinder, IMP::atom::MolecularDynamics, IMP::multifit::SettingsData, IMP::algebra::NearestNeighborD< D >, IMP::domino::SampleAssignmentContainer, IMP::domino::XYZStates, IMP::core::XYZDerivativeGeometry, IMP::core::XYZDerivativesGeometry, IMP::atom::ChainPDBSelector, IMP::em2d::Image, IMP::em2d::SpiderImageReaderWriter, IMP::domino::MinimumRestraintScoreSubsetFilterTable, IMP::core::XYZRGeometry, IMP::core::XYZRsGeometry, IMP::isd::GaussianProcessInterpolation, IMP::core::NormalizedSphereDistancePairScore, IMP::isd::vonMisesSufficient, IMP::atom::AllPDBSelector, IMP::em2d::Em2DRestraint, IMP::domino::ListAssignmentsTable, IMP::core::PredicateSingletonScore< Predicate, Score >, IMP::domino::IndexStates, IMP::core::CoinFlipPairPredicate, IMP::core::CoinFlipQuadPredicate, IMP::core::CoinFlipSingletonPredicate, IMP::core::CoinFlipTripletPredicate, IMP::atom::NPDBSelector, IMP::container::ClosePairContainer, IMP::domino::ListAssignmentContainer, IMP::isd::GaussianEMRestraint, IMP::atom::ForceSwitch, IMP::core::MCCGSampler, IMP::domino::RestraintScoreSubsetFilterTable, IMP::em::CoarseCC, IMP::em2d::ProjectionParametersScoreState, IMP::rotamer::RotamerLibrary, IMP::core::SphereDistanceToSingletonScore, IMP::domino::BranchAndBoundAssignmentsTable, IMP::rmf::HierarchyLoadLink, IMP::atom::CPDBSelector, IMP::display::PlaneGeometry, IMP::isd::CysteineCrossLinkRestraint, IMP::multifit::AssemblyHeader, IMP::core::IncrementalScoringFunction, IMP::pmi::TransformMover, IMP::domino::ParticleStatesTable, IMP::core::ClosePairsPairScore, IMP::rotamer::RotamerCalculator, IMP::atom::BrownianDynamics, IMP::core::AllSamePairPredicate, IMP::core::AllSameQuadPredicate, IMP::core::AllSameSingletonPredicate, IMP::core::AllSameTripletPredicate, IMP::core::RigidBodyTunneler, IMP::em2d::ProjectionStates, IMP::isd::FretRestraint, IMP::container::ConsecutivePairFilter, IMP::em2d::JPGImageReaderWriter, IMP::em2d::TIFFImageReaderWriter, IMP::kmeans::KMeans, IMP::statistics::VectorDEmbedding, IMP::atom::CBetaPDBSelector, IMP::display::SurfaceMeshGeometry, IMP::core::MSConnectivityRestraint, IMP::core::IsCollisionPairPredicate, IMP::core::HarmonicSphereDistancePairScore, IMP::container::ListPairContainer, IMP::container::ListQuadContainer, IMP::container::ListSingletonContainer, IMP::container::ListTripletContainer, IMP::pmi::CompositeRestraint, IMP::core::RigidBodyUmbrella, IMP::core::RigidClosePairsFinder, IMP::isd::TALOSRestraint, IMP::core::OrderedTypePairPredicate, IMP::core::OrderedTypeQuadPredicate, IMP::core::OrderedTypeSingletonPredicate, IMP::core::OrderedTypeTripletPredicate, IMP::container::DynamicListPairContainer, IMP::container::DynamicListQuadContainer, IMP::container::DynamicListSingletonContainer, IMP::container::DynamicListTripletContainer, IMP::core::ExcludedVolumeRestraint, IMP::core::TransformationSymmetry, IMP::em2d::ParticlesDummyRestraint, IMP::atom::CAlphaPDBSelector, IMP::em::MRCReaderWriter, IMP::em::SpiderMapReaderWriter, IMP::atom::LennardJonesPairScore, IMP::container::CloseBipartitePairContainer, IMP::multifit::ComplementarityRestraint, IMP::domino::RecursiveAssignmentsTable, IMP::display::LabelGeometry, IMP::isd::GaussianProcessInterpolationRestraint, IMP::isd::LognormalAmbiguousRestraint, IMP::core::HarmonicUpperBoundSphereDiameterPairScore, IMP::atom::SoapPairFilter, IMP::core::FixedRefiner, IMP::atom::CHARMMStereochemistryRestraint, IMP::core::WeightedDerivativesToRefined, IMP::domino::PackedAssignmentContainer, IMP::statistics::ParticleEmbedding, IMP::container::ConsecutivePairContainer, IMP::core::TruncatedHarmonic< DIRECTION >, IMP::core::TypedPairScore, IMP::isd::AtomicCrossLinkMSRestraint, IMP::atom::ATOMPDBSelector, IMP::core::CentroidOfRefined, IMP::mpi::ReplicaExchange, IMP::multifit::ProteomicsEMAlignmentAtomic, IMP::container::PredicatePairsRestraint, IMP::container::PredicateQuadsRestraint, IMP::container::PredicateSingletonsRestraint, IMP::container::PredicateTripletsRestraint, IMP::isd::FNormal, IMP::isd::MarginalNOERestraint, IMP::container::PairsConstraint, IMP::container::QuadsConstraint, IMP::container::SingletonsConstraint, IMP::container::TripletsConstraint, IMP::container::ConnectingPairContainer, IMP::core::BallMover, IMP::core::TransformationAndReflectionSymmetry, IMP::em2d::ScoreFunction, IMP::gsl::Simplex, IMP::isd::CrossLinkMSRestraint, IMP::algebra::MaxVectorKDMetric, IMP::core::PairConstraint, IMP::core::QuadConstraint, IMP::core::SingletonConstraint, IMP::core::TripletConstraint, IMP::display::ReferenceFrameGeometry, IMP::em::EMReaderWriter, IMP::em::FitRestraint, IMP::core::KClosePairsPairScore, IMP::core::PairRestraint, IMP::core::QuadRestraint, IMP::core::SingletonRestraint, IMP::core::TripletRestraint, IMP::em2d::GridStates, IMP::core::UnorderedTypePairPredicate, IMP::core::UnorderedTypeQuadPredicate, IMP::core::UnorderedTypeSingletonPredicate, IMP::core::UnorderedTypeTripletPredicate, IMP::em2d::Fine2DRegistrationRestraint, IMP::isd::MarginalHBondRestraint, IMP::isd::vonMises, IMP::core::RigidBodyMover, IMP::em::EnvelopeScore, IMP::em2d::PCAFitRestraint, IMP::em2d::RelativePositionMover, IMP::container::DistributePairsScoreState, IMP::container::DistributeQuadsScoreState, IMP::container::DistributeSingletonsScoreState, IMP::container::DistributeTripletsScoreState, IMP::core::ConnectivityRestraint, IMP::domino::SimpleAssignmentsTable, IMP::core::CoverRefined, IMP::saxs::Restraint, IMP::statistics::ChiSquareMetric, IMP::display::BoundingBoxGeometry, IMP::em2d::DistanceFilter, IMP::em2d::DummyRestraint, IMP::atom::NonAlternativePDBSelector, IMP::core::AttributeSingletonPredicate, IMP::display::PymolWriter, IMP::em::CoarseCCatIntervals, IMP::isd::GaussianRestraint, IMP::isd::LognormalRestraint, IMP::modeller::MultipleBinormalRestraint, IMP::atom::BondPairContainer, IMP::SaveToConfigurationSetOptimizerState, IMP::container::AllBipartitePairContainer, IMP::container::PairsRestraint, IMP::container::QuadsRestraint, IMP::container::SingletonsRestraint, IMP::container::TripletsRestraint, IMP::core::HarmonicWell, IMP::em::EnvelopeFitRestraint, IMP::multifit::ProbabilisticAnchorGraph, IMP::atom::CADihedralRestraint, IMP::statistics::ConfigurationSetRMSDMetric, IMP::atom::StereochemistryPairFilter, IMP::core::GenericDistanceToSingletonScore< UF >, IMP::display::TriangleGeometry, IMP::domino::DependencyScoreState, IMP::multifit::ComponentHeader, IMP::atom::BerendsenThermostatOptimizerState, IMP::core::NormalMover, IMP::isd::HybridMonteCarlo, IMP::rmf::SaveOptimizerState, IMP::score_functor::DistancePairScore< DistanceScoreT >, IMP::score_functor::DistancePairScore< score_functor::OrientedSoap >, IMP::score_functor::DistancePairScore< score_functor::Statistical< Key, BIPARTITE, INTERPOLATE, SPARSE > >, IMP::score_functor::DistancePairScore< score_functor::Statistical< ProteinLigandType, BIPARTITE, INTERPOLATE, false > >, IMP::score_functor::DistancePairScore< score_functor::Dope >, IMP::atom::CoulombPairScore, IMP::container::AllPairContainer, IMP::core::HarmonicUpperBoundSphereDistancePairScore, IMP::em2d::CollisionCrossSection, IMP::container::InContainerPairFilter, IMP::container::InContainerQuadFilter, IMP::container::InContainerSingletonFilter, IMP::container::InContainerTripletFilter, IMP::container::PairContainerSet, IMP::container::QuadContainerSet, IMP::container::SingletonContainerSet, IMP::container::TripletContainerSet, IMP::core::NeighborsTable, IMP::em::PCAFitRestraint, IMP::isd::CrossLinkData, IMP::RestraintSet, IMP::statistics::PartitionalClusteringWithCenter, IMP::display::PolygonGeometry, IMP::example::ExampleComplexRestraint, IMP::core::MonteCarlo, IMP::isd::AmbiguousRestraint, IMP::core::DiameterRestraint, IMP::isd::AmbiguousNOERestraint, IMP::atom::CAAngleRestraint, IMP::core::ConjugateGradients, IMP::em::EnvelopePenetrationRestraint, IMP::em::PCAAligner, IMP::em2d::DistanceFilterTable, IMP::gsl::QuasiNewton, IMP::pmi::SigmoidRestraintSphere, IMP::algebra::EuclideanVectorKDMetric, IMP::core::DihedralRestraint, IMP::display::RestraintSetGeometry, IMP::isd::FretData, IMP::isd::NOERestraint, IMP::misc::DecayPairContainerOptimizerState, IMP::multifit::WeightedExcludedVolumeRestraint, IMP::core::TransformedDistancePairScore, IMP::display::SegmentGeometry, IMP::em::DensityFillingRestraint, IMP::em2d::RigidBodiesImageFitRestraint, IMP::example::ExampleSingletonModifier, IMP::isd::CysteineCrossLinkData, IMP::kinematics::KinematicForest, IMP::atom::ImproperSingletonScore, IMP::Configuration, IMP::container::PairContainerStatistics, IMP::container::PairsOptimizerState, IMP::container::QuadContainerStatistics, IMP::container::QuadsOptimizerState, IMP::container::SingletonContainerStatistics, IMP::container::SingletonsOptimizerState, IMP::container::TripletContainerStatistics, IMP::container::TripletsOptimizerState, IMP::domino::DominoSampler, IMP::atom::EzRestraint, IMP::core::AngleRestraint, IMP::core::DerivativesFromRefined, IMP::core::TableRefiner, IMP::display::FilterGeometry, IMP::example::ExampleObject, IMP::example::ExampleUnaryFunction, IMP::atom::LangevinThermostatOptimizerState, IMP::container::MinimumPairRestraint, IMP::container::MinimumQuadRestraint, IMP::container::MinimumSingletonRestraint, IMP::container::MinimumTripletRestraint, IMP::core::GenericBoundingBox3DSingletonScore< UF >, IMP::core::DerivativesToRefined, IMP::multifit::FFTFitting, IMP::multifit::DummyRestraint, IMP::Particle, IMP::saxs::RigidBodiesProfileHandler, IMP::ConfigurationSet, IMP::core::ChildrenRefiner, IMP::display::PointGeometry, IMP::em::MapReaderWriter, IMP::kinematics::KinematicForestScoreState, IMP::kinematics::RevoluteJointMover, IMP::saxs::ChiScoreLog, IMP::isd::vonMisesKappaJeffreysRestraint, IMP::misc::WormLikeChain, IMP::saxs::RadiusOfGyrationRestraint, IMP::statistics::ConfigurationSetXYZEmbedding, IMP::atom::AngleSingletonScore, IMP::core::MoveStatisticsScoreState, IMP::display::ChimeraWriter, IMP::example::ExampleSubsetFilterTable, IMP::isd::RepulsiveDistancePairScore, IMP::isd::vonMisesKappaConjugateRestraint, IMP::multifit::RadiusOfGyrationRestraint, IMP::symmetry::RigidBodyMover, IMP::atom::VelocityScalingOptimizerState, IMP::container::EventPairsOptimizerState, IMP::container::EventQuadsOptimizerState, IMP::container::EventSingletonsOptimizerState, IMP::container::EventTripletsOptimizerState, IMP::core::BoxSweepClosePairsFinder, IMP::core::LeavesRefiner, IMP::core::ConstantPairPredicate, IMP::core::ConstantQuadPredicate, IMP::core::QuadraticClosePairsFinder, IMP::core::RigidBodyFrameGeometry, IMP::core::RigidBodyFramesGeometry, IMP::core::SerialMover, IMP::core::ConstantSingletonPredicate, IMP::core::ConstantTripletPredicate, IMP::display::EllipsoidGeometry, IMP::em2d::ImageReaderWriter, IMP::isd::MolecularDynamicsMover, IMP::saxs::RatioVolatilityScore, IMP::atom::BondSingletonScore, IMP::core::MinimumRestraint, IMP::core::Transform, IMP::atom::DihedralSingletonScore, IMP::core::GenericAttributeSingletonScore< UF >, IMP::core::Cosine, IMP::core::Harmonic, IMP::core::RefinedPairsPairScore, IMP::core::SphereDistancePairScore, IMP::example::ExampleRestraint, IMP::isd::UniformPrior, IMP::isd::WeightRestraint, IMP::multifit::Ensemble, IMP::score_functor::ScoreUnaryFunction< Score, D >, IMP::score_functor::ScoreUnaryFunction< score_functor::OpenCubicSpline >, IMP::container::MinimumPairScore, IMP::container::MinimumQuadScore, IMP::container::MinimumSingletonScore, IMP::container::MinimumTripletScore, IMP::core::GridClosePairsFinder, IMP::core::Linear, IMP::core::NearestNeighborsClosePairsFinder, IMP::core::InBoundingBox3DSingletonPredicate, IMP::display::RestraintGeometry, IMP::isd::LogWrapper, IMP::kinematics::Joint, IMP::misc::LowestRefinedPairScore, IMP::core::RigidBodyDerivativeGeometry, IMP::core::RigidBodyDerivativesGeometry, IMP::display::CylinderGeometry, IMP::example::ExampleConstraint, IMP::example::ExamplePairScore, IMP::statistics::RecursivePartitionalClusteringEmbedding, IMP::statistics::RecursivePartitionalClusteringMetric, IMP::symmetry::BallMover, IMP::atom::CoverBond, IMP::core::HarmonicDistancePairScore, IMP::core::WriteRestraintScoresOptimizerState, IMP::display::WriteOptimizerState, IMP::domino::BranchAndBoundSampler, IMP::em::XplorReaderWriter, IMP::misc::LogPairScore, IMP::atom::BondedPairFilter, IMP::atom::BondEndpointsRefiner, IMP::atom::CHARMMSegmentTopology, IMP::atom::RemoveTranslationOptimizerState, IMP::core::AngleTripletScore, IMP::core::ClosedCubicSpline, IMP::core::ConstantRestraint, IMP::isd::WeightMover, IMP::misc::SoftCylinderPairScore, IMP::multifit::FittingStates, IMP::core::HarmonicLowerBound, IMP::core::HarmonicUpperBound, IMP::core::RigidBodyAnglePairScore, IMP::kinematics::RRT, IMP::saxs::ChiScore, IMP::core::ChecksScoreState, IMP::core::VolumeRestraint, IMP::display::SphereGeometry, IMP::isd::JeffreysRestraint, IMP::multifit::FFTFittingOutput, IMP::atom::RemoveRigidMotionOptimizerState, IMP::atom::SameResiduePairFilter, IMP::kinematics::DOF, IMP::misc::StateAdaptor, IMP::core::RigidBodyHierarchyGeometry, IMP::gsl::ConjugateGradients, IMP::statistics::EuclideanMetric, IMP::display::GeometrySet, IMP::core::SteepestDescent, IMP::em::HighDensityEmbedding, IMP::misc::CommonEndpointPairFilter, IMP::kinematics::LocalPlanner, IMP::core::DistancePairScore, and IMP::kinematics::DOFsSampler.

Definition at line 173 of file Object.h.

void IMP::Object::set_check_level ( CheckLevel  l)

Each object can be assigned a different check level too.

void IMP::Object::set_log_level ( LogLevel  l)

Set the logging level used in this object.

Each object can be assigned a different log level in order to, for example, suppress messages for verbose and uninteresting objects. If set to DEFAULT, the global level as returned by IMP::get_log_level() is used, otherwise the local one is used. Methods in classes inheriting from Object should start with IMP_OBJECT_LOG to change the log level to the local one for this object and increase the current indent.

See Also
IMP::set_log_level()
IMP::get_log_level()
void IMP::Object::set_was_used ( bool  tf) const

IMP provides warnings when objects are never used before they are destroyed. Examples of use include adding an IMP::Restraint to an IMP::Model. If an object is not properly marked as used, or your code is the one using it, call set_was_used(true) on the object.


The documentation for this class was generated from the following file: