RDKit
Open-source cheminformatics and machine learning.
Invariant.h File Reference
#include <assert.h>
#include <string>
#include <iostream>
#include <stdexcept>
#include <RDGeneral/RDLog.h>

Go to the source code of this file.

Classes

class  Invar::Invariant
 

Namespaces

 Invar
 

Macros

#define INVARIANT_EXCEPTION_METHOD   1
 
#define ASSERT_INVARIANT(expr, mess)   assert( expr )
 
#define CHECK_INVARIANT(expr, mess)
 
#define PRECONDITION(expr, mess)
 
#define POSTCONDITION(expr, mess)
 
#define UNDER_CONSTRUCTION(fn)
 
#define RANGE_CHECK(lo, x, hi)
 
#define TEST_ASSERT(expr)
 

Functions

std::ostream & Invar::operator<< (std::ostream &s, const Invariant &inv)
 

Macro Definition Documentation

#define ASSERT_INVARIANT (   expr,
  mess 
)    assert( expr )

Definition at line 105 of file Invariant.h.

#define INVARIANT_EXCEPTION_METHOD   1

Definition at line 26 of file Invariant.h.

#define POSTCONDITION (   expr,
  mess 
)
Value:
if ( !(expr) ) { \
Invar::Invariant inv( "Post-condition Violation", mess, \
#expr, __FILE__, __LINE__ );\
BOOST_LOG(rdErrorLog) << "\n\n****\n" << inv << "****\n\n"; throw inv; }
#define BOOST_LOG(__arg__)
Definition: RDLog.h:42
boost::logging::rdLogger * rdErrorLog

Definition at line 124 of file Invariant.h.

Referenced by RDKit::PeriodicTable::getAtomicNumber(), RDGeom::Point3D::getPerpendicular(), and PySequenceHolder< T >::operator[]().

#define PRECONDITION (   expr,
  mess 
)
Value:
if ( !(expr) ) {\
Invar::Invariant inv( "Pre-condition Violation", mess, \
#expr, __FILE__, __LINE__ ); \
BOOST_LOG(rdErrorLog) << "\n\n****\n" << inv << "****\n\n"; throw inv; }
#define BOOST_LOG(__arg__)
Definition: RDLog.h:42
boost::logging::rdLogger * rdErrorLog

Definition at line 119 of file Invariant.h.

Referenced by RDKit::SLNParse::addAtomToMol(), RDKit::SLNParse::addBranchToMol(), RDCatalog::HierarchCatalog< entryType, paramType, orderType >::addEntry(), RDNumeric::Vector< TYPE >::assign(), RDNumeric::Matrix< double >::assign(), SmilesParseOps::CleanupAfterParseError(), RDKit::SmilesWriter::close(), RDKit::SDWriter::close(), RDKit::TDTWriter::close(), RDKit::PDBWriter::close(), RDKit::SLNParse::closeRingBond(), RDKit::countSwapsToInterconvert(), RDGeom::PointND::directionVector(), RDNumeric::Vector< TYPE >::dotProduct(), RDKit::Drawing::DrawingToCairo(), RDKit::MolDraw2Dwx::drawPolygon(), RDKit::SmilesWriter::flush(), RDKit::SDWriter::flush(), RDKit::TDTWriter::flush(), RDKit::PDBWriter::flush(), DistGeom::FourthDimContrib::FourthDimContrib(), RDKit::SparseIntVect< IndexType >::fromString(), RDKit::MolAlign::MolHistogram::get(), RDKit::PeriodicTable::getAbundanceForIsotope(), RDKit::RecursiveStructureQuery::getAtIdx(), RDKit::PeriodicTable::getAtomicWeight(), RDNumeric::Matrix< double >::getCol(), RDKit::MolAlign::LAP::getCost(), RDKit::PeriodicTable::getDefaultValence(), RDKit::PeriodicTable::getElementSymbol(), RDDepict::EmbeddedFrag::GetEmbeddedAtom(), DistGeom::FourthDimContrib::getEnergy(), DistGeom::FourthDimContrib::getGrad(), RDFeatures::ImplicitFeature< FAMILYMARKER, TYPEMARKER, LOCTYPE >::getLoc(), RDKit::PeriodicTable::getMassForIsotope(), RDKit::PeriodicTable::getMostCommonIsotope(), RDKit::PeriodicTable::getMostCommonIsotopeMass(), RDKit::PeriodicTable::getNouterElecs(), RDKit::Bond::getProp(), RDKit::PeriodicTable::getRb0(), RDKit::PeriodicTable::getRcovalent(), RDNumeric::Matrix< double >::getRow(), RDKit::MolAlign::LAP::getRowSol(), RDKit::PeriodicTable::getRvdw(), RDNumeric::Vector< TYPE >::getVal(), RDNumeric::Matrix< double >::getVal(), RDKit::PeriodicTable::getValenceList(), BFGSOpt::linearSearch(), BFGSOpt::minimize(), RDKit::PeriodicTable::moreElectroNegative(), RDGeom::UniformGrid3D::operator&(), RDKit::Canon::SpecialChiralityAtomCompareFunctor::operator()(), RDKit::Canon::SpecialSymmetryAtomCompareFunctor::operator()(), RDKit::Canon::AtomCompareFunctor::operator()(), RDKit::Canon::ChiralAtomCompareFunctor::operator()(), RDNumeric::Vector< TYPE >::operator+=(), RDNumeric::Matrix< double >::operator+=(), RDNumeric::Vector< TYPE >::operator-=(), RDNumeric::Matrix< double >::operator-=(), RDGeom::Point3D::operator[](), RDNumeric::Vector< TYPE >::operator[](), RDGeom::Point2D::operator[](), Rankers::rankVect(), RDCatalog::Catalog< entryType, orderType >::setCatalogParams(), RDKit::MMFF::MMFFMolProperties::setMMFFDielectricConstant(), RDKit::MMFF::MMFFMolProperties::setMMFFVariant(), RDNumeric::Vector< TYPE >::setVal(), RDNumeric::Matrix< double >::setVal(), RDKit::SLNParse::startMol(), RDCatalog::HierarchCatalog< entryType, paramType, orderType >::toStream(), RDNumeric::Matrix< double >::transpose(), and Queries::Query< int, TargetPtr, needsConversion >::TypeConvert().

#define TEST_ASSERT (   expr)
Value:
if ( !(expr) ) {\
Invar::Invariant inv( "Test Assert", "Expression Failed: ", \
#expr, __FILE__, __LINE__ ); \
BOOST_LOG(rdErrorLog) << "\n\n****\n" << inv << "****\n\n"; throw inv; }
#define BOOST_LOG(__arg__)
Definition: RDLog.h:42
boost::logging::rdLogger * rdErrorLog

Definition at line 139 of file Invariant.h.

Referenced by boost_adaptbx::python::streambuf::streambuf().

#define UNDER_CONSTRUCTION (   fn)
Value:
Invar::Invariant inv( "Incomplete Code", \
"This routine is still under development", fn, __FILE__, __LINE__ ); \
BOOST_LOG(rdErrorLog) << "\n\n****\n" << inv << "****\n\n"; throw inv;
#define BOOST_LOG(__arg__)
Definition: RDLog.h:42
boost::logging::rdLogger * rdErrorLog

Definition at line 129 of file Invariant.h.