RDKit
Open-source cheminformatics and machine learning.
RDKit Namespace Reference

Std stuff. More...

Namespaces

 AtomPair
 
 AtomPairs
 
 Canon
 
 common_properties
 
 constants
 
 Descriptors
 
 detail
 
 DGeomHelpers
 
 DTags
 
 EnumerationStrategyPickler
 
 EnumerationTypes
 
 FileParserUtils
 
 FilterMatchOps
 
 FMCS
 
 Local
 
 MACCSFingerprints
 
 MMFF
 
 MMPA
 
 MolAlign
 
 MolDraw2D_detail
 
 MolDraw2DUtils
 
 MolFragmenter
 
 MolHash
 
 MolInterchange
 
 MolOps
 Groups a variety of molecular query and transformation operations.
 
 MolShapes
 
 MolStandardize
 
 MorganFingerprint
 
 MorganFingerprints
 
 PicklerOps
 
 RDKitFP
 
 RDKitFPUtils
 
 RDTypeTag
 
 ReactionRunnerUtils
 
 ReducedGraphs
 
 RxnOps
 
 SLNParse
 
 SmartsWrite
 
 SmilesWrite
 
 StructureCheck
 
 Subgraphs
 
 TopologicalTorsion
 
 UFF
 
 Utils
 

Classes

struct  AdditionalOutput
 
class  AromaticAtomIterator_
 Iterate over aromatic atoms, this is bidirectional. More...
 
class  Atom
 The class for representing atoms. More...
 
class  AtomEnvironment
 abstract base class that holds atom-environments that will be hashed to generate the fingerprint More...
 
class  AtomEnvironmentGenerator
 abstract base class that generates atom-environments from a molecule More...
 
class  atomicData
 
class  AtomInvariantsGenerator
 abstract base class for atom invariants generators More...
 
class  AtomIterator_
 A general random access iterator. More...
 
class  AtomMonomerInfo
 The abstract base class for atom-level monomer info. More...
 
class  AtomPDBResidueInfo
 Captures atom-level information about peptide residues. More...
 
class  AtomRingQuery
 
class  BadFileException
 used by various file parsing classes to indicate a bad file More...
 
class  Bond
 class for representing a bond More...
 
class  BondInvariantsGenerator
 abstract base class for bond invariants generators More...
 
class  BondIterator_
 iterator for a molecule's bonds, currently BiDirectional, but it theoretically ought to be RandomAccess. More...
 
class  CachedMolHolder
 Concrete class that holds binary cached molecules in memory. More...
 
class  CachedSmilesMolHolder
 Concrete class that holds smiles strings in memory. More...
 
class  CachedTrustedSmilesMolHolder
 Concrete class that holds trusted smiles strings in memory. More...
 
class  CartesianProductStrategy
 This is a class for enumerating reagents using Cartesian Products of. More...
 
struct  charptr_functor
 functor for comparing two strings More...
 
class  ChemicalReaction
 This is a class for storing and applying general chemical reactions. More...
 
class  ChemicalReactionException
 used to indicate an error in the chemical reaction engine More...
 
class  ChemicalReactionParserException
 used to indicate an error in parsing reaction data More...
 
class  Conformer
 The class for representing 2D or 3D conformation of a molecule. More...
 
class  ConformerException
 used to indicate errors from incorrect confomer access More...
 
class  ConstBondIterator_
 const iterator for a molecule's bonds, currently BiDirectional, but it theoretically ought to be RandomAccess. More...
 
struct  CXXAtomIterator
 
struct  CXXBondIterator
 
class  Dict
 The Dict class can be used to store objects of arbitrary type keyed by strings. More...
 
class  DiscreteDistMat
 
class  DiscreteValueVect
 a class for efficiently storing vectors of discrete values More...
 
class  EnumerateLibrary
 This is a class for running reactions on sets of reagents. More...
 
class  EnumerateLibraryBase
 Base class for enumerating chemical reactions from collections of. More...
 
struct  EnumerationParams
 This is a class for providing enumeration options that control. More...
 
class  EnumerationStrategyBase
 
class  EnumerationStrategyException
 class for flagging enumeration strategy errors More...
 
class  EvenSamplePairsStrategy
 EvenSamplePairsStrategy. More...
 
class  ExclusionList
 
class  FeatureFileParseException
 class used to indicate errors in parsing feature definition files. More...
 
class  FileParseException
 used by various file parsing classes to indicate a parse error More...
 
class  FilterCatalog
 
class  FilterCatalogEntry
 
class  FilterCatalogParams
 
struct  FilterData_t
 
class  FilterHierarchyMatcher
 
struct  FilterMatch
 Holds the atomPairs matched by the underlying matcher. More...
 
class  FilterMatcherBase
 
struct  FilterProperty_t
 
class  FingerprintArguments
 Abstract base class that holds molecule independent arguments that are common amongst all fingerprint types and classes inherited from this would hold fingerprint type specific arguments. More...
 
class  FingerprintGenerator
 class that generates same fingerprint style for different output formats More...
 
class  ForwardSDMolSupplier
 
class  FPBReader
 class for reading and searching FPB files More...
 
class  FPHolderBase
 Base FPI for the fingerprinter used to rule out impossible matches. More...
 
class  FragCatalogEntry
 
class  FragCatGenerator
 
class  FragCatParams
 container for user parameters used to create a fragment catalog More...
 
class  FragFPGenerator
 
class  GasteigerParams
 
class  HasPropQuery
 
class  HasPropWithValueQuery
 
class  HasPropWithValueQuery< TargetPtr, std::string >
 
class  HeteroatomIterator_
 Iterate over heteroatoms, this is bidirectional. More...
 
struct  larger_of
 functor for returning the larger of two values More...
 
struct  ltDouble
 functor to compare two doubles with a tolerance More...
 
class  MatchingAtomIterator_
 Iterate over atoms matching a query function. This is bidirectional. More...
 
struct  MCSAtomCompareParameters
 
struct  MCSBondCompareParameters
 
struct  MCSParameters
 
struct  MCSProgressData
 
struct  MCSResult
 
class  MolBundle
 
class  MolCatalogEntry
 This class is used to store ROMol objects in a MolCatalog. More...
 
class  MolCatalogParams
 container for user parameters used to create a mol catalog More...
 
class  MolChemicalFeature
 
class  MolChemicalFeatureDef
 
class  MolChemicalFeatureFactory
 The class for finding chemical features in molecules. More...
 
class  MolDraw2D
 MolDraw2D is the base class for doing 2D renderings of molecules. More...
 
class  MolDraw2DCairo
 
class  MolDraw2DQt
 
class  MolDraw2DSVG
 
class  MolDraw2Dwx
 
struct  MolDrawOptions
 
class  MolHolder
 Concrete class that holds molecules in memory. More...
 
class  MolHolderBase
 Base class API for holding molecules to substructure search. More...
 
class  MolPickler
 handles pickling (serializing) molecules More...
 
class  MolPicklerException
 used to indicate exceptions whilst pickling (serializing) molecules More...
 
class  MolSanitizeException
 class for flagging sanitization errors More...
 
class  MolSupplier
 
class  MolWriter
 
class  MultiFPBReader
 class for reading and searching multiple FPB files More...
 
class  MultiMolDraw2D
 
class  PatternHolder
 Uses the pattern fingerprinter to rule out matches. More...
 
class  PDBMolSupplier
 lazy file parser for PDB files More...
 
class  PDBWriter
 
class  PeriodicTable
 singleton class for retrieving information about atoms More...
 
class  QueryAtom
 Class for storing atomic queries. More...
 
class  QueryAtomIterator_
 Iterate over atoms matching a query. This is bidirectional. More...
 
class  QueryBond
 Class for storing Bond queries. More...
 
class  RandomSampleAllBBsStrategy
 This is a class for randomly enumerating reagents that ensures all reagents. More...
 
class  RandomSampleStrategy
 This is a class for fully randomly sampling reagents. More...
 
struct  RDAny
 
class  RDProps
 
struct  RDValue
 
struct  ReactionFingerprintParams
 
class  ReactionPickler
 handles pickling (serializing) reactions More...
 
class  ReactionPicklerException
 used to indicate exceptions whilst pickling (serializing) reactions More...
 
class  RecursiveStructureQuery
 allows use of recursive structure queries (e.g. recursive SMARTS) More...
 
class  ResonanceMolSupplier
 
class  RGroupDecomposition
 
struct  RGroupDecompositionParameters
 
class  RingInfo
 A class to store information about a molecule's rings. More...
 
class  ROMol
 
class  RWMol
 RWMol is a molecule class that is intended to be edited. More...
 
class  RxnSanitizeException
 class for flagging sanitization errors More...
 
class  SDMolSupplier
 
class  SDWriter
 
class  SLNParseException
 
class  SmartsMatcher
 
class  SmilesMolSupplier
 lazy file parser for Smiles tables More...
 
class  SmilesParseException
 
struct  SmilesParserParams
 
class  SmilesWriter
 
class  Snapshot
 
class  SparseIntVect
 a class for efficiently storing sparse vectors of ints More...
 
class  StereoGroup
 
class  SubstructLibrary
 Substructure Search a library of molecules. More...
 
class  TDTMolSupplier
 lazy file parser for TDT files More...
 
class  TDTWriter
 
class  Trajectory
 
class  UnimplementedFPException
 used to indicate errors for unimplemented fp types in convenience functions More...
 

Typedefs

typedef boost::shared_ptr< ConformerCONFORMER_SPTR
 
typedef boost::uint32_t atomindex_t
 
typedef std::vector< RWMOL_SPTRRWMOL_SPTR_VECT
 
typedef RDCatalog::Catalog< FilterCatalogEntry, FilterCatalogParamsFCatalog
 
typedef std::map< std::string, std::string > STRING_PROPS
 
typedef bool(* MCSFinalMatchCheckFunction) (const short unsigned c1[], const short unsigned c2[], const ROMol &mol1, const FMCS::Graph &query, const ROMol &mol2, const FMCS::Graph &target, const MCSParameters *p)
 
typedef bool(* MCSAtomCompareFunction) (const MCSAtomCompareParameters &p, const ROMol &mol1, unsigned int atom1, const ROMol &mol2, unsigned int atom2, void *userData)
 
typedef bool(* MCSBondCompareFunction) (const MCSBondCompareParameters &p, const ROMol &mol1, unsigned int bond1, const ROMol &mol2, unsigned int bond2, void *userData)
 
typedef bool(* MCSProgressCallback) (const MCSProgressData &stat, const MCSParameters &params, void *userData)
 
typedef RDCatalog::HierarchCatalog< FragCatalogEntry, FragCatParams, int > FragCatalog
 
typedef std::vector< std::pair< int, int > > MatchVectType
 used to return matches from substructure searching, The format is (queryAtomIdx, molAtomIdx) More...
 
typedef RDCatalog::HierarchCatalog< MolCatalogEntry, MolCatalogParams, int > MolCatalog
 a hierarchical catalog for holding molecules More...
 
typedef boost::shared_ptr< MolChemicalFeatureFeatSPtr
 
typedef std::list< FeatSPtrFeatSPtrList
 
typedef FeatSPtrList::iterator FeatSPtrList_I
 
typedef boost::tuple< float, float, float > DrawColour
 
typedef std::map< int, DrawColourColourPalette
 
typedef std::vector< unsigned int > DashPattern
 
typedef std::vector< double > INVAR_VECT
 
typedef INVAR_VECT::iterator INVAR_VECT_I
 
typedef INVAR_VECT::const_iterator INVAR_VECT_CI
 
typedef Queries::Query< bool, Atom const *, true > ATOM_BOOL_QUERY
 
typedef Queries::Query< bool, Bond const *, true > BOND_BOOL_QUERY
 
typedef Queries::AndQuery< int, Atom const *, true > ATOM_AND_QUERY
 
typedef Queries::AndQuery< int, Bond const *, true > BOND_AND_QUERY
 
typedef Queries::OrQuery< int, Atom const *, true > ATOM_OR_QUERY
 
typedef Queries::OrQuery< int, Bond const *, true > BOND_OR_QUERY
 
typedef Queries::XOrQuery< int, Atom const *, true > ATOM_XOR_QUERY
 
typedef Queries::XOrQuery< int, Bond const *, true > BOND_XOR_QUERY
 
typedef Queries::EqualityQuery< int, Atom const *, true > ATOM_EQUALS_QUERY
 
typedef Queries::EqualityQuery< int, Bond const *, true > BOND_EQUALS_QUERY
 
typedef Queries::GreaterQuery< int, Atom const *, true > ATOM_GREATER_QUERY
 
typedef Queries::GreaterQuery< int, Bond const *, true > BOND_GREATER_QUERY
 
typedef Queries::GreaterEqualQuery< int, Atom const *, true > ATOM_GREATEREQUAL_QUERY
 
typedef Queries::GreaterEqualQuery< int, Bond const *, true > BOND_GREATEREQUAL_QUERY
 
typedef Queries::LessQuery< int, Atom const *, true > ATOM_LESS_QUERY
 
typedef Queries::LessQuery< int, Bond const *, true > BOND_LESS_QUERY
 
typedef Queries::LessEqualQuery< int, Atom const *, true > ATOM_LESSEQUAL_QUERY
 
typedef Queries::LessEqualQuery< int, Bond const *, true > BOND_LESSEQUAL_QUERY
 
typedef Queries::RangeQuery< int, Atom const *, true > ATOM_RANGE_QUERY
 
typedef Queries::RangeQuery< int, Bond const *, true > BOND_RANGE_QUERY
 
typedef Queries::SetQuery< int, Atom const *, true > ATOM_SET_QUERY
 
typedef Queries::SetQuery< int, Bond const *, true > BOND_SET_QUERY
 
typedef Queries::Query< int, Bond const *, true > BOND_NULL_QUERY
 
typedef Queries::Query< int, Atom const *, true > ATOM_NULL_QUERY
 
typedef Atom const * ConstAtomPtr
 
typedef Bond const * ConstBondPtr
 
typedef Queries::EqualityQuery< int, Atom const *, true > ATOM_PROP_QUERY
 
typedef Queries::EqualityQuery< int, Bond const *, true > BOND_PROP_QUERY
 
typedef std::map< unsigned int, BondElectrons * > ConjBondMap
 
typedef std::map< unsigned int, AtomElectrons * > ConjAtomMap
 
typedef std::vector< ConjElectrons * > CEVect
 
typedef std::vector< CEVect2 * > CEVect3
 
typedef std::vector< boost::uint8_t > ConjFP
 
typedef boost::unordered_map< std::size_t, ConjElectrons * > CEMap
 
typedef std::map< std::string, boost::shared_ptr< ROMol > > RGroupRow
 
typedef std::vector< boost::shared_ptr< ROMol > > RGroupColumn
 
typedef std::vector< RGroupRowRGroupRows
 
typedef std::map< std::string, RGroupColumnRGroupColumns
 
typedef boost::adjacency_list< boost::vecS, boost::vecS, boost::undirectedS, Atom *, Bond * > MolGraph
 This is the BGL type used to store the topology: More...
 
typedef boost::shared_ptr< RWMolRWMOL_SPTR
 
typedef std::vector< int > PATH_TYPE
 
typedef std::list< PATH_TYPEPATH_LIST
 
typedef PATH_LIST::const_iterator PATH_LIST_CI
 
typedef std::map< int, PATH_LISTINT_PATH_LIST_MAP
 
typedef INT_PATH_LIST_MAP::const_iterator INT_PATH_LIST_MAP_CI
 
typedef INT_PATH_LIST_MAP::iterator INT_PATH_LIST_MAP_I
 
typedef std::vector< SnapshotSnapshotVect
 
typedef std::vector< std::string > STR_VECT
 
typedef RDValue RDValue_cast_t
 
typedef long long int LONGINT
 
typedef unsigned int UINT
 
typedef unsigned short USHORT
 
typedef unsigned char UCHAR
 
typedef std::vector< int > INT_VECT
 
typedef INT_VECT::iterator INT_VECT_I
 
typedef INT_VECT::const_iterator INT_VECT_CI
 
typedef INT_VECT::reverse_iterator INT_VECT_RI
 
typedef INT_VECT::const_reverse_iterator INT_VECT_CRI
 
typedef std::list< int > INT_LIST
 
typedef INT_LIST::iterator INT_LIST_I
 
typedef INT_LIST::const_iterator INT_LIST_CI
 
typedef std::list< INT_VECTLIST_INT_VECT
 
typedef LIST_INT_VECT::iterator LIST_INT_VECT_I
 
typedef LIST_INT_VECT::const_iterator LIST_INT_VECT_CI
 
typedef std::vector< INT_VECTVECT_INT_VECT
 
typedef VECT_INT_VECT::iterator VECT_INT_VECT_I
 
typedef VECT_INT_VECT::const_iterator VECT_INT_VECT_CI
 
typedef std::vector< UINT >::const_iterator UINT_VECT_CI
 
typedef std::vector< UINTUINT_VECT
 
typedef std::vector< std::string >::const_iterator STR_VECT_CI
 
typedef std::vector< std::string >::iterator STR_VECT_I
 
typedef std::vector< double > DOUBLE_VECT
 
typedef DOUBLE_VECT::iterator DOUBLE_VECT_I
 
typedef DOUBLE_VECT::const_iterator DOUBLE_VECT_CI
 
typedef std::vector< DOUBLE_VECTVECT_DOUBLE_VECT
 
typedef VECT_DOUBLE_VECT::iterator VECT_DOUBLE_VECT_I
 
typedef VECT_DOUBLE_VECT::const_iterator VECT_DOUBLE_VECT_CI
 
typedef std::map< std::string, UINTSTR_UINT_MAP
 
typedef std::map< std::string, UINT >::const_iterator STR_UINT_MAP_CI
 
typedef std::map< int, INT_VECTINT_INT_VECT_MAP
 
typedef INT_INT_VECT_MAP::const_iterator INT_INT_VECT_MAP_CI
 
typedef std::map< int, int > INT_MAP_INT
 
typedef INT_MAP_INT::iterator INT_MAP_INT_I
 
typedef INT_MAP_INT::const_iterator INT_MAP_INT_CI
 
typedef std::deque< int > INT_DEQUE
 
typedef INT_DEQUE::iterator INT_DEQUE_I
 
typedef INT_DEQUE::const_iterator INT_DEQUE_CI
 
typedef std::map< int, INT_DEQUEINT_INT_DEQ_MAP
 
typedef INT_INT_DEQ_MAP::const_iterator INT_INT_DEQ_MAP_CI
 
typedef std::set< int > INT_SET
 
typedef INT_SET::iterator INT_SET_I
 
typedef INT_SET::const_iterator INT_SET_CI
 
typedef std::map< double, int, ltDoubleDOUBLE_INT_MAP
 std::map from double to integer. More...
 
typedef boost::minstd_rand rng_type
 
typedef boost::uniform_int uniform_int
 
typedef boost::uniform_real uniform_double
 
typedef boost::variate_generator< rng_type &, uniform_intint_source_type
 
typedef boost::variate_generator< rng_type &, uniform_doubledouble_source_type
 
C++11 Iterators

ROMol is a molecule class that is intended to have a fixed topology

This is the primary class for most molecule operations.

If you need to be manipulating the molecule (e.g. adding or deleting atoms or bonds, use an RWMol instead.

Notes:

  • each ROMol maintains a Dict of properties:
    • Each property is keyed by name and can store an arbitrary type.
    • Properties can be marked as calculated, in which case they will be cleared when the clearComputedProps() method is called.
    • Because they have no impact upon chemistry, all property operations are const, this allows extra flexibility for clients who need to store extra data on ROMol objects.
  • each ROMol has collections of bookmarks for Atoms and Bonds:
    • the Atom bookmarks and Bond bookmarks are stored separately from each other
    • each bookmark, an integer, can map to more than one Atom or Bond
    • these are currently used in molecule construction, but could also be useful for reaction mapping and the like
  • information about rings (SSSR and the like) is stored in the molecule's RingInfo pointer.
typedef boost::shared_ptr< ROMolROMOL_SPTR
 
typedef std::vector< boost::shared_ptr< ROMol > > MOL_SPTR_VECT
 
typedef std::vector< ROMolMOL_VECT
 
typedef std::vector< ROMol * > MOL_PTR_VECT
 
typedef MOL_PTR_VECT::const_iterator MOL_PTR_VECT_CI
 
typedef MOL_PTR_VECT::iterator MOL_PTR_VECT_I
 

Enumerations

enum  FingerprintType {
  AtomPairFP = 1, TopologicalTorsion, MorganFP, RDKitFP,
  PatternFP
}
 
enum  ReactionMoleculeType { Reactant, Product, Agent }
 
enum  Mol2Type { CORINA = 0 }
 
enum  FPType { FPType::AtomPairFP, FPType::MorganFP, FPType::RDKitFP, FPType::TopologicalTorsionFP }
 
enum  AtomComparator { AtomCompareAny, AtomCompareElements, AtomCompareIsotopes }
 
enum  BondComparator { BondCompareAny, BondCompareOrder, BondCompareOrderExact }
 
enum  RGroupLabels {
  IsotopeLabels = 0x01, AtomMapLabels = 0x02, AtomIndexLabels = 0x04, RelabelDuplicateLabels = 0x08,
  AutoDetect = 0x0F
}
 
enum  RGroupMatching { Greedy = 0x01, GreedyChunks = 0x02, Exhaustive = 0x04 }
 
enum  RGroupLabelling { AtomMap = 0x01, Isotope = 0x02, MDLRGroup = 0x04 }
 
enum  RGroupCoreAlignment { None = 0x0, MCS = 0x01 }
 
enum  StereoGroupType { StereoGroupType::STEREO_ABSOLUTE = 0, StereoGroupType::STEREO_OR = 1, StereoGroupType::STEREO_AND = 2 }
 
enum  EEndian { LITTLE_ENDIAN_ORDER, BIG_ENDIAN_ORDER }
 

Functions

RDKIT_GRAPHMOL_EXPORT void setAtomRLabel (Atom *atm, int rlabel)
 Set the atom's MDL integer RLabel. More...
 
RDKIT_GRAPHMOL_EXPORT int getAtomRLabel (const Atom *atm)
 
RDKIT_GRAPHMOL_EXPORT void setAtomAlias (Atom *atom, const std::string &alias)
 Set the atom's MDL atom alias. More...
 
RDKIT_GRAPHMOL_EXPORT std::string getAtomAlias (const Atom *atom)
 
RDKIT_GRAPHMOL_EXPORT void setAtomValue (Atom *atom, const std::string &value)
 Set the atom's MDL atom value. More...
 
RDKIT_GRAPHMOL_EXPORT std::string getAtomValue (const Atom *atom)
 
RDKIT_GRAPHMOL_EXPORT void setSupplementalSmilesLabel (Atom *atom, const std::string &label)
 Sets the supplemental label that will follow the atom when writing. More...
 
RDKIT_GRAPHMOL_EXPORT std::string getSupplementalSmilesLabel (const Atom *atom)
 
RDKIT_CHEMREACTIONS_EXPORT EnumerationTypes::BBS removeNonmatchingReagents (const ChemicalReaction &rxn, EnumerationTypes::BBS bbs, const EnumerationParams &params=EnumerationParams())
 Helper function, remove reagents that are incompatible. More...
 
RDKIT_CHEMREACTIONS_EXPORT bool EnumerateLibraryCanSerialize ()
 
template<class T >
EnumerationTypes::RGROUPS getSizesFromBBs (const std::vector< std::vector< T > > &bbs)
 Return the number of elements per input vector. More...
 
RDKIT_CHEMREACTIONS_EXPORT EnumerationTypes::RGROUPS getSizesFromReactants (const std::vector< MOL_SPTR_VECT > &bbs)
 
RDKIT_CHEMREACTIONS_EXPORT MOL_SPTR_VECT getReactantsFromRGroups (const std::vector< MOL_SPTR_VECT > &bbs, const EnumerationTypes::RGROUPS &rgroups)
 
RDKIT_CHEMREACTIONS_EXPORT boost::uint64_t computeNumProducts (const EnumerationTypes::RGROUPS &sizes)
 
RDKIT_CHEMREACTIONS_EXPORT bool preprocessReaction (ChemicalReaction &rxn, const std::string &propName=common_properties::molFileValue)
 
RDKIT_CHEMREACTIONS_EXPORT bool preprocessReaction (ChemicalReaction &rxn, unsigned int &numWarnings, unsigned int &numErrors, std::vector< std::vector< std::pair< unsigned int, std::string > > > &reactantLabels, const std::string &propName=common_properties::molFileValue)
 
RDKIT_CHEMREACTIONS_EXPORT bool preprocessReaction (ChemicalReaction &rxn, const std::map< std::string, ROMOL_SPTR > &queries, const std::string &propName=common_properties::molFileValue)
 
RDKIT_CHEMREACTIONS_EXPORT bool preprocessReaction (ChemicalReaction &rxn, unsigned int &numWarnings, unsigned int &numErrors, std::vector< std::vector< std::pair< unsigned int, std::string > > > &reactantLabels, const std::map< std::string, ROMOL_SPTR > &queries, const std::string &propName=common_properties::molFileValue)
 
RDKIT_CHEMREACTIONS_EXPORT bool isMoleculeReactantOfReaction (const ChemicalReaction &rxn, const ROMol &mol, unsigned int &which)
 
RDKIT_CHEMREACTIONS_EXPORT bool isMoleculeReactantOfReaction (const ChemicalReaction &rxn, const ROMol &mol)
 
RDKIT_CHEMREACTIONS_EXPORT bool isMoleculeProductOfReaction (const ChemicalReaction &rxn, const ROMol &mol, unsigned int &which)
 
RDKIT_CHEMREACTIONS_EXPORT bool isMoleculeProductOfReaction (const ChemicalReaction &rxn, const ROMol &mol)
 
RDKIT_CHEMREACTIONS_EXPORT bool isMoleculeAgentOfReaction (const ChemicalReaction &rxn, const ROMol &mol, unsigned int &which)
 
RDKIT_CHEMREACTIONS_EXPORT bool isMoleculeAgentOfReaction (const ChemicalReaction &rxn, const ROMol &mol)
 
RDKIT_CHEMREACTIONS_EXPORT VECT_INT_VECT getReactingAtoms (const ChemicalReaction &rxn, bool mappedAtomsOnly=false)
 
RDKIT_CHEMREACTIONS_EXPORT void addRecursiveQueriesToReaction (ChemicalReaction &rxn, const std::map< std::string, ROMOL_SPTR > &queries, const std::string &propName, std::vector< std::vector< std::pair< unsigned int, std::string >>> *reactantLabels=NULL)
 add the recursive queries to the reactants of a reaction More...
 
RDKIT_CHEMREACTIONS_EXPORT ExplicitBitVectStructuralFingerprintChemReaction (const ChemicalReaction &rxn, const ReactionFingerprintParams &params=DefaultStructuralFPParams)
 
RDKIT_CHEMREACTIONS_EXPORT SparseIntVect< boost::uint32_t > * DifferenceFingerprintChemReaction (const ChemicalReaction &rxn, const ReactionFingerprintParams &params=DefaultDifferenceFPParams)
 
RDKIT_CHEMREACTIONS_EXPORT ChemicalReactionRxnBlockToChemicalReaction (const std::string &rxnBlock)
 Parse a text block in MDL rxn format into a ChemicalReaction. More...
 
RDKIT_CHEMREACTIONS_EXPORT ChemicalReactionRxnFileToChemicalReaction (const std::string &fileName)
 Parse a file in MDL rxn format into a ChemicalReaction. More...
 
RDKIT_CHEMREACTIONS_EXPORT ChemicalReactionRxnDataStreamToChemicalReaction (std::istream &rxnStream, unsigned int &line)
 Parse a text stream in MDL rxn format into a ChemicalReaction. More...
 
RDKIT_CHEMREACTIONS_EXPORT ChemicalReactionRxnSmartsToChemicalReaction (const std::string &text, std::map< std::string, std::string > *replacements=0, bool useSmiles=false)
 Parse a string containing "Reaction SMARTS" into a ChemicalReaction. More...
 
RDKIT_CHEMREACTIONS_EXPORT ChemicalReactionRxnMolToChemicalReaction (const ROMol &mol)
 Parse a ROMol into a ChemicalReaction, RXN role must be set before. More...
 
RDKIT_CHEMREACTIONS_EXPORT std::string ChemicalReactionToRxnSmarts (const ChemicalReaction &rxn)
 returns the reaction SMARTS for a reaction More...
 
RDKIT_CHEMREACTIONS_EXPORT std::string ChemicalReactionToRxnSmiles (const ChemicalReaction &rxn, bool canonical=true)
 returns the reaction SMILES for a reaction More...
 
RDKIT_CHEMREACTIONS_EXPORT std::string ChemicalReactionToRxnBlock (const ChemicalReaction &rxn, bool separateAgents=false)
 returns an RXN block for a reaction More...
 
RDKIT_CHEMREACTIONS_EXPORT ROMolChemicalReactionToRxnMol (const ChemicalReaction &rxn)
 returns a ROMol with RXN roles used to describe the reaction More...
 
RDKIT_CHEMREACTIONS_EXPORT std::vector< MOL_SPTR_VECTrun_Reactants (const ChemicalReaction &rxn, const MOL_SPTR_VECT &reactants, unsigned int maxProducts=1000)
 Runs the reaction on a set of reactants. More...
 
RDKIT_CHEMREACTIONS_EXPORT std::vector< MOL_SPTR_VECTrun_Reactant (const ChemicalReaction &rxn, const ROMOL_SPTR &reactant, unsigned int reactantIdx)
 Runs a single reactant against a single reactant template. More...
 
RDKIT_CHEMREACTIONS_EXPORT ROMolreduceProductToSideChains (const ROMOL_SPTR &product, bool addDummyAtoms=true)
 Reduce the product generated by run_Reactants or run_Reactant to. More...
 
RDKIT_CHEMREACTIONS_EXPORT MOL_SPTR_VECT::const_iterator getStartIterator (const ChemicalReaction &rxn, ReactionMoleculeType t)
 
RDKIT_CHEMREACTIONS_EXPORT MOL_SPTR_VECT::const_iterator getEndIterator (const ChemicalReaction &rxn, ReactionMoleculeType t)
 
RDKIT_CHEMREACTIONS_EXPORT bool hasReactantTemplateSubstructMatch (const ChemicalReaction &rxn, const ChemicalReaction &query_rxn)
 
RDKIT_CHEMREACTIONS_EXPORT bool hasProductTemplateSubstructMatch (const ChemicalReaction &rxn, const ChemicalReaction &query_rxn)
 
RDKIT_CHEMREACTIONS_EXPORT bool hasAgentTemplateSubstructMatch (const ChemicalReaction &rxn, const ChemicalReaction &query_rxn)
 
RDKIT_CHEMREACTIONS_EXPORT bool hasReactionSubstructMatch (const ChemicalReaction &rxn, const ChemicalReaction &query_rxn, bool includeAgents=false)
 
RDKIT_CHEMREACTIONS_EXPORT bool hasReactionAtomMapping (const ChemicalReaction &rxn)
 
RDKIT_CHEMREACTIONS_EXPORT bool isReactionTemplateMoleculeAgent (const ROMol &mol, double agentThreshold)
 
RDKIT_CHEMREACTIONS_EXPORT void updateProductsStereochem (ChemicalReaction *rxn)
 
RDKIT_CHEMREACTIONS_EXPORT void removeMappingNumbersFromReactions (const ChemicalReaction &rxn)
 
RDKIT_CHEMTRANSFORMS_EXPORT ROMoldeleteSubstructs (const ROMol &mol, const ROMol &query, bool onlyFrags=false, bool useChirality=false)
 Returns a copy of an ROMol with the atoms and bonds that match a pattern removed. More...
 
RDKIT_CHEMTRANSFORMS_EXPORT std::vector< ROMOL_SPTRreplaceSubstructs (const ROMol &mol, const ROMol &query, const ROMol &replacement, bool replaceAll=false, unsigned int replacementConnectionPoint=0, bool useChirality=false)
 Returns a list of copies of an ROMol with the atoms and bonds that match a pattern replaced with the atoms contained in another molecule. More...
 
RDKIT_CHEMTRANSFORMS_EXPORT ROMolreplaceSidechains (const ROMol &mol, const ROMol &coreQuery, bool useChirality=false)
 Returns a copy of an ROMol with the atoms and bonds that don't fall within a substructure match removed. More...
 
RDKIT_CHEMTRANSFORMS_EXPORT ROMolreplaceCore (const ROMol &mol, const ROMol &core, const MatchVectType &matchVect, bool replaceDummies=true, bool labelByIndex=false, bool requireDummyMatch=false)
 Returns a copy of an ROMol with the atoms and bonds that are referenced by the MatchVector removed. MatchVector must be defined between mol and the specified core. More...
 
RDKIT_CHEMTRANSFORMS_EXPORT ROMolreplaceCore (const ROMol &mol, const ROMol &coreQuery, bool replaceDummies=true, bool labelByIndex=false, bool requireDummyMatch=false, bool useChirality=false)
 Returns a copy of an ROMol with the atoms and bonds that do fall within a substructure match removed. More...
 
RDKIT_CHEMTRANSFORMS_EXPORT ROMolMurckoDecompose (const ROMol &mol)
 Carries out a Murcko decomposition on the molecule provided. More...
 
RDKIT_CHEMTRANSFORMS_EXPORT ROMolcombineMols (const ROMol &mol1, const ROMol &mol2, RDGeom::Point3D offset=RDGeom::Point3D(0, 0, 0))
 Combined two molecules to create a new one. More...
 
RDKIT_CHEMTRANSFORMS_EXPORT void addRecursiveQueries (ROMol &mol, const std::map< std::string, ROMOL_SPTR > &queries, const std::string &propName, std::vector< std::pair< unsigned int, std::string > > *reactantLabels=NULL)
 Adds named recursive queries to a molecule's atoms based on atom. More...
 
RDKIT_CHEMTRANSFORMS_EXPORT void parseQueryDefFile (const std::string &filename, std::map< std::string, ROMOL_SPTR > &queryDefs, bool standardize=true, const std::string &delimiter="\, const std::string &comment="//", unsigned int nameColumn=0, unsigned int smartsColumn=1)
 parses a query definition file and sets up a set of definitions suitable for use by addRecursiveQueries() More...
 
RDKIT_CHEMTRANSFORMS_EXPORT void parseQueryDefFile (std::istream *inStream, std::map< std::string, ROMOL_SPTR > &queryDefs, bool standardize=true, const std::string &delimiter="\, const std::string &comment="//", unsigned int nameColumn=0, unsigned int smartsColumn=1)
 
RDKIT_CHEMTRANSFORMS_EXPORT void parseQueryDefText (const std::string &queryDefText, std::map< std::string, ROMOL_SPTR > &queryDefs, bool standardize=true, const std::string &delimiter="\, const std::string &comment="//", unsigned int nameColumn=0, unsigned int smartsColumn=1)
 equivalent to parseQueryDefFile() but the query definitions are More...
 
bool hasNonZeroZCoords (const Conformer &conf)
 Returns true if any of the z coords are non zero, false otherwise. More...
 
RDKIT_FILEPARSERS_EXPORT std::string strip (const std::string &orig)
 
RDKIT_FILEPARSERS_EXPORT RWMolMolDataStreamToMol (std::istream *inStream, unsigned int &line, bool sanitize=true, bool removeHs=true, bool strictParsing=true)
 
RDKIT_FILEPARSERS_EXPORT RWMolMolDataStreamToMol (std::istream &inStream, unsigned int &line, bool sanitize=true, bool removeHs=true, bool strictParsing=true)
 
RDKIT_FILEPARSERS_EXPORT RWMolMolBlockToMol (const std::string &molBlock, bool sanitize=true, bool removeHs=true, bool strictParsing=true)
 
RDKIT_FILEPARSERS_EXPORT RWMolMolFileToMol (const std::string &fName, bool sanitize=true, bool removeHs=true, bool strictParsing=true)
 
RDKIT_FILEPARSERS_EXPORT std::string MolToMolBlock (const ROMol &mol, bool includeStereo=true, int confId=-1, bool kekulize=true, bool forceV3000=false)
 
RDKIT_FILEPARSERS_EXPORT void MolToMolFile (const ROMol &mol, const std::string &fName, bool includeStereo=true, int confId=-1, bool kekulize=true, bool forceV3000=false)
 
RDKIT_FILEPARSERS_EXPORT RWMolTPLDataStreamToMol (std::istream *inStream, unsigned int &line, bool sanitize=true, bool skipFirstConf=false)
 translate TPL data (BioCad format) into a multi-conf molecule More...
 
RDKIT_FILEPARSERS_EXPORT RWMolTPLFileToMol (const std::string &fName, bool sanitize=true, bool skipFirstConf=false)
 construct a multi-conf molecule from a TPL (BioCad format) file More...
 
RDKIT_FILEPARSERS_EXPORT std::string MolToTPLText (const ROMol &mol, const std::string &partialChargeProp="_GasteigerCharge", bool writeFirstConfTwice=false)
 
RDKIT_FILEPARSERS_EXPORT void MolToTPLFile (const ROMol &mol, const std::string &fName, const std::string &partialChargeProp="_GasteigerCharge", bool writeFirstConfTwice=false)
 
RDKIT_FILEPARSERS_EXPORT RWMolMol2FileToMol (const std::string &fName, bool sanitize=true, bool removeHs=true, Mol2Type variant=CORINA, bool cleanupSubstructures=true)
 
RDKIT_FILEPARSERS_EXPORT RWMolMol2DataStreamToMol (std::istream *inStream, bool sanitize=true, bool removeHs=true, Mol2Type variant=CORINA, bool cleanupSubstructures=true)
 
RDKIT_FILEPARSERS_EXPORT RWMolMol2DataStreamToMol (std::istream &inStream, bool sanitize=true, bool removeHs=true, Mol2Type variant=CORINA, bool cleanupSubstructures=true)
 
RDKIT_FILEPARSERS_EXPORT RWMolMol2BlockToMol (const std::string &molBlock, bool sanitize=true, bool removeHs=true, Mol2Type variant=CORINA, bool cleanupSubstructures=true)
 
RDKIT_FILEPARSERS_EXPORT RWMolPDBBlockToMol (const char *str, bool sanitize=true, bool removeHs=true, unsigned int flavor=0, bool proximityBonding=true)
 
RDKIT_FILEPARSERS_EXPORT RWMolPDBBlockToMol (const std::string &str, bool sanitize=true, bool removeHs=true, unsigned int flavor=0, bool proximityBonding=true)
 
RDKIT_FILEPARSERS_EXPORT RWMolPDBDataStreamToMol (std::istream *inStream, bool sanitize=true, bool removeHs=true, unsigned int flavor=0, bool proximityBonding=true)
 
RDKIT_FILEPARSERS_EXPORT RWMolPDBDataStreamToMol (std::istream &inStream, bool sanitize=true, bool removeHs=true, unsigned int flavor=0, bool proximityBonding=true)
 
RDKIT_FILEPARSERS_EXPORT RWMolPDBFileToMol (const std::string &fname, bool sanitize=true, bool removeHs=true, unsigned int flavor=0, bool proximityBonding=true)
 
RDKIT_FILEPARSERS_EXPORT std::string MolToPDBBlock (const ROMol &mol, int confId=-1, unsigned int flavor=0)
 
RDKIT_FILEPARSERS_EXPORT void MolToPDBFile (const ROMol &mol, const std::string &fname, int confId=-1, unsigned int flavor=0)
 
RDKIT_FILEPARSERS_EXPORT RWMolRDKitSVGToMol (const std::string &svg, bool sanitize=true, bool removeHs=true)
 
RDKIT_FILEPARSERS_EXPORT RWMolRDKitSVGToMol (std::istream *instream, bool sanitize=true, bool removeHs=true)
 
RDKIT_FILEPARSERS_EXPORT void DetectAtomStereoChemistry (RWMol &mol, const Conformer *conf)
 
RDKIT_FILEPARSERS_EXPORT void DetectBondStereoChemistry (ROMol &mol, const Conformer *conf)
 deprecated, please use MolOps::detectBondStereoChemistry instead More...
 
RDKIT_FILEPARSERS_EXPORT void WedgeMolBonds (ROMol &mol, const Conformer *conf)
 
RDKIT_FILEPARSERS_EXPORT void WedgeBond (Bond *bond, unsigned int fromAtomIdx, const Conformer *conf)
 
RDKIT_FILEPARSERS_EXPORT INT_MAP_INT pickBondsToWedge (const ROMol &mol)
 
RDKIT_FILEPARSERS_EXPORT void ClearSingleBondDirFlags (ROMol &mol)
 
RDKIT_FILEPARSERS_EXPORT Bond::BondDir DetermineBondWedgeState (const Bond *bond, unsigned int fromAtomIdx, const Conformer *conf)
 
RDKIT_FILEPARSERS_EXPORT Bond::BondDir DetermineBondWedgeState (const Bond *bond, const INT_MAP_INT &wedgeBonds, const Conformer *conf)
 
RDKIT_FILEPARSERS_EXPORT bool IsBlacklistedPair (Atom *beg_atom, Atom *end_atom)
 
RDKIT_FILEPARSERS_EXPORT void ConnectTheDots (RWMol *mol, unsigned int flags=0)
 
RDKIT_FILEPARSERS_EXPORT void StandardPDBResidueBondOrders (RWMol *mol)
 
RDKIT_FILEPARSERS_EXPORT bool SamePDBResidue (AtomPDBResidueInfo *p, AtomPDBResidueInfo *q)
 
RDKIT_FILEPARSERS_EXPORT RWMolSequenceToMol (const char *seq, bool sanitize, bool lowerD)
 
RDKIT_FILEPARSERS_EXPORT RWMolSequenceToMol (const std::string &seq, bool sanitize, bool lowerD)
 
RDKIT_FILEPARSERS_EXPORT RWMolSequenceToMol (const char *seq, bool sanitize=true, int flavor=0)
 
RDKIT_FILEPARSERS_EXPORT RWMolSequenceToMol (const std::string &seq, bool sanitize=true, int flavor=0)
 
RDKIT_FILEPARSERS_EXPORT RWMolFASTAToMol (const char *seq, bool sanitize, bool lowerD)
 
RDKIT_FILEPARSERS_EXPORT RWMolFASTAToMol (const std::string &seq, bool sanitize, bool lowerD)
 
RDKIT_FILEPARSERS_EXPORT RWMolFASTAToMol (const char *seq, bool sanitize=true, int flavor=0)
 
RDKIT_FILEPARSERS_EXPORT RWMolFASTAToMol (const std::string &seq, bool sanitize=true, int flavor=0)
 
RDKIT_FILEPARSERS_EXPORT RWMolHELMToMol (const char *helm, bool sanitize=true)
 
RDKIT_FILEPARSERS_EXPORT RWMolHELMToMol (const std::string &helm, bool sanitize=true)
 
RDKIT_FILEPARSERS_EXPORT std::string MolToSequence (const ROMol &mol)
 
RDKIT_FILEPARSERS_EXPORT std::string MolToFASTA (const ROMol &mol)
 
RDKIT_FILEPARSERS_EXPORT std::string MolToHELM (const ROMol &mol)
 
RDKIT_FILTERCATALOG_EXPORT bool FilterCatalogCanSerialize ()
 
unsigned int GetNumEntries (FilterCatalogParams::FilterCatalogs catalog)
 
const FilterData_tGetFilterData (FilterCatalogParams::FilterCatalogs catalog)
 
unsigned int GetNumPropertyEntries (FilterCatalogParams::FilterCatalogs catalog)
 
const FilterProperty_tGetFilterProperties (FilterCatalogParams::FilterCatalogs catalog)
 
FilterCatalogEntryMakeFilterCatalogEntry (const FilterData_t &, unsigned int num_props=0, const FilterProperty_t *props=0)
 
RDKIT_FILTERCATALOG_EXPORT const FilterCatalogGetFunctionalGroupHierarchy ()
 Return the functional group hierarchy as a FilterCatalog. More...
 
RDKIT_FILTERCATALOG_EXPORT const std::map< std::string, ROMOL_SPTR > & GetFlattenedFunctionalGroupHierarchy (bool normalized=false)
 
RDKIT_FINGERPRINTS_EXPORT SparseIntVect< std::uint64_t > * getSparseCountFP (const ROMol &mol, FPType fPType)
 
RDKIT_FINGERPRINTS_EXPORT SparseBitVectgetSparseFP (const ROMol &mol, FPType fPType)
 
RDKIT_FINGERPRINTS_EXPORT SparseIntVect< std::uint32_t > * getCountFP (const ROMol &mol, FPType fPType)
 
RDKIT_FINGERPRINTS_EXPORT ExplicitBitVectgetFP (const ROMol &mol, FPType fPType)
 
RDKIT_FINGERPRINTS_EXPORT std::vector< SparseIntVect< std::uint64_t > * > * getSparseCountFPBulk (const std::vector< const ROMol *> molVector, FPType fPType)
 
RDKIT_FINGERPRINTS_EXPORT std::vector< SparseBitVect * > * getSparseFPBulk (const std::vector< const ROMol *> molVector, FPType fPType)
 
RDKIT_FINGERPRINTS_EXPORT std::vector< SparseIntVect< std::uint32_t > * > * getCountFPBulk (const std::vector< const ROMol *> molVector, FPType fPType)
 
RDKIT_FINGERPRINTS_EXPORT std::vector< ExplicitBitVect * > * getFPBulk (const std::vector< const ROMol *> molVector, FPType fPType)
 
RDKIT_FINGERPRINTS_EXPORT ExplicitBitVectRDKFingerprintMol (const ROMol &mol, unsigned int minPath=1, unsigned int maxPath=7, unsigned int fpSize=2048, unsigned int nBitsPerHash=2, bool useHs=true, double tgtDensity=0.0, unsigned int minSize=128, bool branchedPaths=true, bool useBondOrder=true, std::vector< boost::uint32_t > *atomInvariants=0, const std::vector< boost::uint32_t > *fromAtoms=0, std::vector< std::vector< boost::uint32_t > > *atomBits=0, std::map< boost::uint32_t, std::vector< std::vector< int > > > *bitInfo=0)
 Generates a topological (Daylight like) fingerprint for a molecule using an alternate (faster) hashing algorithm. More...
 
RDKIT_FINGERPRINTS_EXPORT ExplicitBitVectLayeredFingerprintMol (const ROMol &mol, unsigned int layerFlags=0xFFFFFFFF, unsigned int minPath=1, unsigned int maxPath=7, unsigned int fpSize=2048, std::vector< unsigned int > *atomCounts=0, ExplicitBitVect *setOnlyBits=0, bool branchedPaths=true, const std::vector< boost::uint32_t > *fromAtoms=0)
 Generates a topological (Daylight like) fingerprint for a molecule using a layer-based hashing algorithm. More...
 
RDKIT_FINGERPRINTS_EXPORT ExplicitBitVectPatternFingerprintMol (const ROMol &mol, unsigned int fpSize=2048, std::vector< unsigned int > *atomCounts=0, ExplicitBitVect *setOnlyBits=0)
 Generates a topological fingerprint for a molecule using a series of pre-defined structural patterns. More...
 
RDKIT_FINGERPRINTS_EXPORT SparseIntVect< boost::uint64_t > * getUnfoldedRDKFingerprintMol (const ROMol &mol, unsigned int minPath=1, unsigned int maxPath=7, bool useHs=true, bool branchedPaths=true, bool useBondOrder=true, std::vector< boost::uint32_t > *atomInvariants=0, const std::vector< boost::uint32_t > *fromAtoms=0, std::vector< std::vector< boost::uint64_t > > *atomBits=0, std::map< boost::uint64_t, std::vector< std::vector< int > > > *bitInfo=0)
 
RDKIT_FMCS_EXPORT bool MCSAtomCompareAny (const MCSAtomCompareParameters &p, const ROMol &mol1, unsigned int atom1, const ROMol &mol2, unsigned int atom2, void *userData)
 
RDKIT_FMCS_EXPORT bool MCSAtomCompareElements (const MCSAtomCompareParameters &p, const ROMol &mol1, unsigned int atom1, const ROMol &mol2, unsigned int atom2, void *userData)
 
RDKIT_FMCS_EXPORT bool MCSAtomCompareIsotopes (const MCSAtomCompareParameters &p, const ROMol &mol1, unsigned int atom1, const ROMol &mol2, unsigned int atom2, void *userData)
 
RDKIT_FMCS_EXPORT bool MCSBondCompareAny (const MCSBondCompareParameters &p, const ROMol &mol1, unsigned int bond1, const ROMol &mol2, unsigned int bond2, void *userData)
 
RDKIT_FMCS_EXPORT bool MCSBondCompareOrder (const MCSBondCompareParameters &p, const ROMol &mol1, unsigned int bond1, const ROMol &mol2, unsigned int bond2, void *userData)
 
RDKIT_FMCS_EXPORT bool MCSBondCompareOrderExact (const MCSBondCompareParameters &p, const ROMol &mol1, unsigned int bond1, const ROMol &mol2, unsigned int bond2, void *userData)
 
RDKIT_FMCS_EXPORT bool MCSProgressCallbackTimeout (const MCSProgressData &stat, const MCSParameters &params, void *userData)
 
RDKIT_FMCS_EXPORT void parseMCSParametersJSON (const char *json, MCSParameters *params)
 
RDKIT_FMCS_EXPORT MCSResult findMCS (const std::vector< ROMOL_SPTR > &mols, const MCSParameters *params=0)
 
RDKIT_FMCS_EXPORT MCSResult findMCS_P (const std::vector< ROMOL_SPTR > &mols, const char *params_json)
 
RDKIT_FMCS_EXPORT MCSResult findMCS (const std::vector< ROMOL_SPTR > &mols, bool maximizeBonds, double threshold=1.0, unsigned timeout=3600, bool verbose=false, bool matchValences=false, bool ringMatchesRingOnly=false, bool completeRingsOnly=false, bool matchChiralTag=false, AtomComparator atomComp=AtomCompareElements, BondComparator bondComp=BondCompareOrder)
 
bool FinalChiralityCheckFunction (const short unsigned c1[], const short unsigned c2[], const ROMol &mol1, const FMCS::Graph &query, const ROMol &mol2, const FMCS::Graph &target, const MCSParameters *p)
 
RDKIT_FRAGCATALOG_EXPORT MOL_SPTR_VECT readFuncGroups (std::string fileName)
 
RDKIT_FRAGCATALOG_EXPORT MOL_SPTR_VECT readFuncGroups (std::istream &inStream, int nToRead=-1)
 
RDKIT_FRAGCATALOG_EXPORT MatchVectType findFuncGroupsOnMol (const ROMol &mol, const FragCatParams *params, INT_VECT &fgBonds)
 
RDKIT_FRAGCATALOG_EXPORT ROMolprepareMol (const ROMol &mol, const FragCatParams *fparams, MatchVectType &aToFmap)
 
RDKIT_MOLCHEMICALFEATURES_EXPORT int parseFeatureData (const std::string &defnText, MolChemicalFeatureDef::CollectionType &featDefs)
 
RDKIT_MOLCHEMICALFEATURES_EXPORT int parseFeatureData (std::istream &istream, MolChemicalFeatureDef::CollectionType &featDefs)
 
RDKIT_MOLCHEMICALFEATURES_EXPORT int parseFeatureFile (const std::string &fileName, MolChemicalFeatureDef::CollectionType &featDefs)
 
RDKIT_MOLCHEMICALFEATURES_EXPORT MolChemicalFeatureFactorybuildFeatureFactory (std::istream &inStream)
 constructs a MolChemicalFeatureFactory from the data in a stream More...
 
RDKIT_MOLCHEMICALFEATURES_EXPORT MolChemicalFeatureFactorybuildFeatureFactory (const std::string &featureData)
 constructs a MolChemicalFeatureFactory from the data in a string More...
 
void assignDefaultPalette (ColourPalette &palette)
 
void assignBWPalette (ColourPalette &palette)
 
RDKIT_PARTIALCHARGES_EXPORT void computeGasteigerCharges (const ROMol *mol, int nIter=12, bool throwOnParamFailure=false)
 
RDKIT_PARTIALCHARGES_EXPORT void computeGasteigerCharges (const ROMol &mol, int nIter=12, bool throwOnParamFailure=false)
 
RDKIT_PARTIALCHARGES_EXPORT void computeGasteigerCharges (const ROMol &mol, std::vector< double > &charges, int nIter=12, bool throwOnParamFailure=false)
 
std::string describeQuery (const Atom *atom)
 
std::string describeQuery (const Bond *bond)
 
static int queryAtomAromatic (Atom const *at)
 
static int queryAtomAliphatic (Atom const *at)
 
static int queryAtomExplicitDegree (Atom const *at)
 
static int queryAtomTotalDegree (Atom const *at)
 
static int queryAtomNonHydrogenDegree (Atom const *at)
 
static int queryAtomHeavyAtomDegree (Atom const *at)
 
static int queryAtomHCount (Atom const *at)
 
static int queryAtomImplicitHCount (Atom const *at)
 
static int queryAtomHasImplicitH (Atom const *at)
 
static int queryAtomImplicitValence (Atom const *at)
 
static int queryAtomExplicitValence (Atom const *at)
 
static int queryAtomTotalValence (Atom const *at)
 
static int queryAtomUnsaturated (Atom const *at)
 
static int queryAtomNum (Atom const *at)
 
static int makeAtomType (int atomic_num, bool aromatic)
 
static void parseAtomType (int val, int &atomic_num, bool &aromatic)
 
static bool getAtomTypeIsAromatic (int val)
 
static int getAtomTypeAtomicNum (int val)
 
static int queryAtomType (Atom const *at)
 
static int queryAtomMass (Atom const *at)
 
static int queryAtomIsotope (Atom const *at)
 
static int queryAtomFormalCharge (Atom const *at)
 
static int queryAtomHybridization (Atom const *at)
 
static int queryAtomNumRadicalElectrons (Atom const *at)
 
static int queryAtomHasChiralTag (Atom const *at)
 
static int queryAtomMissingChiralTag (Atom const *at)
 
static int queryAtomHasHeteroatomNbrs (Atom const *at)
 
static int queryAtomNumHeteroatomNbrs (Atom const *at)
 
static int queryAtomHasAliphaticHeteroatomNbrs (Atom const *at)
 
static int queryAtomNumAliphaticHeteroatomNbrs (Atom const *at)
 
RDKIT_GRAPHMOL_EXPORT unsigned int queryAtomBondProduct (Atom const *at)
 
RDKIT_GRAPHMOL_EXPORT unsigned int queryAtomAllBondProduct (Atom const *at)
 
static int queryBondOrder (Bond const *bond)
 
static int queryBondIsSingleOrAromatic (Bond const *bond)
 
static int queryBondDir (Bond const *bond)
 
static int queryIsBondInNRings (Bond const *at)
 
static int queryBondHasStereo (Bond const *bnd)
 
static int queryIsAtomInNRings (Atom const *at)
 
static int queryIsAtomInRing (Atom const *at)
 
static int queryAtomHasRingBond (Atom const *at)
 
static int queryIsBondInRing (Bond const *bond)
 
static int queryAtomMinRingSize (Atom const *at)
 
static int queryBondMinRingSize (Bond const *bond)
 
static int queryAtomRingBondCount (Atom const *at)
 
template<int tgt>
int queryAtomIsInRingOfSize (Atom const *at)
 
template<int tgt>
int queryBondIsInRingOfSize (Bond const *bond)
 
template<class T >
T * makeAtomSimpleQuery (int what, int func(Atom const *), const std::string &description="Atom Simple")
 
static ATOM_RANGE_QUERYmakeAtomRangeQuery (int lower, int upper, bool lowerOpen, bool upperOpen, int func(Atom const *), const std::string &description="Atom Range")
 
template<class T >
T * makeAtomNumQuery (int what, const std::string &descr)
 returns a Query for matching atomic number More...
 
RDKIT_GRAPHMOL_EXPORT ATOM_EQUALS_QUERYmakeAtomNumQuery (int what)
 
template<class T >
T * makeAtomTypeQuery (int num, int aromatic, const std::string &descr)
 returns a Query for matching atomic number and aromaticity More...
 
RDKIT_GRAPHMOL_EXPORT ATOM_EQUALS_QUERYmakeAtomTypeQuery (int num, int aromatic)
 
template<class T >
T * makeAtomImplicitValenceQuery (int what, const std::string &descr)
 returns a Query for matching implicit valence More...
 
RDKIT_GRAPHMOL_EXPORT ATOM_EQUALS_QUERYmakeAtomImplicitValenceQuery (int what)
 
template<class T >
T * makeAtomExplicitValenceQuery (int what, const std::string &descr)
 returns a Query for matching explicit valence More...
 
RDKIT_GRAPHMOL_EXPORT ATOM_EQUALS_QUERYmakeAtomExplicitValenceQuery (int what)
 
template<class T >
T * makeAtomTotalValenceQuery (int what, const std::string &descr)
 returns a Query for matching total valence More...
 
RDKIT_GRAPHMOL_EXPORT ATOM_EQUALS_QUERYmakeAtomTotalValenceQuery (int what)
 
template<class T >
T * makeAtomExplicitDegreeQuery (int what, const std::string &descr)
 returns a Query for matching explicit degree More...
 
RDKIT_GRAPHMOL_EXPORT ATOM_EQUALS_QUERYmakeAtomExplicitDegreeQuery (int what)
 
template<class T >
T * makeAtomTotalDegreeQuery (int what, const std::string &descr)
 returns a Query for matching atomic degree More...
 
RDKIT_GRAPHMOL_EXPORT ATOM_EQUALS_QUERYmakeAtomTotalDegreeQuery (int what)
 
template<class T >
T * makeAtomHeavyAtomDegreeQuery (int what, const std::string &descr)
 returns a Query for matching heavy atom degree More...
 
RDKIT_GRAPHMOL_EXPORT ATOM_EQUALS_QUERYmakeAtomHeavyAtomDegreeQuery (int what)
 
template<class T >
T * makeAtomHCountQuery (int what, const std::string &descr)
 returns a Query for matching hydrogen count More...
 
RDKIT_GRAPHMOL_EXPORT ATOM_EQUALS_QUERYmakeAtomHCountQuery (int what)
 
template<class T >
T * makeAtomHasImplicitHQuery (const std::string &descr)
 returns a Query for matching ring atoms More...
 
RDKIT_GRAPHMOL_EXPORT ATOM_EQUALS_QUERYmakeAtomHasImplicitHQuery ()
 
template<class T >
T * makeAtomImplicitHCountQuery (int what, const std::string &descr)
 returns a Query for matching implicit hydrogen count More...
 
RDKIT_GRAPHMOL_EXPORT ATOM_EQUALS_QUERYmakeAtomImplicitHCountQuery (int what)
 
template<class T >
T * makeAtomAromaticQuery (const std::string &descr)
 returns a Query for matching the isAromatic flag More...
 
RDKIT_GRAPHMOL_EXPORT ATOM_EQUALS_QUERYmakeAtomAromaticQuery ()
 
template<class T >
T * makeAtomAliphaticQuery (const std::string &descr)
 returns a Query for matching aliphatic atoms More...
 
RDKIT_GRAPHMOL_EXPORT ATOM_EQUALS_QUERYmakeAtomAliphaticQuery ()
 
template<class T >
T * makeAtomMassQuery (int what, const std::string &descr)
 returns a Query for matching atoms with a particular mass More...
 
RDKIT_GRAPHMOL_EXPORT ATOM_EQUALS_QUERYmakeAtomMassQuery (int what)
 
template<class T >
T * makeAtomIsotopeQuery (int what, const std::string &descr)
 returns a Query for matching atoms with a particular isotope More...
 
RDKIT_GRAPHMOL_EXPORT ATOM_EQUALS_QUERYmakeAtomIsotopeQuery (int what)
 
template<class T >
T * makeAtomFormalChargeQuery (int what, const std::string &descr)
 returns a Query for matching formal charge More...
 
RDKIT_GRAPHMOL_EXPORT ATOM_EQUALS_QUERYmakeAtomFormalChargeQuery (int what)
 
template<class T >
T * makeAtomHybridizationQuery (int what, const std::string &descr)
 returns a Query for matching hybridization More...
 
RDKIT_GRAPHMOL_EXPORT ATOM_EQUALS_QUERYmakeAtomHybridizationQuery (int what)
 
template<class T >
T * makeAtomNumRadicalElectronsQuery (int what, const std::string &descr)
 returns a Query for matching the number of radical electrons More...
 
RDKIT_GRAPHMOL_EXPORT ATOM_EQUALS_QUERYmakeAtomNumRadicalElectronsQuery (int what)
 
template<class T >
T * makeAtomHasChiralTagQuery (const std::string &descr)
 
RDKIT_GRAPHMOL_EXPORT ATOM_EQUALS_QUERYmakeAtomHasChiralTagQuery ()
 
template<class T >
T * makeAtomMissingChiralTagQuery (const std::string &descr)
 
RDKIT_GRAPHMOL_EXPORT ATOM_EQUALS_QUERYmakeAtomMissingChiralTagQuery ()
 
template<class T >
T * makeAtomUnsaturatedQuery (const std::string &descr)
 returns a Query for matching atoms with unsaturation: More...
 
RDKIT_GRAPHMOL_EXPORT ATOM_EQUALS_QUERYmakeAtomUnsaturatedQuery ()
 
template<class T >
T * makeAtomInRingQuery (const std::string &descr)
 returns a Query for matching ring atoms More...
 
RDKIT_GRAPHMOL_EXPORT ATOM_EQUALS_QUERYmakeAtomInRingQuery ()
 
template<class T >
T * makeAtomInNRingsQuery (int what, const std::string &descr)
 returns a Query for matching atoms in a particular number of rings More...
 
RDKIT_GRAPHMOL_EXPORT ATOM_EQUALS_QUERYmakeAtomInNRingsQuery (int what)
 
RDKIT_GRAPHMOL_EXPORT ATOM_EQUALS_QUERYmakeAtomInRingOfSizeQuery (int tgt)
 returns a Query for matching atoms in rings of a particular size More...
 
template<class T >
T * makeAtomMinRingSizeQuery (int tgt, const std::string &descr)
 returns a Query for matching an atom's minimum ring size More...
 
RDKIT_GRAPHMOL_EXPORT ATOM_EQUALS_QUERYmakeAtomMinRingSizeQuery (int tgt)
 
template<class T >
T * makeAtomRingBondCountQuery (int what, const std::string &descr)
 returns a Query for matching atoms with a particular number of ring bonds More...
 
RDKIT_GRAPHMOL_EXPORT ATOM_EQUALS_QUERYmakeAtomRingBondCountQuery (int what)
 
RDKIT_GRAPHMOL_EXPORT ATOM_EQUALS_QUERYmakeAAtomQuery ()
 returns a Query for matching generic A atoms (heavy atoms) More...
 
RDKIT_GRAPHMOL_EXPORT ATOM_EQUALS_QUERYmakeAHAtomQuery ()
 returns a Query for matching generic AH atoms (any atom) More...
 
RDKIT_GRAPHMOL_EXPORT ATOM_OR_QUERYmakeQAtomQuery ()
 returns a Query for matching generic Q atoms (heteroatoms) More...
 
RDKIT_GRAPHMOL_EXPORT ATOM_EQUALS_QUERYmakeQHAtomQuery ()
 returns a Query for matching generic QH atoms (heteroatom or H) More...
 
RDKIT_GRAPHMOL_EXPORT ATOM_OR_QUERYmakeXAtomQuery ()
 returns a Query for matching generic X atoms (halogens) More...
 
RDKIT_GRAPHMOL_EXPORT ATOM_OR_QUERYmakeXHAtomQuery ()
 returns a Query for matching generic XH atoms (halogen or H) More...
 
RDKIT_GRAPHMOL_EXPORT ATOM_OR_QUERYmakeMAtomQuery ()
 returns a Query for matching generic M atoms (metals) More...
 
RDKIT_GRAPHMOL_EXPORT ATOM_OR_QUERYmakeMHAtomQuery ()
 returns a Query for matching generic MH atoms (metals or H) More...
 
template<class T >
T * makeAtomHasRingBondQuery (const std::string &descr)
 returns a Query for matching atoms that have ring bonds More...
 
RDKIT_GRAPHMOL_EXPORT ATOM_EQUALS_QUERYmakeAtomHasRingBondQuery ()
 
template<class T >
T * makeAtomNumHeteroatomNbrsQuery (int what, const std::string &descr)
 returns a Query for matching the number of heteroatom neighbors More...
 
RDKIT_GRAPHMOL_EXPORT ATOM_EQUALS_QUERYmakeAtomNumHeteroatomNbrsQuery (int what)
 
template<class T >
T * makeAtomHasHeteroatomNbrsQuery (const std::string &descr)
 returns a Query for matching atoms that have heteroatom neighbors More...
 
RDKIT_GRAPHMOL_EXPORT ATOM_EQUALS_QUERYmakeAtomHasHeteroatomNbrsQuery ()
 
template<class T >
T * makeAtomNumAliphaticHeteroatomNbrsQuery (int what, const std::string &descr)
 returns a Query for matching the number of aliphatic heteroatom neighbors More...
 
RDKIT_GRAPHMOL_EXPORT ATOM_EQUALS_QUERYmakeAtomNumAliphaticHeteroatomNbrsQuery (int what)
 
template<class T >
T * makeAtomHasAliphaticHeteroatomNbrsQuery (const std::string &descr)
 returns a Query for matching atoms that have heteroatom neighbors More...
 
RDKIT_GRAPHMOL_EXPORT ATOM_EQUALS_QUERYmakeAtomHasAliphaticHeteroatomNbrsQuery ()
 
RDKIT_GRAPHMOL_EXPORT BOND_EQUALS_QUERYmakeBondOrderEqualsQuery (Bond::BondType what)
 returns a Query for matching bond orders More...
 
RDKIT_GRAPHMOL_EXPORT BOND_EQUALS_QUERYmakeSingleOrAromaticBondQuery ()
 returns a Query for unspecified SMARTS bonds More...
 
RDKIT_GRAPHMOL_EXPORT BOND_EQUALS_QUERYmakeBondDirEqualsQuery (Bond::BondDir what)
 returns a Query for matching bond directions More...
 
RDKIT_GRAPHMOL_EXPORT BOND_EQUALS_QUERYmakeBondHasStereoQuery ()
 returns a Query for matching bonds with stereo set More...
 
RDKIT_GRAPHMOL_EXPORT BOND_EQUALS_QUERYmakeBondIsInRingQuery ()
 returns a Query for matching ring bonds More...
 
RDKIT_GRAPHMOL_EXPORT BOND_EQUALS_QUERYmakeBondInRingOfSizeQuery (int what)
 returns a Query for matching bonds in rings of a particular size More...
 
RDKIT_GRAPHMOL_EXPORT BOND_EQUALS_QUERYmakeBondMinRingSizeQuery (int what)
 returns a Query for matching a bond's minimum ring size More...
 
RDKIT_GRAPHMOL_EXPORT BOND_EQUALS_QUERYmakeBondInNRingsQuery (int tgt)
 returns a Query for matching bonds in a particular number of rings More...
 
RDKIT_GRAPHMOL_EXPORT BOND_NULL_QUERYmakeBondNullQuery ()
 returns a Query for matching any bond More...
 
RDKIT_GRAPHMOL_EXPORT ATOM_NULL_QUERYmakeAtomNullQuery ()
 returns a Query for matching any atom More...
 
static int queryAtomRingMembership (Atom const *at)
 
template<typename T >
int nullDataFun (T)
 
template<typename T >
bool nullQueryFun (T)
 
template<class Target >
Queries::EqualityQuery< int, const Target *, true > * makeHasPropQuery (const std::string &property)
 returns a Query for matching atoms that have a particular property More...
 
template<class Target , class T >
Queries::EqualityQuery< int, const Target *, true > * makePropQuery (const std::string &propname, const T &val, const T &tolerance=T())
 
RDKIT_GRAPHMOL_EXPORT bool isComplexQuery (const Bond *b)
 
RDKIT_GRAPHMOL_EXPORT bool isComplexQuery (const Atom *a)
 
RDKIT_GRAPHMOL_EXPORT bool isAtomAromatic (const Atom *a)
 
RDKIT_RGROUPDECOMPOSITION_EXPORT unsigned int RGroupDecompose (const std::vector< ROMOL_SPTR > &cores, const std::vector< ROMOL_SPTR > &mols, RGroupRows &rows, std::vector< unsigned int > *unmatched=0, const RGroupDecompositionParameters &options=RGroupDecompositionParameters())
 
RDKIT_RGROUPDECOMPOSITION_EXPORT unsigned int RGroupDecompose (const std::vector< ROMOL_SPTR > &cores, const std::vector< ROMOL_SPTR > &mols, RGroupColumns &columns, std::vector< unsigned int > *unmatched=0, const RGroupDecompositionParameters &options=RGroupDecompositionParameters())
 
RDKIT_SLNPARSE_EXPORT RWMolSLNToMol (const std::string &smi, bool sanitize=true, int debugParse=0)
 
RDKIT_SLNPARSE_EXPORT RWMolSLNQueryToMol (const std::string &smi, bool mergeHs=true, int debugParse=0)
 
RDKIT_SMILESPARSE_EXPORT std::string MolToSmarts (ROMol &mol, bool doIsomericSmarts=true)
 returns the SMARTS for a molecule More...
 
RDKIT_SMILESPARSE_EXPORT RWMolSmilesToMol (const std::string &smi, const SmilesParserParams &params)
 
RDKIT_SMILESPARSE_EXPORT AtomSmilesToAtom (const std::string &smi)
 
RDKIT_SMILESPARSE_EXPORT BondSmilesToBond (const std::string &smi)
 
RWMolSmilesToMol (const std::string &smi, int debugParse=0, bool sanitize=true, std::map< std::string, std::string > *replacements=0)
 Construct a molecule from a SMILES string. More...
 
RDKIT_SMILESPARSE_EXPORT RWMolSmartsToMol (const std::string &sma, int debugParse=0, bool mergeHs=false, std::map< std::string, std::string > *replacements=0)
 Construct a molecule from a SMARTS string. More...
 
RDKIT_SMILESPARSE_EXPORT AtomSmartsToAtom (const std::string &sma)
 
RDKIT_SMILESPARSE_EXPORT BondSmartsToBond (const std::string &sma)
 
std::unique_ptr< RDKit::RWMoloperator"" _smiles (const char *text, size_t len)
 
std::unique_ptr< RDKit::RWMoloperator"" _smarts (const char *text, size_t len)
 
RDKIT_SMILESPARSE_EXPORT std::string MolToSmiles (const ROMol &mol, bool doIsomericSmiles=true, bool doKekule=false, int rootedAtAtom=-1, bool canonical=true, bool allBondsExplicit=false, bool allHsExplicit=false, bool doRandom=false)
 returns canonical SMILES for a molecule More...
 
RDKIT_SMILESPARSE_EXPORT std::string MolFragmentToSmiles (const ROMol &mol, const std::vector< int > &atomsToUse, const std::vector< int > *bondsToUse=0, const std::vector< std::string > *atomSymbols=0, const std::vector< std::string > *bondSymbols=0, bool doIsomericSmiles=true, bool doKekule=false, int rootedAtAtom=-1, bool canonical=true, bool allBondsExplicit=false, bool allHsExplicit=false)
 returns canonical SMILES for part of a molecule More...
 
RDKIT_GRAPHMOL_EXPORT void removeGroupsWithAtom (const Atom *atom, std::vector< StereoGroup > &groups)
 
RDKIT_GRAPHMOL_EXPORT void removeGroupsWithAtoms (const std::vector< Atom *> &atoms, std::vector< StereoGroup > &groups)
 
RDKIT_SUBGRAPHS_EXPORT INT_PATH_LIST_MAP findAllSubgraphsOfLengthsMtoN (const ROMol &mol, unsigned int lowerLen, unsigned int upperLen, bool useHs=false, int rootedAtAtom=-1)
 find all bond subgraphs in a range of sizes More...
 
RDKIT_SUBGRAPHS_EXPORT PATH_LIST findAllSubgraphsOfLengthN (const ROMol &mol, unsigned int targetLen, bool useHs=false, int rootedAtAtom=-1)
 find all bond subgraphs of a particular size More...
 
RDKIT_SUBGRAPHS_EXPORT PATH_LIST findUniqueSubgraphsOfLengthN (const ROMol &mol, unsigned int targetLen, bool useHs=false, bool useBO=true, int rootedAtAtom=-1)
 find unique bond subgraphs of a particular size More...
 
RDKIT_SUBGRAPHS_EXPORT PATH_LIST findAllPathsOfLengthN (const ROMol &mol, unsigned int targetLen, bool useBonds=true, bool useHs=false, int rootedAtAtom=-1)
 find all paths of a particular size More...
 
RDKIT_SUBGRAPHS_EXPORT INT_PATH_LIST_MAP findAllPathsOfLengthsMtoN (const ROMol &mol, unsigned int lowerLen, unsigned int upperLen, bool useBonds=true, bool useHs=false, int rootedAtAtom=-1)
 
RDKIT_SUBGRAPHS_EXPORT PATH_TYPE findAtomEnvironmentOfRadiusN (const ROMol &mol, unsigned int radius, unsigned int rootedAtAtom, bool useHs=false)
 find bond subgraphs of a particular radius around an atom More...
 
RDKIT_SUBSTRUCTMATCH_EXPORT bool SubstructMatch (const ROMol &mol, const ROMol &query, MatchVectType &matchVect, bool recursionPossible=true, bool useChirality=false, bool useQueryQueryMatches=false)
 Find a substructure match for a query in a molecule. More...
 
RDKIT_SUBSTRUCTMATCH_EXPORT bool SubstructMatch (ResonanceMolSupplier &resMolSuppl, const ROMol &query, MatchVectType &matchVect, bool recursionPossible=true, bool useChirality=false, bool useQueryQueryMatches=false)
 Find a substructure match for a query in a ResonanceMolSupplier object. More...
 
RDKIT_SUBSTRUCTMATCH_EXPORT unsigned int SubstructMatch (const ROMol &mol, const ROMol &query, std::vector< MatchVectType > &matchVect, bool uniquify=true, bool recursionPossible=true, bool useChirality=false, bool useQueryQueryMatches=false, unsigned int maxMatches=1000)
 Find all substructure matches for a query in a molecule. More...
 
RDKIT_SUBSTRUCTMATCH_EXPORT unsigned int SubstructMatch (ResonanceMolSupplier &resMolSuppl, const ROMol &query, std::vector< MatchVectType > &matchVect, bool uniquify=false, bool recursionPossible=true, bool useChirality=false, bool useQueryQueryMatches=false, unsigned int maxMatches=1000, int numThreads=1)
 Find all substructure matches for a query in a ResonanceMolSupplier object. More...
 
RDKIT_SUBSTRUCTMATCH_EXPORT bool SubstructMatch (const MolBundle &bundle, const ROMol &query, MatchVectType &matchVect, bool recursionPossible=true, bool useChirality=false, bool useQueryQueryMatches=false)
 
RDKIT_SUBSTRUCTMATCH_EXPORT bool SubstructMatch (const ROMol &bundle, const MolBundle &query, MatchVectType &matchVect, bool recursionPossible=true, bool useChirality=false, bool useQueryQueryMatches=false)
 
RDKIT_SUBSTRUCTMATCH_EXPORT bool SubstructMatch (const MolBundle &bundle, const MolBundle &query, MatchVectType &matchVect, bool recursionPossible=true, bool useChirality=false, bool useQueryQueryMatches=false)
 
RDKIT_SUBSTRUCTMATCH_EXPORT unsigned int SubstructMatch (const MolBundle &mol, const ROMol &query, std::vector< MatchVectType > &matchVect, bool uniquify=true, bool recursionPossible=true, bool useChirality=false, bool useQueryQueryMatches=false, unsigned int maxMatches=1000)
 
RDKIT_SUBSTRUCTMATCH_EXPORT unsigned int SubstructMatch (const MolBundle &mol, const MolBundle &query, std::vector< MatchVectType > &matchVect, bool uniquify=true, bool recursionPossible=true, bool useChirality=false, bool useQueryQueryMatches=false, unsigned int maxMatches=1000)
 
RDKIT_SUBSTRUCTMATCH_EXPORT unsigned int SubstructMatch (const ROMol &mol, const MolBundle &query, std::vector< MatchVectType > &matchVect, bool uniquify=true, bool recursionPossible=true, bool useChirality=false, bool useQueryQueryMatches=false, unsigned int maxMatches=1000)
 
RDKIT_SUBSTRUCTMATCH_EXPORT double toPrime (const MatchVectType &v)
 
RDKIT_SUBSTRUCTMATCH_EXPORT void removeDuplicates (std::vector< MatchVectType > &v, unsigned int nAtoms)
 
RDKIT_SUBSTRUCTMATCH_EXPORT bool atomCompat (const Atom *a1, const Atom *a2, bool useQueryQueryMatches=false)
 
RDKIT_SUBSTRUCTMATCH_EXPORT bool chiralAtomCompat (const Atom *a1, const Atom *a2)
 
RDKIT_SUBSTRUCTMATCH_EXPORT bool bondCompat (const Bond *b1, const Bond *b2, bool useQueryQueryMatches=false)
 
RDKIT_TRAJECTORY_EXPORT unsigned int readAmberTrajectory (const std::string &fName, Trajectory &traj)
 Reads coordinates from an AMBER trajectory file into the traj Trajectory object. More...
 
RDKIT_TRAJECTORY_EXPORT unsigned int readGromosTrajectory (const std::string &fName, Trajectory &traj)
 Reads coordinates from a GROMOS trajectory file into the traj Trajectory object. More...
 
DiscreteDistMatgetDiscreteDistMat ()
 
RDKIT_DATASTRUCTS_EXPORT unsigned int computeL1Norm (const DiscreteValueVect &v1, const DiscreteValueVect &v2)
 
RDKIT_DATASTRUCTS_EXPORT DiscreteValueVect operator+ (const DiscreteValueVect &p1, const DiscreteValueVect &p2)
 
RDKIT_DATASTRUCTS_EXPORT DiscreteValueVect operator- (const DiscreteValueVect &p1, const DiscreteValueVect &p2)
 
template<typename IndexType , typename SequenceType >
void updateFromSequence (SparseIntVect< IndexType > &vect, const SequenceType &seq)
 
template<typename IndexType >
double DiceSimilarity (const SparseIntVect< IndexType > &v1, const SparseIntVect< IndexType > &v2, bool returnDistance=false, double bounds=0.0)
 
template<typename IndexType >
double TverskySimilarity (const SparseIntVect< IndexType > &v1, const SparseIntVect< IndexType > &v2, double a, double b, bool returnDistance=false, double bounds=0.0)
 
template<typename IndexType >
double TanimotoSimilarity (const SparseIntVect< IndexType > &v1, const SparseIntVect< IndexType > &v2, bool returnDistance=false, double bounds=0.0)
 
template<typename CompareFunc >
bool hanoi (int *base, int nel, int *temp, int *count, int *changed, CompareFunc compar)
 
template<typename CompareFunc >
void hanoisort (int *base, int nel, int *count, int *changed, CompareFunc compar)
 
template<class T >
const T rdany_cast (const RDAny &d)
 
template<class T >
rdany_cast (RDAny &d)
 
template<class T >
boost::enable_if< boost::is_arithmetic< T >, T >::type from_rdany (const RDAny &arg)
 
template<class T >
boost::disable_if< boost::is_arithmetic< T >, T >::type from_rdany (const RDAny &arg)
 
unsigned int getNumThreadsToUse (int target)
 
void copy_rdvalue (RDValue &dest, const RDValue &src)
 
template<class T >
bool rdvalue_is (RDValue v)
 
template<>
bool rdvalue_is< double > (RDValue v)
 
template<>
bool rdvalue_is< const double & > (RDValue v)
 
template<class T >
rdvalue_cast (RDValue v)
 
template<>
double rdvalue_cast< double > (RDValue v)
 
template<>
float rdvalue_cast< float > (RDValue v)
 
template<>
int rdvalue_cast< int > (RDValue v)
 
template<>
unsigned int rdvalue_cast< unsigned int > (RDValue v)
 
template<>
bool rdvalue_cast< bool > (RDValue v)
 
template<>
std::string rdvalue_cast< std::string > (RDValue_cast_t v)
 
template<>
std::string & rdvalue_cast< std::string & > (RDValue_cast_t v)
 
template<>
std::vector< double > rdvalue_cast< std::vector< double > > (RDValue_cast_t v)
 
template<>
std::vector< double > & rdvalue_cast< std::vector< double > & > (RDValue_cast_t v)
 
template<>
std::vector< float > rdvalue_cast< std::vector< float > > (RDValue_cast_t v)
 
template<>
std::vector< float > & rdvalue_cast< std::vector< float > & > (RDValue_cast_t v)
 
template<>
std::vector< std::string > rdvalue_cast< std::vector< std::string > > (RDValue_cast_t v)
 
template<>
std::vector< std::string > & rdvalue_cast< std::vector< std::string > & > (RDValue_cast_t v)
 
template<>
std::vector< int > rdvalue_cast< std::vector< int > > (RDValue_cast_t v)
 
template<>
std::vector< int > & rdvalue_cast< std::vector< int > & > (RDValue_cast_t v)
 
template<>
std::vector< unsigned int > rdvalue_cast< std::vector< unsigned int > > (RDValue_cast_t v)
 
template<>
std::vector< unsigned int > & rdvalue_cast< std::vector< unsigned int > & > (RDValue_cast_t v)
 
template<>
boost::any rdvalue_cast< boost::any > (RDValue_cast_t v)
 
template<>
boost::any & rdvalue_cast< boost::any & > (RDValue_cast_t v)
 
template<>
const boost::any & rdvalue_cast< const boost::any & > (RDValue_cast_t v)
 
template<class T >
std::string vectToString (RDValue val)
 
bool rdvalue_tostring (RDValue_cast_t val, std::string &res)
 
template<class T >
boost::enable_if< boost::is_arithmetic< T >, T >::type from_rdvalue (RDValue_cast_t arg)
 
template<class T >
boost::disable_if< boost::is_arithmetic< T >, T >::type from_rdvalue (RDValue_cast_t arg)
 
template<class T , unsigned int size>
SwapBytes (T value)
 
template<EEndian from, EEndian to, class T >
EndianSwapBytes (T value)
 
template<EEndian from, EEndian to>
char EndianSwapBytes (char value)
 
template<EEndian from, EEndian to>
unsigned char EndianSwapBytes (unsigned char value)
 
template<EEndian from, EEndian to>
signed char EndianSwapBytes (signed char value)
 
void appendPackedIntToStream (std::stringstream &ss, boost::uint32_t num)
 Packs an integer and outputs it to a stream. More...
 
boost::uint32_t readPackedIntFromStream (std::stringstream &ss)
 Reads an integer from a stream in packed format and returns the result. More...
 
boost::uint32_t pullPackedIntFromString (const char *&text)
 
template<typename T >
void streamWrite (std::ostream &ss, const T &val)
 does a binary write of an object to a stream More...
 
void streamWrite (std::ostream &ss, const std::string &what)
 special case for string More...
 
template<typename T >
void streamWriteVec (std::ostream &ss, const T &val)
 
template<typename T >
void streamRead (std::istream &ss, T &loc)
 does a binary read of an object from a stream More...
 
template<class T >
void streamRead (std::istream &ss, T &obj, int version)
 special case for string More...
 
void streamRead (std::istream &ss, std::string &what, int version)
 
template<class T >
void streamReadVec (std::istream &ss, T &val)
 
void streamReadStringVec (std::istream &ss, std::vector< std::string > &val, int version)
 
std::string getLine (std::istream *inStream)
 grabs the next line from an instream and returns it. More...
 
std::string getLine (std::istream &inStream)
 grabs the next line from an instream and returns it. More...
 
bool isSerializable (const Dict::Pair &pair)
 
bool streamWriteProp (std::ostream &ss, const Dict::Pair &pair)
 
bool streamWriteProps (std::ostream &ss, const RDProps &props, bool savePrivate=false, bool saveComputed=false)
 
template<class T >
void readRDValue (std::istream &ss, RDValue &value)
 
template<class T >
void readRDVecValue (std::istream &ss, RDValue &value)
 
void readRDValueString (std::istream &ss, RDValue &value)
 
void readRDStringVecValue (std::istream &ss, RDValue &value)
 
bool streamReadProp (std::istream &ss, Dict::Pair &pair)
 
unsigned int streamReadProps (std::istream &ss, RDProps &props)
 
RDKIT_RDGENERAL_EXPORT void Union (const INT_VECT &r1, const INT_VECT &r2, INT_VECT &res)
 calculate the union of two INT_VECTs and put the results in a third vector More...
 
RDKIT_RDGENERAL_EXPORT void Intersect (const INT_VECT &r1, const INT_VECT &r2, INT_VECT &res)
 calculate the intersection of two INT_VECTs and put the results in a third vector More...
 
RDKIT_RDGENERAL_EXPORT void Union (const VECT_INT_VECT &rings, INT_VECT &res, const INT_VECT *exclude=NULL)
 calculating the union of the INT_VECT's in a VECT_INT_VECT More...
 
RDKIT_RDGENERAL_EXPORT int nextCombination (INT_VECT &comb, int tot)
 given a current combination of numbers change it to the next possible More...
 
RDKIT_RDGENERAL_EXPORT double round (double v)
 rounds a value to the closest int More...
 
RDKIT_RDGENERAL_EXPORT double computeIntVectPrimesProduct (const INT_VECT &ring)
 compute the product of the set of primes corresponding to the values in an INT_VECT More...
 
RDKIT_RDGENERAL_EXPORT bool feq (double v1, double v2, double tol=1e-4)
 floating point comparison with a tolerance More...
 
RDKIT_RDGENERAL_EXPORT rng_typegetRandomGenerator (int seed=-1)
 Optionally seed and return a reference to the global (Boost) random. More...
 
RDKIT_RDGENERAL_EXPORT double getRandomVal (int seed=-1)
 
RDKIT_RDGENERAL_EXPORT double_source_typegetDoubleRandomSource ()
 return a reference to the global (Boost) random source More...
 
template<class T >
unsigned int countSwapsToInterconvert (const T &ref, T probe)
 

Variables

RDKIT_GRAPHMOL_EXPORT const std::string periodicTableAtomData
 
RDKIT_GRAPHMOL_EXPORT const std::string isotopesAtomData []
 
RDKIT_CHEMREACTIONS_EXPORT const ReactionFingerprintParams DefaultStructuralFPParams
 
RDKIT_CHEMREACTIONS_EXPORT const ReactionFingerprintParams DefaultDifferenceFPParams
 
const int MOLFILE_MAXLINE = 256
 
static int defaultConfId = -1
 
static const unsigned int ctdIGNORE_H_H_CONTACTS = 0x1
 
RDKIT_FILTERCATALOG_EXPORT const char * DEFAULT_FILTERMATCHERBASE_NAME
 
RDKIT_FILTERCATALOG_EXPORT const char * SMARTS_MATCH_NAME_DEFAULT
 
const std::string RDKFingerprintMolVersion = "2.0.0"
 
const unsigned int maxFingerprintLayers = 10
 
const std::string LayeredFingerprintMolVersion = "0.7.0"
 
const unsigned int substructLayers = 0x07
 
std::string paramData
 
std::string additionalParamData
 
const double IONXH = 20.02
 
const double DAMP_SCALE = 0.5
 
const double DAMP = 0.5
 
const int massIntegerConversionFactor = 1000
 
RDKIT_GRAPHMOL_EXPORT const int ci_RIGHTMOST_ATOM
 
RDKIT_GRAPHMOL_EXPORT const int ci_LEADING_BOND
 
RDKIT_GRAPHMOL_EXPORT const int ci_ATOM_HOLDER
 
const int NUM_PRIMES_AVAIL = 1000
 the number of primes available and stored More...
 
int firstThousandPrimes [NUM_PRIMES_AVAIL]
 
const unsigned int BITS_PER_INT = 32
 
RDKIT_RDGENERAL_EXPORT const double MAX_DOUBLE
 
RDKIT_RDGENERAL_EXPORT const double EPS_DOUBLE
 
RDKIT_RDGENERAL_EXPORT const double SMALL_DOUBLE
 
RDKIT_RDGENERAL_EXPORT const double MAX_INT
 
RDKIT_RDGENERAL_EXPORT const double MAX_LONGINT
 
const int FILE_MAXLINE
 an assumed maximum length for lines read from files More...
 
RDKIT_RDGENERAL_EXPORT const char * rdkitVersion
 
RDKIT_RDGENERAL_EXPORT const char * boostVersion
 
RDKIT_RDGENERAL_EXPORT const char * rdkitBuild
 

Detailed Description

Std stuff.

Includes a bunch of functionality for handling Atom and Bond queries.

Typedef Documentation

◆ ATOM_AND_QUERY

typedef Queries::AndQuery<int, Atom const *, true> RDKit::ATOM_AND_QUERY

Definition at line 31 of file QueryOps.h.

◆ ATOM_BOOL_QUERY

typedef Queries::Query<bool, Atom const *, true> RDKit::ATOM_BOOL_QUERY

Definition at line 28 of file QueryOps.h.

◆ ATOM_EQUALS_QUERY

Definition at line 40 of file QueryOps.h.

◆ ATOM_GREATER_QUERY

Definition at line 43 of file QueryOps.h.

◆ ATOM_GREATEREQUAL_QUERY

Definition at line 47 of file QueryOps.h.

◆ ATOM_LESS_QUERY

typedef Queries::LessQuery<int, Atom const *, true> RDKit::ATOM_LESS_QUERY

Definition at line 51 of file QueryOps.h.

◆ ATOM_LESSEQUAL_QUERY

Definition at line 54 of file QueryOps.h.

◆ ATOM_NULL_QUERY

typedef Queries::Query<int, Atom const *, true> RDKit::ATOM_NULL_QUERY

Definition at line 64 of file QueryOps.h.

◆ ATOM_OR_QUERY

typedef Queries::OrQuery<int, Atom const *, true> RDKit::ATOM_OR_QUERY

Definition at line 34 of file QueryOps.h.

◆ ATOM_PROP_QUERY

typedef Queries::EqualityQuery<int, Atom const *, true> RDKit::ATOM_PROP_QUERY

Definition at line 782 of file QueryOps.h.

◆ ATOM_RANGE_QUERY

typedef Queries::RangeQuery<int, Atom const *, true> RDKit::ATOM_RANGE_QUERY

Definition at line 57 of file QueryOps.h.

◆ ATOM_SET_QUERY

typedef Queries::SetQuery<int, Atom const *, true> RDKit::ATOM_SET_QUERY

Definition at line 60 of file QueryOps.h.

◆ ATOM_XOR_QUERY

typedef Queries::XOrQuery<int, Atom const *, true> RDKit::ATOM_XOR_QUERY

Definition at line 37 of file QueryOps.h.

◆ atomindex_t

typedef boost::uint32_t RDKit::atomindex_t

Definition at line 14 of file details.h.

◆ BOND_AND_QUERY

typedef Queries::AndQuery<int, Bond const *, true> RDKit::BOND_AND_QUERY

Definition at line 32 of file QueryOps.h.

◆ BOND_BOOL_QUERY

typedef Queries::Query<bool, Bond const *, true> RDKit::BOND_BOOL_QUERY

Definition at line 29 of file QueryOps.h.

◆ BOND_EQUALS_QUERY

Definition at line 41 of file QueryOps.h.

◆ BOND_GREATER_QUERY

Definition at line 44 of file QueryOps.h.

◆ BOND_GREATEREQUAL_QUERY

Definition at line 49 of file QueryOps.h.

◆ BOND_LESS_QUERY

typedef Queries::LessQuery<int, Bond const *, true> RDKit::BOND_LESS_QUERY

Definition at line 52 of file QueryOps.h.

◆ BOND_LESSEQUAL_QUERY

Definition at line 55 of file QueryOps.h.

◆ BOND_NULL_QUERY

typedef Queries::Query<int, Bond const *, true> RDKit::BOND_NULL_QUERY

Definition at line 63 of file QueryOps.h.

◆ BOND_OR_QUERY

typedef Queries::OrQuery<int, Bond const *, true> RDKit::BOND_OR_QUERY

Definition at line 35 of file QueryOps.h.

◆ BOND_PROP_QUERY

typedef Queries::EqualityQuery<int, Bond const *, true> RDKit::BOND_PROP_QUERY

Definition at line 783 of file QueryOps.h.

◆ BOND_RANGE_QUERY

typedef Queries::RangeQuery<int, Bond const *, true> RDKit::BOND_RANGE_QUERY

Definition at line 58 of file QueryOps.h.

◆ BOND_SET_QUERY

typedef Queries::SetQuery<int, Bond const *, true> RDKit::BOND_SET_QUERY

Definition at line 61 of file QueryOps.h.

◆ BOND_XOR_QUERY

typedef Queries::XOrQuery<int, Bond const *, true> RDKit::BOND_XOR_QUERY

Definition at line 38 of file QueryOps.h.

◆ CEMap

typedef boost::unordered_map<std::size_t, ConjElectrons *> RDKit::CEMap

Definition at line 32 of file Resonance.h.

◆ CEVect

typedef std::vector<ConjElectrons *> RDKit::CEVect

Definition at line 29 of file Resonance.h.

◆ CEVect3

typedef std::vector<CEVect2 *> RDKit::CEVect3

Definition at line 30 of file Resonance.h.

◆ ColourPalette

typedef std::map<int, DrawColour> RDKit::ColourPalette

Definition at line 40 of file MolDraw2D.h.

◆ CONFORMER_SPTR

typedef boost::shared_ptr<Conformer> RDKit::CONFORMER_SPTR

Definition at line 136 of file Conformer.h.

◆ ConjAtomMap

typedef std::map<unsigned int, AtomElectrons *> RDKit::ConjAtomMap

Definition at line 28 of file Resonance.h.

◆ ConjBondMap

typedef std::map<unsigned int, BondElectrons *> RDKit::ConjBondMap

Definition at line 26 of file Resonance.h.

◆ ConjFP

typedef std::vector<boost::uint8_t> RDKit::ConjFP

Definition at line 31 of file Resonance.h.

◆ ConstAtomPtr

typedef Atom const* RDKit::ConstAtomPtr

Definition at line 634 of file QueryOps.h.

◆ ConstBondPtr

typedef Bond const* RDKit::ConstBondPtr

Definition at line 745 of file QueryOps.h.

◆ DashPattern

typedef std::vector<unsigned int> RDKit::DashPattern

Definition at line 41 of file MolDraw2D.h.

◆ DOUBLE_INT_MAP

typedef std::map<double, int, ltDouble> RDKit::DOUBLE_INT_MAP

std::map from double to integer.

Definition at line 317 of file types.h.

◆ double_source_type

typedef boost::variate_generator<rng_type &, uniform_double> RDKit::double_source_type

Definition at line 40 of file utils.h.

◆ DOUBLE_VECT

typedef std::vector<double> RDKit::DOUBLE_VECT

Definition at line 272 of file types.h.

◆ DOUBLE_VECT_CI

typedef DOUBLE_VECT::const_iterator RDKit::DOUBLE_VECT_CI

Definition at line 274 of file types.h.

◆ DOUBLE_VECT_I

typedef DOUBLE_VECT::iterator RDKit::DOUBLE_VECT_I

Definition at line 273 of file types.h.

◆ DrawColour

typedef boost::tuple<float, float, float> RDKit::DrawColour

Definition at line 39 of file MolDraw2D.h.

◆ FCatalog

◆ FeatSPtr

typedef boost::shared_ptr<MolChemicalFeature> RDKit::FeatSPtr

Definition at line 19 of file MolChemicalFeatureFactory.h.

◆ FeatSPtrList

typedef std::list<FeatSPtr> RDKit::FeatSPtrList

Definition at line 21 of file MolChemicalFeatureFactory.h.

◆ FeatSPtrList_I

typedef FeatSPtrList::iterator RDKit::FeatSPtrList_I

Definition at line 22 of file MolChemicalFeatureFactory.h.

◆ FragCatalog

◆ INT_DEQUE

typedef std::deque<int> RDKit::INT_DEQUE

Definition at line 289 of file types.h.

◆ INT_DEQUE_CI

typedef INT_DEQUE::const_iterator RDKit::INT_DEQUE_CI

Definition at line 291 of file types.h.

◆ INT_DEQUE_I

typedef INT_DEQUE::iterator RDKit::INT_DEQUE_I

Definition at line 290 of file types.h.

◆ INT_INT_DEQ_MAP

typedef std::map<int, INT_DEQUE> RDKit::INT_INT_DEQ_MAP

Definition at line 293 of file types.h.

◆ INT_INT_DEQ_MAP_CI

typedef INT_INT_DEQ_MAP::const_iterator RDKit::INT_INT_DEQ_MAP_CI

Definition at line 294 of file types.h.

◆ INT_INT_VECT_MAP

typedef std::map<int, INT_VECT> RDKit::INT_INT_VECT_MAP

Definition at line 282 of file types.h.

◆ INT_INT_VECT_MAP_CI

typedef INT_INT_VECT_MAP::const_iterator RDKit::INT_INT_VECT_MAP_CI

Definition at line 283 of file types.h.

◆ INT_LIST

typedef std::list<int> RDKit::INT_LIST

Definition at line 253 of file types.h.

◆ INT_LIST_CI

typedef INT_LIST::const_iterator RDKit::INT_LIST_CI

Definition at line 255 of file types.h.

◆ INT_LIST_I

typedef INT_LIST::iterator RDKit::INT_LIST_I

Definition at line 254 of file types.h.

◆ INT_MAP_INT

typedef std::map<int, int> RDKit::INT_MAP_INT

Definition at line 285 of file types.h.

◆ INT_MAP_INT_CI

typedef INT_MAP_INT::const_iterator RDKit::INT_MAP_INT_CI

Definition at line 287 of file types.h.

◆ INT_MAP_INT_I

typedef INT_MAP_INT::iterator RDKit::INT_MAP_INT_I

Definition at line 286 of file types.h.

◆ INT_PATH_LIST_MAP

typedef std::map<int, PATH_LIST> RDKit::INT_PATH_LIST_MAP

Definition at line 45 of file Subgraphs.h.

◆ INT_PATH_LIST_MAP_CI

typedef INT_PATH_LIST_MAP::const_iterator RDKit::INT_PATH_LIST_MAP_CI

Definition at line 46 of file Subgraphs.h.

◆ INT_PATH_LIST_MAP_I

typedef INT_PATH_LIST_MAP::iterator RDKit::INT_PATH_LIST_MAP_I

Definition at line 47 of file Subgraphs.h.

◆ INT_SET

typedef std::set<int> RDKit::INT_SET

Definition at line 296 of file types.h.

◆ INT_SET_CI

typedef INT_SET::const_iterator RDKit::INT_SET_CI

Definition at line 298 of file types.h.

◆ INT_SET_I

typedef INT_SET::iterator RDKit::INT_SET_I

Definition at line 297 of file types.h.

◆ int_source_type

typedef boost::variate_generator<rng_type &, uniform_int> RDKit::int_source_type

Definition at line 39 of file utils.h.

◆ INT_VECT

typedef std::vector<int> RDKit::INT_VECT

Definition at line 247 of file types.h.

◆ INT_VECT_CI

typedef INT_VECT::const_iterator RDKit::INT_VECT_CI

Definition at line 249 of file types.h.

◆ INT_VECT_CRI

typedef INT_VECT::const_reverse_iterator RDKit::INT_VECT_CRI

Definition at line 251 of file types.h.

◆ INT_VECT_I

typedef INT_VECT::iterator RDKit::INT_VECT_I

Definition at line 248 of file types.h.

◆ INT_VECT_RI

typedef INT_VECT::reverse_iterator RDKit::INT_VECT_RI

Definition at line 250 of file types.h.

◆ INVAR_VECT

typedef std::vector<double> RDKit::INVAR_VECT

Definition at line 30 of file MolOps.h.

◆ INVAR_VECT_CI

typedef INVAR_VECT::const_iterator RDKit::INVAR_VECT_CI

Definition at line 33 of file MolOps.h.

◆ INVAR_VECT_I

typedef INVAR_VECT::iterator RDKit::INVAR_VECT_I

Definition at line 32 of file MolOps.h.

◆ LIST_INT_VECT

typedef std::list<INT_VECT> RDKit::LIST_INT_VECT

Definition at line 257 of file types.h.

◆ LIST_INT_VECT_CI

typedef LIST_INT_VECT::const_iterator RDKit::LIST_INT_VECT_CI

Definition at line 259 of file types.h.

◆ LIST_INT_VECT_I

typedef LIST_INT_VECT::iterator RDKit::LIST_INT_VECT_I

Definition at line 258 of file types.h.

◆ LONGINT

typedef long long int RDKit::LONGINT

Definition at line 226 of file types.h.

◆ MatchVectType

typedef std::vector< std::pair< int, int > > RDKit::MatchVectType

used to return matches from substructure searching, The format is (queryAtomIdx, molAtomIdx)

Definition at line 24 of file FragFPGenerator.h.

◆ MCSAtomCompareFunction

typedef bool(* RDKit::MCSAtomCompareFunction) (const MCSAtomCompareParameters &p, const ROMol &mol1, unsigned int atom1, const ROMol &mol2, unsigned int atom2, void *userData)

Definition at line 51 of file FMCS.h.

◆ MCSBondCompareFunction

typedef bool(* RDKit::MCSBondCompareFunction) (const MCSBondCompareParameters &p, const ROMol &mol1, unsigned int bond1, const ROMol &mol2, unsigned int bond2, void *userData)

Definition at line 55 of file FMCS.h.

◆ MCSFinalMatchCheckFunction

typedef bool(* RDKit::MCSFinalMatchCheckFunction) (const short unsigned c1[], const short unsigned c2[], const ROMol &mol1, const FMCS::Graph &query, const ROMol &mol2, const FMCS::Graph &target, const MCSParameters *p)

Definition at line 47 of file FMCS.h.

◆ MCSProgressCallback

typedef bool(* RDKit::MCSProgressCallback) (const MCSProgressData &stat, const MCSParameters &params, void *userData)

Definition at line 94 of file FMCS.h.

◆ MOL_PTR_VECT

typedef std::vector<ROMol *> RDKit::MOL_PTR_VECT

Definition at line 725 of file ROMol.h.

◆ MOL_PTR_VECT_CI

typedef MOL_PTR_VECT::const_iterator RDKit::MOL_PTR_VECT_CI

Definition at line 728 of file ROMol.h.

◆ MOL_PTR_VECT_I

typedef MOL_PTR_VECT::iterator RDKit::MOL_PTR_VECT_I

Definition at line 729 of file ROMol.h.

◆ MOL_SPTR_VECT

typedef std::vector< ROMOL_SPTR > RDKit::MOL_SPTR_VECT

Definition at line 20 of file FragCatParams.h.

◆ MOL_VECT

typedef std::vector<ROMol> RDKit::MOL_VECT

Definition at line 723 of file ROMol.h.

◆ MolCatalog

a hierarchical catalog for holding molecules

Definition at line 17 of file MolCatalog.h.

◆ MolGraph

typedef boost::adjacency_list<boost::vecS, boost::vecS, boost::undirectedS, Atom *, Bond *> RDKit::MolGraph

This is the BGL type used to store the topology:

Definition at line 41 of file ROMol.h.

◆ PATH_LIST

typedef std::list<PATH_TYPE> RDKit::PATH_LIST

Definition at line 42 of file Subgraphs.h.

◆ PATH_LIST_CI

typedef PATH_LIST::const_iterator RDKit::PATH_LIST_CI

Definition at line 43 of file Subgraphs.h.

◆ PATH_TYPE

typedef std::vector<int> RDKit::PATH_TYPE

Definition at line 37 of file Subgraphs.h.

◆ RDValue_cast_t

Definition at line 360 of file RDValue-doublemagic.h.

◆ RGroupColumn

typedef std::vector<boost::shared_ptr<ROMol> > RDKit::RGroupColumn

Definition at line 88 of file RGroupDecomp.h.

◆ RGroupColumns

typedef std::map<std::string, RGroupColumn> RDKit::RGroupColumns

Definition at line 91 of file RGroupDecomp.h.

◆ RGroupRow

typedef std::map<std::string, boost::shared_ptr<ROMol> > RDKit::RGroupRow

Definition at line 87 of file RGroupDecomp.h.

◆ RGroupRows

typedef std::vector<RGroupRow> RDKit::RGroupRows

Definition at line 90 of file RGroupDecomp.h.

◆ rng_type

typedef boost::minstd_rand RDKit::rng_type

Definition at line 36 of file utils.h.

◆ ROMOL_SPTR

typedef boost::shared_ptr< ROMol > RDKit::ROMOL_SPTR

Definition at line 22 of file ChemTransforms.h.

◆ RWMOL_SPTR

typedef boost::shared_ptr<RWMol> RDKit::RWMOL_SPTR

Definition at line 218 of file RWMol.h.

◆ RWMOL_SPTR_VECT

typedef std::vector< RWMOL_SPTR > RDKit::RWMOL_SPTR_VECT

Definition at line 31 of file FileParsers.h.

◆ SnapshotVect

typedef std::vector<Snapshot> RDKit::SnapshotVect

Definition at line 19 of file Snapshot.h.

◆ STR_UINT_MAP

typedef std::map<std::string, UINT> RDKit::STR_UINT_MAP

Definition at line 279 of file types.h.

◆ STR_UINT_MAP_CI

typedef std::map<std::string, UINT>::const_iterator RDKit::STR_UINT_MAP_CI

Definition at line 280 of file types.h.

◆ STR_VECT

typedef std::vector< std::string > RDKit::STR_VECT

Definition at line 29 of file Dict.h.

◆ STR_VECT_CI

typedef std::vector<std::string>::const_iterator RDKit::STR_VECT_CI

Definition at line 268 of file types.h.

◆ STR_VECT_I

typedef std::vector<std::string>::iterator RDKit::STR_VECT_I

Definition at line 269 of file types.h.

◆ STRING_PROPS

typedef std::map<std::string, std::string> RDKit::STRING_PROPS

Definition at line 53 of file FilterCatalogEntry.h.

◆ UCHAR

typedef unsigned char RDKit::UCHAR

Definition at line 245 of file types.h.

◆ UINT

typedef unsigned int RDKit::UINT

Definition at line 243 of file types.h.

◆ UINT_VECT

typedef std::vector<UINT> RDKit::UINT_VECT

Definition at line 266 of file types.h.

◆ UINT_VECT_CI

typedef std::vector<UINT>::const_iterator RDKit::UINT_VECT_CI

Definition at line 265 of file types.h.

◆ uniform_double

typedef boost::uniform_real RDKit::uniform_double

Definition at line 38 of file utils.h.

◆ uniform_int

typedef boost::uniform_int RDKit::uniform_int

Definition at line 37 of file utils.h.

◆ USHORT

typedef unsigned short RDKit::USHORT

Definition at line 244 of file types.h.

◆ VECT_DOUBLE_VECT

typedef std::vector<DOUBLE_VECT> RDKit::VECT_DOUBLE_VECT

Definition at line 275 of file types.h.

◆ VECT_DOUBLE_VECT_CI

typedef VECT_DOUBLE_VECT::const_iterator RDKit::VECT_DOUBLE_VECT_CI

Definition at line 277 of file types.h.

◆ VECT_DOUBLE_VECT_I

typedef VECT_DOUBLE_VECT::iterator RDKit::VECT_DOUBLE_VECT_I

Definition at line 276 of file types.h.

◆ VECT_INT_VECT

typedef std::vector<INT_VECT> RDKit::VECT_INT_VECT

Definition at line 261 of file types.h.

◆ VECT_INT_VECT_CI

typedef VECT_INT_VECT::const_iterator RDKit::VECT_INT_VECT_CI

Definition at line 263 of file types.h.

◆ VECT_INT_VECT_I

typedef VECT_INT_VECT::iterator RDKit::VECT_INT_VECT_I

Definition at line 262 of file types.h.

Enumeration Type Documentation

◆ AtomComparator

Enumerator
AtomCompareAny 
AtomCompareElements 
AtomCompareIsotopes 

Definition at line 151 of file FMCS.h.

◆ BondComparator

Enumerator
BondCompareAny 
BondCompareOrder 
BondCompareOrderExact 

Definition at line 156 of file FMCS.h.

◆ EEndian

Enumerator
LITTLE_ENDIAN_ORDER 
BIG_ENDIAN_ORDER 

Definition at line 27 of file StreamOps.h.

◆ FingerprintType

Enumerator
AtomPairFP 
TopologicalTorsion 
MorganFP 
RDKitFP 
PatternFP 

Definition at line 43 of file ReactionFingerprints.h.

◆ FPType

enum RDKit::FPType
strong
Enumerator
AtomPairFP 
MorganFP 
RDKitFP 
TopologicalTorsionFP 

Definition at line 295 of file FingerprintGenerator.h.

◆ Mol2Type

Enumerator
CORINA 

Definition at line 174 of file FileParsers.h.

◆ ReactionMoleculeType

Enumerator
Reactant 
Product 
Agent 

Definition at line 41 of file ReactionUtils.h.

◆ RGroupCoreAlignment

Enumerator
None 
MCS 

Definition at line 48 of file RGroupDecomp.h.

◆ RGroupLabelling

Enumerator
AtomMap 
Isotope 
MDLRGroup 

Definition at line 42 of file RGroupDecomp.h.

◆ RGroupLabels

Compute the isomporphic degenerative points in the molecule. These are points that are symmetrically equivalent.

Parameters
molMolecule to compute the degenerative points
Returns
the set of degenerative points (set<unsigned int>)
Enumerator
IsotopeLabels 
AtomMapLabels 
AtomIndexLabels 
RelabelDuplicateLabels 
AutoDetect 

Definition at line 28 of file RGroupDecomp.h.

◆ RGroupMatching

Enumerator
Greedy 
GreedyChunks 
Exhaustive 

Definition at line 36 of file RGroupDecomp.h.

◆ StereoGroupType

Enumerator
STEREO_ABSOLUTE 
STEREO_OR 
STEREO_AND 

Definition at line 28 of file StereoGroup.h.

Function Documentation

◆ addRecursiveQueries()

RDKIT_CHEMTRANSFORMS_EXPORT void RDKit::addRecursiveQueries ( ROMol mol,
const std::map< std::string, ROMOL_SPTR > &  queries,
const std::string &  propName,
std::vector< std::pair< unsigned int, std::string > > *  reactantLabels = NULL 
)

Adds named recursive queries to a molecule's atoms based on atom.

Parameters
mol- the molecule to be modified
queries- the dictionary of named queries to add
propName- the atom property to use to get query names
reactantLabels- to store pairs of (atom index, query string)

NOTES:

  • existing query information, if present, will be supplemented (AND logic)
  • non-query atoms will be replaced with query atoms using only the query logic
  • query names can be present as comma separated lists, they will then be combined using OR logic.
  • throws a KeyErrorException if a particular query name is not present in queries

◆ addRecursiveQueriesToReaction()

RDKIT_CHEMREACTIONS_EXPORT void RDKit::addRecursiveQueriesToReaction ( ChemicalReaction rxn,
const std::map< std::string, ROMOL_SPTR > &  queries,
const std::string &  propName,
std::vector< std::vector< std::pair< unsigned int, std::string >>> *  reactantLabels = NULL 
)

add the recursive queries to the reactants of a reaction

This does its work using RDKit::addRecursiveQueries()

Parameters
rxnthe reaction we are interested in
queries- the dictionary of named queries to add
propName- the atom property to use to get query names optional:
reactantLabels- to store pairs of (atom index, query string) per reactant

NOTES:

  • existing query information, if present, will be supplemented (AND logic)
  • non-query atoms will be replaced with query atoms using only the query logic
  • query names can be present as comma separated lists, they will then be combined using OR logic.
  • throws a KeyErrorException if a particular query name is not present in queries

Referenced by RDKit::ChemicalReaction::setImplicitPropertiesFlag().

◆ appendPackedIntToStream()

void RDKit::appendPackedIntToStream ( std::stringstream &  ss,
boost::uint32_t  num 
)
inline

Packs an integer and outputs it to a stream.

Definition at line 98 of file StreamOps.h.

References CHECK_INVARIANT.

◆ assignBWPalette()

void RDKit::assignBWPalette ( ColourPalette palette)
inline

Definition at line 58 of file MolDraw2D.h.

◆ assignDefaultPalette()

void RDKit::assignDefaultPalette ( ColourPalette palette)
inline

Definition at line 43 of file MolDraw2D.h.

Referenced by RDKit::MolDrawOptions::MolDrawOptions().

◆ atomCompat()

RDKIT_SUBSTRUCTMATCH_EXPORT bool RDKit::atomCompat ( const Atom a1,
const Atom a2,
bool  useQueryQueryMatches = false 
)

◆ bondCompat()

RDKIT_SUBSTRUCTMATCH_EXPORT bool RDKit::bondCompat ( const Bond b1,
const Bond b2,
bool  useQueryQueryMatches = false 
)

◆ buildFeatureFactory() [1/2]

RDKIT_MOLCHEMICALFEATURES_EXPORT MolChemicalFeatureFactory* RDKit::buildFeatureFactory ( std::istream &  inStream)

constructs a MolChemicalFeatureFactory from the data in a stream

Referenced by RDKit::MolChemicalFeatureFactory::addFeatureDef().

◆ buildFeatureFactory() [2/2]

RDKIT_MOLCHEMICALFEATURES_EXPORT MolChemicalFeatureFactory* RDKit::buildFeatureFactory ( const std::string &  featureData)

constructs a MolChemicalFeatureFactory from the data in a string

◆ ChemicalReactionToRxnBlock()

RDKIT_CHEMREACTIONS_EXPORT std::string RDKit::ChemicalReactionToRxnBlock ( const ChemicalReaction rxn,
bool  separateAgents = false 
)

returns an RXN block for a reaction

Parameters
rxnchemical reaction
separateAgentsflag to decide if agents were put in a seperate block, otherwise they were included in the reactants block (default)

Referenced by RDKit::ChemicalReactionParserException::~ChemicalReactionParserException().

◆ ChemicalReactionToRxnMol()

RDKIT_CHEMREACTIONS_EXPORT ROMol* RDKit::ChemicalReactionToRxnMol ( const ChemicalReaction rxn)

returns a ROMol with RXN roles used to describe the reaction

Referenced by RDKit::ChemicalReactionParserException::~ChemicalReactionParserException().

◆ ChemicalReactionToRxnSmarts()

RDKIT_CHEMREACTIONS_EXPORT std::string RDKit::ChemicalReactionToRxnSmarts ( const ChemicalReaction rxn)

returns the reaction SMARTS for a reaction

Referenced by RDKit::ChemicalReactionParserException::~ChemicalReactionParserException().

◆ ChemicalReactionToRxnSmiles()

RDKIT_CHEMREACTIONS_EXPORT std::string RDKit::ChemicalReactionToRxnSmiles ( const ChemicalReaction rxn,
bool  canonical = true 
)

returns the reaction SMILES for a reaction

Referenced by RDKit::ChemicalReactionParserException::~ChemicalReactionParserException().

◆ chiralAtomCompat()

RDKIT_SUBSTRUCTMATCH_EXPORT bool RDKit::chiralAtomCompat ( const Atom a1,
const Atom a2 
)

◆ ClearSingleBondDirFlags()

RDKIT_FILEPARSERS_EXPORT void RDKit::ClearSingleBondDirFlags ( ROMol mol)

◆ combineMols()

RDKIT_CHEMTRANSFORMS_EXPORT ROMol* RDKit::combineMols ( const ROMol mol1,
const ROMol mol2,
RDGeom::Point3D  offset = RDGeom::Point3D(0, 0, 0) 
)

Combined two molecules to create a new one.

Parameters
mol1- the first ROMol to be combined
mol2- the second ROMol to be combined
offset- a constant offset to be added to every atom position in mol2
Returns
a new ROMol with the two molecules combined. The new molecule has not been sanitized. The client is responsible for deleting this molecule.

◆ computeGasteigerCharges() [1/3]

RDKIT_PARTIALCHARGES_EXPORT void RDKit::computeGasteigerCharges ( const ROMol mol,
int  nIter = 12,
bool  throwOnParamFailure = false 
)

◆ computeGasteigerCharges() [2/3]

RDKIT_PARTIALCHARGES_EXPORT void RDKit::computeGasteigerCharges ( const ROMol mol,
int  nIter = 12,
bool  throwOnParamFailure = false 
)

◆ computeGasteigerCharges() [3/3]

RDKIT_PARTIALCHARGES_EXPORT void RDKit::computeGasteigerCharges ( const ROMol mol,
std::vector< double > &  charges,
int  nIter = 12,
bool  throwOnParamFailure = false 
)

◆ computeIntVectPrimesProduct()

RDKIT_RDGENERAL_EXPORT double RDKit::computeIntVectPrimesProduct ( const INT_VECT ring)

compute the product of the set of primes corresponding to the values in an INT_VECT

◆ computeL1Norm()

RDKIT_DATASTRUCTS_EXPORT unsigned int RDKit::computeL1Norm ( const DiscreteValueVect v1,
const DiscreteValueVect v2 
)

◆ computeNumProducts()

RDKIT_CHEMREACTIONS_EXPORT boost::uint64_t RDKit::computeNumProducts ( const EnumerationTypes::RGROUPS sizes)

computeNumProducts Returns the number of possible product combination from The given numbers of building blocks for each rgroup or EnumerationStrategyBase::EnumerationOverflow if the number will not fit into the machines integer type. n.b. An overflow simply means there are a lot of products not that they cannot be enumerated

Referenced by getSizesFromBBs(), RDKit::EnumerationStrategyBase::initialize(), and RDKit::EnumerationStrategyBase::internalInitialize().

◆ ConnectTheDots()

RDKIT_FILEPARSERS_EXPORT void RDKit::ConnectTheDots ( RWMol mol,
unsigned int  flags = 0 
)

◆ copy_rdvalue()

◆ countSwapsToInterconvert()

template<class T >
unsigned int RDKit::countSwapsToInterconvert ( const T &  ref,
probe 
)

Definition at line 54 of file utils.h.

References CHECK_INVARIANT, and PRECONDITION.

◆ deleteSubstructs()

RDKIT_CHEMTRANSFORMS_EXPORT ROMol* RDKit::deleteSubstructs ( const ROMol mol,
const ROMol query,
bool  onlyFrags = false,
bool  useChirality = false 
)

Returns a copy of an ROMol with the atoms and bonds that match a pattern removed.

Parameters
molthe ROMol of interest
querythe query ROMol
onlyFragsif this is set, atoms will only be removed if the entire fragment in which they are found is matched by the query.
useChirality- if set, match the coreQuery using chirality
Returns
a copy of mol with the matching atoms and bonds (if any) removed.

◆ describeQuery() [1/2]

std::string RDKit::describeQuery ( const Atom atom)
inline

◆ describeQuery() [2/2]

std::string RDKit::describeQuery ( const Bond bond)
inline

◆ DetectAtomStereoChemistry()

RDKIT_FILEPARSERS_EXPORT void RDKit::DetectAtomStereoChemistry ( RWMol mol,
const Conformer conf 
)

◆ DetectBondStereoChemistry()

RDKIT_FILEPARSERS_EXPORT void RDKit::DetectBondStereoChemistry ( ROMol mol,
const Conformer conf 
)

deprecated, please use MolOps::detectBondStereoChemistry instead

◆ DetermineBondWedgeState() [1/2]

RDKIT_FILEPARSERS_EXPORT Bond::BondDir RDKit::DetermineBondWedgeState ( const Bond bond,
unsigned int  fromAtomIdx,
const Conformer conf 
)

◆ DetermineBondWedgeState() [2/2]

RDKIT_FILEPARSERS_EXPORT Bond::BondDir RDKit::DetermineBondWedgeState ( const Bond bond,
const INT_MAP_INT wedgeBonds,
const Conformer conf 
)

◆ DiceSimilarity()

template<typename IndexType >
double RDKit::DiceSimilarity ( const SparseIntVect< IndexType > &  v1,
const SparseIntVect< IndexType > &  v2,
bool  returnDistance = false,
double  bounds = 0.0 
)

◆ DifferenceFingerprintChemReaction()

RDKIT_CHEMREACTIONS_EXPORT SparseIntVect<boost::uint32_t>* RDKit::DifferenceFingerprintChemReaction ( const ChemicalReaction rxn,
const ReactionFingerprintParams params = DefaultDifferenceFPParams 
)

Generates a difference fingerprint for a reaction to use in similarity search of reactions

A difference fingerprint is generated as a SparseIntVect to use for similarity search of reactions. By default the fingerprint is generated as 2048 bit hashed fingerprint subtracting AtompairFP of the reactants from the products' AtompairFP and tentatively the agent AtompairFP is added

Parameters
rxnthe reaction to be fingerprinted
paramsspecific settings to manipulate fingerprint generation
Returns
the reaction fingerprint, as an SparseIntVec

Notes:

  • the caller is responsible for deleteing the result

◆ EndianSwapBytes() [1/4]

template<EEndian from, EEndian to, class T >
T RDKit::EndianSwapBytes ( value)
inline

Definition at line 69 of file StreamOps.h.

◆ EndianSwapBytes() [2/4]

template<EEndian from, EEndian to>
char RDKit::EndianSwapBytes ( char  value)
inline

Definition at line 84 of file StreamOps.h.

◆ EndianSwapBytes() [3/4]

template<EEndian from, EEndian to>
unsigned char RDKit::EndianSwapBytes ( unsigned char  value)
inline

Definition at line 88 of file StreamOps.h.

◆ EndianSwapBytes() [4/4]

template<EEndian from, EEndian to>
signed char RDKit::EndianSwapBytes ( signed char  value)
inline

Definition at line 92 of file StreamOps.h.

◆ EnumerateLibraryCanSerialize()

RDKIT_CHEMREACTIONS_EXPORT bool RDKit::EnumerateLibraryCanSerialize ( )

◆ FASTAToMol() [1/4]

RDKIT_FILEPARSERS_EXPORT RWMol* RDKit::FASTAToMol ( const char *  seq,
bool  sanitize,
bool  lowerD 
)
Parameters
seq- the string to be processed
sanitize- toggles sanitization and stereochemistry perception of the molecule
lowerD- if set, lower case letters will be parsed as the d form of the corresponding amino acid

◆ FASTAToMol() [2/4]

RDKIT_FILEPARSERS_EXPORT RWMol* RDKit::FASTAToMol ( const std::string &  seq,
bool  sanitize,
bool  lowerD 
)

This is an overloaded member function, provided for convenience. It differs from the above function only in what argument(s) it accepts.

◆ FASTAToMol() [3/4]

RDKIT_FILEPARSERS_EXPORT RWMol* RDKit::FASTAToMol ( const char *  seq,
bool  sanitize = true,
int  flavor = 0 
)
Parameters
seq- the string to be processed
sanitize- toggles sanitization and stereochemistry perception of the molecule
flavor- 0 Protein, L amino acids (default) 1 Protein, D amino acids 2 RNA, no cap 3 RNA, 5' cap 4 RNA, 3' cap 5 RNA, both caps 6 DNA, no cap 7 DNA, 5' cap 8 DNA, 3' cap 9 DNA, both caps

◆ FASTAToMol() [4/4]

RDKIT_FILEPARSERS_EXPORT RWMol* RDKit::FASTAToMol ( const std::string &  seq,
bool  sanitize = true,
int  flavor = 0 
)

This is an overloaded member function, provided for convenience. It differs from the above function only in what argument(s) it accepts.

◆ feq()

RDKIT_RDGENERAL_EXPORT bool RDKit::feq ( double  v1,
double  v2,
double  tol = 1e-4 
)

floating point comparison with a tolerance

◆ FilterCatalogCanSerialize()

RDKIT_FILTERCATALOG_EXPORT bool RDKit::FilterCatalogCanSerialize ( )

◆ FinalChiralityCheckFunction()

bool RDKit::FinalChiralityCheckFunction ( const short unsigned  c1[],
const short unsigned  c2[],
const ROMol mol1,
const FMCS::Graph query,
const ROMol mol2,
const FMCS::Graph target,
const MCSParameters p 
)

◆ findAllPathsOfLengthN()

RDKIT_SUBGRAPHS_EXPORT PATH_LIST RDKit::findAllPathsOfLengthN ( const ROMol mol,
unsigned int  targetLen,
bool  useBonds = true,
bool  useHs = false,
int  rootedAtAtom = -1 
)

find all paths of a particular size

Parameters
mol- the molecule to be considered
targetLen- the length of the paths to be returned
useBonds- if set, the path indices will be bond indices, not atom indices
useHs- if set, hydrogens in the graph will be considered eligible to be in paths. NOTE: this will not add Hs to the graph.
rootedAtAtom- if non-negative, only subgraphs that start at this atom will be returned.

The result is a list of paths (i.e. list of list of bond indices)

◆ findAllPathsOfLengthsMtoN()

RDKIT_SUBGRAPHS_EXPORT INT_PATH_LIST_MAP RDKit::findAllPathsOfLengthsMtoN ( const ROMol mol,
unsigned int  lowerLen,
unsigned int  upperLen,
bool  useBonds = true,
bool  useHs = false,
int  rootedAtAtom = -1 
)

◆ findAllSubgraphsOfLengthN()

RDKIT_SUBGRAPHS_EXPORT PATH_LIST RDKit::findAllSubgraphsOfLengthN ( const ROMol mol,
unsigned int  targetLen,
bool  useHs = false,
int  rootedAtAtom = -1 
)

find all bond subgraphs of a particular size

Parameters
mol- the molecule to be considered
targetLen- the length of the subgraphs to be returned
useHs- if set, hydrogens in the graph will be considered eligible to be in paths. NOTE: this will not add Hs to the graph.
rootedAtAtom- if non-negative, only subgraphs that start at this atom will be returned.

The result is a list of paths (i.e. list of list of bond indices)

◆ findAllSubgraphsOfLengthsMtoN()

RDKIT_SUBGRAPHS_EXPORT INT_PATH_LIST_MAP RDKit::findAllSubgraphsOfLengthsMtoN ( const ROMol mol,
unsigned int  lowerLen,
unsigned int  upperLen,
bool  useHs = false,
int  rootedAtAtom = -1 
)

find all bond subgraphs in a range of sizes

Parameters
mol- the molecule to be considered
lowerLen- the minimum subgraph size to find
upperLen- the maximum subgraph size to find
useHs- if set, hydrogens in the graph will be considered eligible to be in paths. NOTE: this will not add Hs to the graph.
rootedAtAtom- if non-negative, only subgraphs that start at this atom will be returned.

The result is a map from subgraph size -> list of paths (i.e. list of list of bond indices)

◆ findAtomEnvironmentOfRadiusN()

RDKIT_SUBGRAPHS_EXPORT PATH_TYPE RDKit::findAtomEnvironmentOfRadiusN ( const ROMol mol,
unsigned int  radius,
unsigned int  rootedAtAtom,
bool  useHs = false 
)

find bond subgraphs of a particular radius around an atom

Parameters
mol- the molecule to be considered
radius- the radius of the subgraphs to be considered
rootedAtAtom- the atom to consider
useHs- if set, hydrogens in the graph will be considered eligible to be in paths. NOTE: this will not add Hs to the graph.

The result is a path (a vector of bond indices)

◆ findFuncGroupsOnMol()

RDKIT_FRAGCATALOG_EXPORT MatchVectType RDKit::findFuncGroupsOnMol ( const ROMol mol,
const FragCatParams params,
INT_VECT fgBonds 
)

◆ findMCS() [1/2]

RDKIT_FMCS_EXPORT MCSResult RDKit::findMCS ( const std::vector< ROMOL_SPTR > &  mols,
const MCSParameters params = 0 
)

◆ findMCS() [2/2]

RDKIT_FMCS_EXPORT MCSResult RDKit::findMCS ( const std::vector< ROMOL_SPTR > &  mols,
bool  maximizeBonds,
double  threshold = 1.0,
unsigned  timeout = 3600,
bool  verbose = false,
bool  matchValences = false,
bool  ringMatchesRingOnly = false,
bool  completeRingsOnly = false,
bool  matchChiralTag = false,
AtomComparator  atomComp = AtomCompareElements,
BondComparator  bondComp = BondCompareOrder 
)

◆ findMCS_P()

RDKIT_FMCS_EXPORT MCSResult RDKit::findMCS_P ( const std::vector< ROMOL_SPTR > &  mols,
const char *  params_json 
)

◆ findUniqueSubgraphsOfLengthN()

RDKIT_SUBGRAPHS_EXPORT PATH_LIST RDKit::findUniqueSubgraphsOfLengthN ( const ROMol mol,
unsigned int  targetLen,
bool  useHs = false,
bool  useBO = true,
int  rootedAtAtom = -1 
)

find unique bond subgraphs of a particular size

Parameters
mol- the molecule to be considered
targetLen- the length of the subgraphs to be returned
useHs- if set, hydrogens in the graph will be considered eligible to be in paths. NOTE: this will not add Hs to the graph.
useBO- if set, bond orders will be considered when uniquifying the paths
rootedAtAtom- if non-negative, only subgraphs that start at this atom will be returned.

The result is a list of paths (i.e. list of list of bond indices)

◆ from_rdany() [1/2]

template<class T >
boost::enable_if<boost::is_arithmetic<T>, T>::type RDKit::from_rdany ( const RDAny arg)

◆ from_rdany() [2/2]

template<class T >
boost::disable_if<boost::is_arithmetic<T>, T>::type RDKit::from_rdany ( const RDAny arg)

Definition at line 214 of file RDAny.h.

References rdany_cast().

◆ from_rdvalue() [1/2]

template<class T >
boost::enable_if<boost::is_arithmetic<T>, T>::type RDKit::from_rdvalue ( RDValue_cast_t  arg)

Definition at line 230 of file RDValue.h.

References RDKit::RDValue::getTag(), rdvalue_cast(), and RDKit::RDTypeTag::StringTag.

◆ from_rdvalue() [2/2]

template<class T >
boost::disable_if<boost::is_arithmetic<T>, T>::type RDKit::from_rdvalue ( RDValue_cast_t  arg)

Definition at line 251 of file RDValue.h.

References rdvalue_cast().

◆ getAtomAlias()

RDKIT_GRAPHMOL_EXPORT std::string RDKit::getAtomAlias ( const Atom atom)

◆ getAtomRLabel()

RDKIT_GRAPHMOL_EXPORT int RDKit::getAtomRLabel ( const Atom atm)

◆ getAtomTypeAtomicNum()

static int RDKit::getAtomTypeAtomicNum ( int  val)
inlinestatic

Definition at line 136 of file QueryOps.h.

◆ getAtomTypeIsAromatic()

static bool RDKit::getAtomTypeIsAromatic ( int  val)
inlinestatic

Definition at line 132 of file QueryOps.h.

◆ getAtomValue()

RDKIT_GRAPHMOL_EXPORT std::string RDKit::getAtomValue ( const Atom atom)

◆ getCountFP()

RDKIT_FINGERPRINTS_EXPORT SparseIntVect<std::uint32_t>* RDKit::getCountFP ( const ROMol mol,
FPType  fPType 
)

◆ getCountFPBulk()

RDKIT_FINGERPRINTS_EXPORT std::vector<SparseIntVect<std::uint32_t> *>* RDKit::getCountFPBulk ( const std::vector< const ROMol *>  molVector,
FPType  fPType 
)

◆ getDiscreteDistMat()

DiscreteDistMat* RDKit::getDiscreteDistMat ( )

◆ getDoubleRandomSource()

RDKIT_RDGENERAL_EXPORT double_source_type& RDKit::getDoubleRandomSource ( )

return a reference to the global (Boost) random source

◆ getEndIterator()

RDKIT_CHEMREACTIONS_EXPORT MOL_SPTR_VECT::const_iterator RDKit::getEndIterator ( const ChemicalReaction rxn,
ReactionMoleculeType  t 
)

◆ GetFilterData()

const FilterData_t* RDKit::GetFilterData ( FilterCatalogParams::FilterCatalogs  catalog)

◆ GetFilterProperties()

const FilterProperty_t* RDKit::GetFilterProperties ( FilterCatalogParams::FilterCatalogs  catalog)

◆ GetFlattenedFunctionalGroupHierarchy()

RDKIT_FILTERCATALOG_EXPORT const std::map<std::string, ROMOL_SPTR>& RDKit::GetFlattenedFunctionalGroupHierarchy ( bool  normalized = false)

Return the flattened functional group hierarchy as a string->ROMOL_SPTR map The label is the name of the functional group in the hiearchy e.g. Halogen.Bromine.Aliphatic

◆ getFP()

◆ getFPBulk()

RDKIT_FINGERPRINTS_EXPORT std::vector<ExplicitBitVect *>* RDKit::getFPBulk ( const std::vector< const ROMol *>  molVector,
FPType  fPType 
)

◆ GetFunctionalGroupHierarchy()

RDKIT_FILTERCATALOG_EXPORT const FilterCatalog& RDKit::GetFunctionalGroupHierarchy ( )

Return the functional group hierarchy as a FilterCatalog.

◆ getLine() [1/2]

std::string RDKit::getLine ( std::istream *  inStream)
inline

grabs the next line from an instream and returns it.

Definition at line 288 of file StreamOps.h.

Referenced by getLine().

◆ getLine() [2/2]

std::string RDKit::getLine ( std::istream &  inStream)
inline

grabs the next line from an instream and returns it.

Definition at line 297 of file StreamOps.h.

References getLine().

◆ GetNumEntries()

unsigned int RDKit::GetNumEntries ( FilterCatalogParams::FilterCatalogs  catalog)

◆ GetNumPropertyEntries()

unsigned int RDKit::GetNumPropertyEntries ( FilterCatalogParams::FilterCatalogs  catalog)

◆ getNumThreadsToUse()

unsigned int RDKit::getNumThreadsToUse ( int  target)
inline

◆ getRandomGenerator()

RDKIT_RDGENERAL_EXPORT rng_type& RDKit::getRandomGenerator ( int  seed = -1)

Optionally seed and return a reference to the global (Boost) random.

◆ getRandomVal()

RDKIT_RDGENERAL_EXPORT double RDKit::getRandomVal ( int  seed = -1)

Return a random double value between 0.0 and 1.0 Optionally seed the random number generator

◆ getReactantsFromRGroups()

RDKIT_CHEMREACTIONS_EXPORT MOL_SPTR_VECT RDKit::getReactantsFromRGroups ( const std::vector< MOL_SPTR_VECT > &  bbs,
const EnumerationTypes::RGROUPS rgroups 
)

getReactantsFromRGroups Helper function for enumeration, bbs are stored in a std::vector< std::vector<boost:shared_ptr<ROMol> >

Referenced by getSizesFromBBs().

◆ getReactingAtoms()

RDKIT_CHEMREACTIONS_EXPORT VECT_INT_VECT RDKit::getReactingAtoms ( const ChemicalReaction rxn,
bool  mappedAtomsOnly = false 
)

returns indices of the atoms in each reactant that are changed in the reaction

Parameters
rxnthe reaction we are interested in
mappedAtomsOnlyif set, atoms that are not mapped will not be included in the list of changed atoms (otherwise they are automatically included)

How are changed atoms recognized? 1) Atoms whose degree changes 2) Atoms whose bonding pattern changes 3) unmapped atoms (unless the mappedAtomsOnly flag is set) 4) Atoms connected to unmapped atoms 5) Atoms whose atomic number changes (unless the corresponding product atom is a dummy) 6) Atoms with more than one atomic number query (unless the corresponding product atom is a dummy)

Note that the atomic number of a query atom depends on how it's constructed. When coming from SMARTS: if the first query is an atomic label/number that sets the atomic number, otherwise it's zero. For example [O;] is atomic number 8 while [;O] is atomic number 0. When coming from RXN: the atomic number of the atom in the rxn file sets the value.

Referenced by RDKit::ChemicalReaction::setImplicitPropertiesFlag().

◆ getSizesFromBBs()

template<class T >
EnumerationTypes::RGROUPS RDKit::getSizesFromBBs ( const std::vector< std::vector< T > > &  bbs)

Return the number of elements per input vector.

Parameters
bbsvector<vector<T> >
Returns
vector<unint64_t> number of elements in each vector

Definition at line 73 of file EnumerationStrategyBase.h.

References computeNumProducts(), getReactantsFromRGroups(), getSizesFromReactants(), and RDKIT_CHEMREACTIONS_EXPORT.

Referenced by RDKit::EnumerationStrategyBase::initialize().

◆ getSizesFromReactants()

RDKIT_CHEMREACTIONS_EXPORT EnumerationTypes::RGROUPS RDKit::getSizesFromReactants ( const std::vector< MOL_SPTR_VECT > &  bbs)

getSizesFromReactants Helper function for enumeration, bbs are stored in a std::vector< std::vector<boost:shared_ptr<ROMol> >

Referenced by getSizesFromBBs().

◆ getSparseCountFP()

RDKIT_FINGERPRINTS_EXPORT SparseIntVect<std::uint64_t>* RDKit::getSparseCountFP ( const ROMol mol,
FPType  fPType 
)

◆ getSparseCountFPBulk()

RDKIT_FINGERPRINTS_EXPORT std::vector<SparseIntVect<std::uint64_t> *>* RDKit::getSparseCountFPBulk ( const std::vector< const ROMol *>  molVector,
FPType  fPType 
)

◆ getSparseFP()

◆ getSparseFPBulk()

RDKIT_FINGERPRINTS_EXPORT std::vector<SparseBitVect *>* RDKit::getSparseFPBulk ( const std::vector< const ROMol *>  molVector,
FPType  fPType 
)

◆ getStartIterator()

RDKIT_CHEMREACTIONS_EXPORT MOL_SPTR_VECT::const_iterator RDKit::getStartIterator ( const ChemicalReaction rxn,
ReactionMoleculeType  t 
)

◆ getSupplementalSmilesLabel()

RDKIT_GRAPHMOL_EXPORT std::string RDKit::getSupplementalSmilesLabel ( const Atom atom)

◆ getUnfoldedRDKFingerprintMol()

RDKIT_FINGERPRINTS_EXPORT SparseIntVect<boost::uint64_t>* RDKit::getUnfoldedRDKFingerprintMol ( const ROMol mol,
unsigned int  minPath = 1,
unsigned int  maxPath = 7,
bool  useHs = true,
bool  branchedPaths = true,
bool  useBondOrder = true,
std::vector< boost::uint32_t > *  atomInvariants = 0,
const std::vector< boost::uint32_t > *  fromAtoms = 0,
std::vector< std::vector< boost::uint64_t > > *  atomBits = 0,
std::map< boost::uint64_t, std::vector< std::vector< int > > > *  bitInfo = 0 
)

◆ hanoi()

template<typename CompareFunc >
bool RDKit::hanoi ( int *  base,
int  nel,
int *  temp,
int *  count,
int *  changed,
CompareFunc  compar 
)

changed ||

changed ||

Definition at line 27 of file hanoiSort.h.

Referenced by hanoisort().

◆ hanoisort()

template<typename CompareFunc >
void RDKit::hanoisort ( int *  base,
int  nel,
int *  count,
int *  changed,
CompareFunc  compar 
)

Definition at line 141 of file hanoiSort.h.

References hanoi().

Referenced by RDKit::Canon::RefinePartitions().

◆ hasAgentTemplateSubstructMatch()

RDKIT_CHEMREACTIONS_EXPORT bool RDKit::hasAgentTemplateSubstructMatch ( const ChemicalReaction rxn,
const ChemicalReaction query_rxn 
)

◆ hasNonZeroZCoords()

bool RDKit::hasNonZeroZCoords ( const Conformer conf)
inline

Returns true if any of the z coords are non zero, false otherwise.

Parameters
confConformer object to analyze

Definition at line 142 of file Conformer.h.

References RDKit::Conformer::getPositions().

◆ hasProductTemplateSubstructMatch()

RDKIT_CHEMREACTIONS_EXPORT bool RDKit::hasProductTemplateSubstructMatch ( const ChemicalReaction rxn,
const ChemicalReaction query_rxn 
)

◆ hasReactantTemplateSubstructMatch()

RDKIT_CHEMREACTIONS_EXPORT bool RDKit::hasReactantTemplateSubstructMatch ( const ChemicalReaction rxn,
const ChemicalReaction query_rxn 
)

◆ hasReactionAtomMapping()

RDKIT_CHEMREACTIONS_EXPORT bool RDKit::hasReactionAtomMapping ( const ChemicalReaction rxn)

◆ hasReactionSubstructMatch()

RDKIT_CHEMREACTIONS_EXPORT bool RDKit::hasReactionSubstructMatch ( const ChemicalReaction rxn,
const ChemicalReaction query_rxn,
bool  includeAgents = false 
)

◆ HELMToMol() [1/2]

RDKIT_FILEPARSERS_EXPORT RWMol* RDKit::HELMToMol ( const char *  helm,
bool  sanitize = true 
)
Parameters
seq- the string to be processed
sanitize- toggles sanitization and stereochemistry perception of the molecule

◆ HELMToMol() [2/2]

RDKIT_FILEPARSERS_EXPORT RWMol* RDKit::HELMToMol ( const std::string &  helm,
bool  sanitize = true 
)

This is an overloaded member function, provided for convenience. It differs from the above function only in what argument(s) it accepts.

◆ Intersect()

RDKIT_RDGENERAL_EXPORT void RDKit::Intersect ( const INT_VECT r1,
const INT_VECT r2,
INT_VECT res 
)

calculate the intersection of two INT_VECTs and put the results in a third vector

Referenced by RDKit::charptr_functor::operator()().

◆ isAtomAromatic()

RDKIT_GRAPHMOL_EXPORT bool RDKit::isAtomAromatic ( const Atom a)

Referenced by makePropQuery().

◆ IsBlacklistedPair()

RDKIT_FILEPARSERS_EXPORT bool RDKit::IsBlacklistedPair ( Atom beg_atom,
Atom end_atom 
)

◆ isComplexQuery() [1/2]

RDKIT_GRAPHMOL_EXPORT bool RDKit::isComplexQuery ( const Bond b)

Referenced by makePropQuery().

◆ isComplexQuery() [2/2]

RDKIT_GRAPHMOL_EXPORT bool RDKit::isComplexQuery ( const Atom a)

◆ isMoleculeAgentOfReaction() [1/2]

RDKIT_CHEMREACTIONS_EXPORT bool RDKit::isMoleculeAgentOfReaction ( const ChemicalReaction rxn,
const ROMol mol,
unsigned int &  which 
)

tests whether or not the molecule has a substructure match to any of the reaction's agents the which argument is used to return which of the agents the molecule matches. If there's no match, it is equal to the number of agents on return

Referenced by RDKit::ChemicalReaction::setImplicitPropertiesFlag().

◆ isMoleculeAgentOfReaction() [2/2]

RDKIT_CHEMREACTIONS_EXPORT bool RDKit::isMoleculeAgentOfReaction ( const ChemicalReaction rxn,
const ROMol mol 
)

This is an overloaded member function, provided for convenience. It differs from the above function only in what argument(s) it accepts.

◆ isMoleculeProductOfReaction() [1/2]

RDKIT_CHEMREACTIONS_EXPORT bool RDKit::isMoleculeProductOfReaction ( const ChemicalReaction rxn,
const ROMol mol,
unsigned int &  which 
)

tests whether or not the molecule has a substructure match to any of the reaction's products the which argument is used to return which of the products the molecule matches. If there's no match, it is equal to the number of products on return

Referenced by RDKit::ChemicalReaction::setImplicitPropertiesFlag().

◆ isMoleculeProductOfReaction() [2/2]

RDKIT_CHEMREACTIONS_EXPORT bool RDKit::isMoleculeProductOfReaction ( const ChemicalReaction rxn,
const ROMol mol 
)

This is an overloaded member function, provided for convenience. It differs from the above function only in what argument(s) it accepts.

◆ isMoleculeReactantOfReaction() [1/2]

RDKIT_CHEMREACTIONS_EXPORT bool RDKit::isMoleculeReactantOfReaction ( const ChemicalReaction rxn,
const ROMol mol,
unsigned int &  which 
)

tests whether or not the molecule has a substructure match to any of the reaction's reactants the which argument is used to return which of the reactants the molecule matches. If there's no match, it is equal to the number of reactants on return

Referenced by RDKit::ChemicalReaction::setImplicitPropertiesFlag().

◆ isMoleculeReactantOfReaction() [2/2]

RDKIT_CHEMREACTIONS_EXPORT bool RDKit::isMoleculeReactantOfReaction ( const ChemicalReaction rxn,
const ROMol mol 
)

This is an overloaded member function, provided for convenience. It differs from the above function only in what argument(s) it accepts.

◆ isReactionTemplateMoleculeAgent()

RDKIT_CHEMREACTIONS_EXPORT bool RDKit::isReactionTemplateMoleculeAgent ( const ROMol mol,
double  agentThreshold 
)

◆ isSerializable()

◆ LayeredFingerprintMol()

RDKIT_FINGERPRINTS_EXPORT ExplicitBitVect* RDKit::LayeredFingerprintMol ( const ROMol mol,
unsigned int  layerFlags = 0xFFFFFFFF,
unsigned int  minPath = 1,
unsigned int  maxPath = 7,
unsigned int  fpSize = 2048,
std::vector< unsigned int > *  atomCounts = 0,
ExplicitBitVect setOnlyBits = 0,
bool  branchedPaths = true,
const std::vector< boost::uint32_t > *  fromAtoms = 0 
)

Generates a topological (Daylight like) fingerprint for a molecule using a layer-based hashing algorithm.

Experimental: This function is experimental. The API or results may change from release to release.

Parameters
molthe molecule to be fingerprinted
layerFlagsthe layers to be included (see below)
minPaththe minimum path length (in bonds) to be included
maxPaththe minimum path length (in bonds) to be included
fpSizethe size of the fingerprint
atomCountsif provided, this will be used to provide the count of the number of paths that set bits each atom is involved in. The vector should have at least as many entries as the molecule has atoms and is not zeroed out here.
setOnlyBitsif provided, only bits that are set in this bit vector will be set in the result. This is essentially the same as doing: (*res) &= (*setOnlyBits); but also has an impact on the atomCounts (if being used)
branchedPathstoggles generation of branched subgraphs, not just linear paths
Returns
the molecular fingerprint, as an ExplicitBitVect

Notes:

  • the caller is responsible for deleteing the result

Layer definitions:

  • 0x01: pure topology
  • 0x02: bond order
  • 0x04: atom types
  • 0x08: presence of rings
  • 0x10: ring sizes
  • 0x20: aromaticity

◆ makeAAtomQuery()

RDKIT_GRAPHMOL_EXPORT ATOM_EQUALS_QUERY* RDKit::makeAAtomQuery ( )

returns a Query for matching generic A atoms (heavy atoms)

Referenced by makeAtomRingBondCountQuery().

◆ makeAHAtomQuery()

RDKIT_GRAPHMOL_EXPORT ATOM_EQUALS_QUERY* RDKit::makeAHAtomQuery ( )

returns a Query for matching generic AH atoms (any atom)

Referenced by makeAtomRingBondCountQuery().

◆ makeAtomAliphaticQuery() [1/2]

template<class T >
T* RDKit::makeAtomAliphaticQuery ( const std::string &  descr)

returns a Query for matching aliphatic atoms

Definition at line 431 of file QueryOps.h.

References queryAtomAliphatic(), and RDKIT_GRAPHMOL_EXPORT.

◆ makeAtomAliphaticQuery() [2/2]

RDKIT_GRAPHMOL_EXPORT ATOM_EQUALS_QUERY* RDKit::makeAtomAliphaticQuery ( )

This is an overloaded member function, provided for convenience. It differs from the above function only in what argument(s) it accepts.

◆ makeAtomAromaticQuery() [1/2]

template<class T >
T* RDKit::makeAtomAromaticQuery ( const std::string &  descr)

returns a Query for matching the isAromatic flag

Definition at line 423 of file QueryOps.h.

References queryAtomAromatic(), and RDKIT_GRAPHMOL_EXPORT.

◆ makeAtomAromaticQuery() [2/2]

RDKIT_GRAPHMOL_EXPORT ATOM_EQUALS_QUERY* RDKit::makeAtomAromaticQuery ( )

This is an overloaded member function, provided for convenience. It differs from the above function only in what argument(s) it accepts.

◆ makeAtomExplicitDegreeQuery() [1/2]

template<class T >
T* RDKit::makeAtomExplicitDegreeQuery ( int  what,
const std::string &  descr 
)

returns a Query for matching explicit degree

Definition at line 375 of file QueryOps.h.

References queryAtomExplicitDegree(), and RDKIT_GRAPHMOL_EXPORT.

◆ makeAtomExplicitDegreeQuery() [2/2]

RDKIT_GRAPHMOL_EXPORT ATOM_EQUALS_QUERY* RDKit::makeAtomExplicitDegreeQuery ( int  what)

This is an overloaded member function, provided for convenience. It differs from the above function only in what argument(s) it accepts.

◆ makeAtomExplicitValenceQuery() [1/2]

template<class T >
T* RDKit::makeAtomExplicitValenceQuery ( int  what,
const std::string &  descr 
)

returns a Query for matching explicit valence

Definition at line 359 of file QueryOps.h.

References queryAtomExplicitValence(), and RDKIT_GRAPHMOL_EXPORT.

◆ makeAtomExplicitValenceQuery() [2/2]

RDKIT_GRAPHMOL_EXPORT ATOM_EQUALS_QUERY* RDKit::makeAtomExplicitValenceQuery ( int  what)

This is an overloaded member function, provided for convenience. It differs from the above function only in what argument(s) it accepts.

◆ makeAtomFormalChargeQuery() [1/2]

template<class T >
T* RDKit::makeAtomFormalChargeQuery ( int  what,
const std::string &  descr 
)

returns a Query for matching formal charge

Definition at line 456 of file QueryOps.h.

References queryAtomFormalCharge(), and RDKIT_GRAPHMOL_EXPORT.

◆ makeAtomFormalChargeQuery() [2/2]

RDKIT_GRAPHMOL_EXPORT ATOM_EQUALS_QUERY* RDKit::makeAtomFormalChargeQuery ( int  what)

This is an overloaded member function, provided for convenience. It differs from the above function only in what argument(s) it accepts.

◆ makeAtomHasAliphaticHeteroatomNbrsQuery() [1/2]

template<class T >
T* RDKit::makeAtomHasAliphaticHeteroatomNbrsQuery ( const std::string &  descr)

◆ makeAtomHasAliphaticHeteroatomNbrsQuery() [2/2]

RDKIT_GRAPHMOL_EXPORT ATOM_EQUALS_QUERY* RDKit::makeAtomHasAliphaticHeteroatomNbrsQuery ( )

This is an overloaded member function, provided for convenience. It differs from the above function only in what argument(s) it accepts.

◆ makeAtomHasChiralTagQuery() [1/2]

template<class T >
T* RDKit::makeAtomHasChiralTagQuery ( const std::string &  descr)

returns a Query for matching whether or not chirality has been set on the atom

Definition at line 482 of file QueryOps.h.

References queryAtomHasChiralTag(), and RDKIT_GRAPHMOL_EXPORT.

◆ makeAtomHasChiralTagQuery() [2/2]

RDKIT_GRAPHMOL_EXPORT ATOM_EQUALS_QUERY* RDKit::makeAtomHasChiralTagQuery ( )

◆ makeAtomHasHeteroatomNbrsQuery() [1/2]

template<class T >
T* RDKit::makeAtomHasHeteroatomNbrsQuery ( const std::string &  descr)

returns a Query for matching atoms that have heteroatom neighbors

Definition at line 576 of file QueryOps.h.

References queryAtomHasHeteroatomNbrs(), and RDKIT_GRAPHMOL_EXPORT.

◆ makeAtomHasHeteroatomNbrsQuery() [2/2]

RDKIT_GRAPHMOL_EXPORT ATOM_EQUALS_QUERY* RDKit::makeAtomHasHeteroatomNbrsQuery ( )

This is an overloaded member function, provided for convenience. It differs from the above function only in what argument(s) it accepts.

◆ makeAtomHasImplicitHQuery() [1/2]

template<class T >
T* RDKit::makeAtomHasImplicitHQuery ( const std::string &  descr)

returns a Query for matching ring atoms

Definition at line 407 of file QueryOps.h.

References queryAtomHasImplicitH(), and RDKIT_GRAPHMOL_EXPORT.

◆ makeAtomHasImplicitHQuery() [2/2]

RDKIT_GRAPHMOL_EXPORT ATOM_EQUALS_QUERY* RDKit::makeAtomHasImplicitHQuery ( )

This is an overloaded member function, provided for convenience. It differs from the above function only in what argument(s) it accepts.

◆ makeAtomHasRingBondQuery() [1/2]

template<class T >
T* RDKit::makeAtomHasRingBondQuery ( const std::string &  descr)

returns a Query for matching atoms that have ring bonds

Definition at line 559 of file QueryOps.h.

References queryAtomHasRingBond(), and RDKIT_GRAPHMOL_EXPORT.

◆ makeAtomHasRingBondQuery() [2/2]

RDKIT_GRAPHMOL_EXPORT ATOM_EQUALS_QUERY* RDKit::makeAtomHasRingBondQuery ( )

This is an overloaded member function, provided for convenience. It differs from the above function only in what argument(s) it accepts.

◆ makeAtomHCountQuery() [1/2]

template<class T >
T* RDKit::makeAtomHCountQuery ( int  what,
const std::string &  descr 
)

returns a Query for matching hydrogen count

Definition at line 399 of file QueryOps.h.

References queryAtomHCount(), and RDKIT_GRAPHMOL_EXPORT.

◆ makeAtomHCountQuery() [2/2]

RDKIT_GRAPHMOL_EXPORT ATOM_EQUALS_QUERY* RDKit::makeAtomHCountQuery ( int  what)

This is an overloaded member function, provided for convenience. It differs from the above function only in what argument(s) it accepts.

◆ makeAtomHeavyAtomDegreeQuery() [1/2]

template<class T >
T* RDKit::makeAtomHeavyAtomDegreeQuery ( int  what,
const std::string &  descr 
)

returns a Query for matching heavy atom degree

Definition at line 391 of file QueryOps.h.

References queryAtomHeavyAtomDegree(), and RDKIT_GRAPHMOL_EXPORT.

◆ makeAtomHeavyAtomDegreeQuery() [2/2]

RDKIT_GRAPHMOL_EXPORT ATOM_EQUALS_QUERY* RDKit::makeAtomHeavyAtomDegreeQuery ( int  what)

This is an overloaded member function, provided for convenience. It differs from the above function only in what argument(s) it accepts.

◆ makeAtomHybridizationQuery() [1/2]

template<class T >
T* RDKit::makeAtomHybridizationQuery ( int  what,
const std::string &  descr 
)

returns a Query for matching hybridization

Definition at line 464 of file QueryOps.h.

References queryAtomHybridization(), and RDKIT_GRAPHMOL_EXPORT.

◆ makeAtomHybridizationQuery() [2/2]

RDKIT_GRAPHMOL_EXPORT ATOM_EQUALS_QUERY* RDKit::makeAtomHybridizationQuery ( int  what)

This is an overloaded member function, provided for convenience. It differs from the above function only in what argument(s) it accepts.

◆ makeAtomImplicitHCountQuery() [1/2]

template<class T >
T* RDKit::makeAtomImplicitHCountQuery ( int  what,
const std::string &  descr 
)

returns a Query for matching implicit hydrogen count

Definition at line 415 of file QueryOps.h.

References queryAtomImplicitHCount(), and RDKIT_GRAPHMOL_EXPORT.

◆ makeAtomImplicitHCountQuery() [2/2]

RDKIT_GRAPHMOL_EXPORT ATOM_EQUALS_QUERY* RDKit::makeAtomImplicitHCountQuery ( int  what)

This is an overloaded member function, provided for convenience. It differs from the above function only in what argument(s) it accepts.

◆ makeAtomImplicitValenceQuery() [1/2]

template<class T >
T* RDKit::makeAtomImplicitValenceQuery ( int  what,
const std::string &  descr 
)

returns a Query for matching implicit valence

Definition at line 351 of file QueryOps.h.

References queryAtomImplicitValence(), and RDKIT_GRAPHMOL_EXPORT.

◆ makeAtomImplicitValenceQuery() [2/2]

RDKIT_GRAPHMOL_EXPORT ATOM_EQUALS_QUERY* RDKit::makeAtomImplicitValenceQuery ( int  what)

This is an overloaded member function, provided for convenience. It differs from the above function only in what argument(s) it accepts.

◆ makeAtomInNRingsQuery() [1/2]

template<class T >
T* RDKit::makeAtomInNRingsQuery ( int  what,
const std::string &  descr 
)

returns a Query for matching atoms in a particular number of rings

This is an overloaded member function, provided for convenience. It differs from the above function only in what argument(s) it accepts.

Definition at line 515 of file QueryOps.h.

References makeAtomInRingOfSizeQuery(), queryIsAtomInNRings(), and RDKIT_GRAPHMOL_EXPORT.

◆ makeAtomInNRingsQuery() [2/2]

RDKIT_GRAPHMOL_EXPORT ATOM_EQUALS_QUERY* RDKit::makeAtomInNRingsQuery ( int  what)

This is an overloaded member function, provided for convenience. It differs from the above function only in what argument(s) it accepts.

◆ makeAtomInRingOfSizeQuery()

RDKIT_GRAPHMOL_EXPORT ATOM_EQUALS_QUERY* RDKit::makeAtomInRingOfSizeQuery ( int  tgt)

returns a Query for matching atoms in rings of a particular size

Referenced by makeAtomInNRingsQuery().

◆ makeAtomInRingQuery() [1/2]

template<class T >
T* RDKit::makeAtomInRingQuery ( const std::string &  descr)

returns a Query for matching ring atoms

Definition at line 507 of file QueryOps.h.

References queryIsAtomInRing(), and RDKIT_GRAPHMOL_EXPORT.

◆ makeAtomInRingQuery() [2/2]

RDKIT_GRAPHMOL_EXPORT ATOM_EQUALS_QUERY* RDKit::makeAtomInRingQuery ( )

◆ makeAtomIsotopeQuery() [1/2]

template<class T >
T* RDKit::makeAtomIsotopeQuery ( int  what,
const std::string &  descr 
)

returns a Query for matching atoms with a particular isotope

Definition at line 448 of file QueryOps.h.

References queryAtomIsotope(), and RDKIT_GRAPHMOL_EXPORT.

◆ makeAtomIsotopeQuery() [2/2]

RDKIT_GRAPHMOL_EXPORT ATOM_EQUALS_QUERY* RDKit::makeAtomIsotopeQuery ( int  what)

This is an overloaded member function, provided for convenience. It differs from the above function only in what argument(s) it accepts.

◆ makeAtomMassQuery() [1/2]

template<class T >
T* RDKit::makeAtomMassQuery ( int  what,
const std::string &  descr 
)

returns a Query for matching atoms with a particular mass

Definition at line 439 of file QueryOps.h.

References queryAtomMass(), and RDKIT_GRAPHMOL_EXPORT.

◆ makeAtomMassQuery() [2/2]

RDKIT_GRAPHMOL_EXPORT ATOM_EQUALS_QUERY* RDKit::makeAtomMassQuery ( int  what)

This is an overloaded member function, provided for convenience. It differs from the above function only in what argument(s) it accepts.

◆ makeAtomMinRingSizeQuery() [1/2]

template<class T >
T* RDKit::makeAtomMinRingSizeQuery ( int  tgt,
const std::string &  descr 
)

returns a Query for matching an atom's minimum ring size

Definition at line 526 of file QueryOps.h.

References queryAtomMinRingSize(), and RDKIT_GRAPHMOL_EXPORT.

◆ makeAtomMinRingSizeQuery() [2/2]

RDKIT_GRAPHMOL_EXPORT ATOM_EQUALS_QUERY* RDKit::makeAtomMinRingSizeQuery ( int  tgt)

This is an overloaded member function, provided for convenience. It differs from the above function only in what argument(s) it accepts.

◆ makeAtomMissingChiralTagQuery() [1/2]

template<class T >
T* RDKit::makeAtomMissingChiralTagQuery ( const std::string &  descr)

returns a Query for matching whether or not a potentially chiral atom is missing a chiral tag

Definition at line 491 of file QueryOps.h.

References queryAtomMissingChiralTag(), and RDKIT_GRAPHMOL_EXPORT.

◆ makeAtomMissingChiralTagQuery() [2/2]

RDKIT_GRAPHMOL_EXPORT ATOM_EQUALS_QUERY* RDKit::makeAtomMissingChiralTagQuery ( )

◆ makeAtomNullQuery()

RDKIT_GRAPHMOL_EXPORT ATOM_NULL_QUERY* RDKit::makeAtomNullQuery ( )

returns a Query for matching any atom

Referenced by makeAtomHasAliphaticHeteroatomNbrsQuery().

◆ makeAtomNumAliphaticHeteroatomNbrsQuery() [1/2]

template<class T >
T* RDKit::makeAtomNumAliphaticHeteroatomNbrsQuery ( int  what,
const std::string &  descr 
)

returns a Query for matching the number of aliphatic heteroatom neighbors

Definition at line 584 of file QueryOps.h.

References queryAtomNumAliphaticHeteroatomNbrs(), and RDKIT_GRAPHMOL_EXPORT.

◆ makeAtomNumAliphaticHeteroatomNbrsQuery() [2/2]

RDKIT_GRAPHMOL_EXPORT ATOM_EQUALS_QUERY* RDKit::makeAtomNumAliphaticHeteroatomNbrsQuery ( int  what)

This is an overloaded member function, provided for convenience. It differs from the above function only in what argument(s) it accepts.

◆ makeAtomNumHeteroatomNbrsQuery() [1/2]

template<class T >
T* RDKit::makeAtomNumHeteroatomNbrsQuery ( int  what,
const std::string &  descr 
)

returns a Query for matching the number of heteroatom neighbors

Definition at line 567 of file QueryOps.h.

References queryAtomNumHeteroatomNbrs(), and RDKIT_GRAPHMOL_EXPORT.

◆ makeAtomNumHeteroatomNbrsQuery() [2/2]

RDKIT_GRAPHMOL_EXPORT ATOM_EQUALS_QUERY* RDKit::makeAtomNumHeteroatomNbrsQuery ( int  what)

This is an overloaded member function, provided for convenience. It differs from the above function only in what argument(s) it accepts.

◆ makeAtomNumQuery() [1/2]

template<class T >
T* RDKit::makeAtomNumQuery ( int  what,
const std::string &  descr 
)

returns a Query for matching atomic number

Definition at line 333 of file QueryOps.h.

References queryAtomNum(), and RDKIT_GRAPHMOL_EXPORT.

◆ makeAtomNumQuery() [2/2]

RDKIT_GRAPHMOL_EXPORT ATOM_EQUALS_QUERY* RDKit::makeAtomNumQuery ( int  what)

This is an overloaded member function, provided for convenience. It differs from the above function only in what argument(s) it accepts.

◆ makeAtomNumRadicalElectronsQuery() [1/2]

template<class T >
T* RDKit::makeAtomNumRadicalElectronsQuery ( int  what,
const std::string &  descr 
)

returns a Query for matching the number of radical electrons

Definition at line 472 of file QueryOps.h.

References queryAtomNumRadicalElectrons(), and RDKIT_GRAPHMOL_EXPORT.

◆ makeAtomNumRadicalElectronsQuery() [2/2]

RDKIT_GRAPHMOL_EXPORT ATOM_EQUALS_QUERY* RDKit::makeAtomNumRadicalElectronsQuery ( int  what)

This is an overloaded member function, provided for convenience. It differs from the above function only in what argument(s) it accepts.

◆ makeAtomRangeQuery()

static ATOM_RANGE_QUERY* RDKit::makeAtomRangeQuery ( int  lower,
int  upper,
bool  lowerOpen,
bool  upperOpen,
int   funcAtom const *,
const std::string &  description = "Atom Range" 
)
inlinestatic

◆ makeAtomRingBondCountQuery() [1/2]

template<class T >
T* RDKit::makeAtomRingBondCountQuery ( int  what,
const std::string &  descr 
)

returns a Query for matching atoms with a particular number of ring bonds

Definition at line 534 of file QueryOps.h.

References makeAAtomQuery(), makeAHAtomQuery(), makeMAtomQuery(), makeMHAtomQuery(), makeQAtomQuery(), makeQHAtomQuery(), makeXAtomQuery(), makeXHAtomQuery(), queryAtomRingBondCount(), and RDKIT_GRAPHMOL_EXPORT.

◆ makeAtomRingBondCountQuery() [2/2]

RDKIT_GRAPHMOL_EXPORT ATOM_EQUALS_QUERY* RDKit::makeAtomRingBondCountQuery ( int  what)

This is an overloaded member function, provided for convenience. It differs from the above function only in what argument(s) it accepts.

◆ makeAtomSimpleQuery()

template<class T >
T* RDKit::makeAtomSimpleQuery ( int  what,
int   funcAtom const *,
const std::string &  description = "Atom Simple" 
)

Definition at line 312 of file QueryOps.h.

◆ makeAtomTotalDegreeQuery() [1/2]

template<class T >
T* RDKit::makeAtomTotalDegreeQuery ( int  what,
const std::string &  descr 
)

returns a Query for matching atomic degree

Definition at line 383 of file QueryOps.h.

References queryAtomTotalDegree(), and RDKIT_GRAPHMOL_EXPORT.

◆ makeAtomTotalDegreeQuery() [2/2]

RDKIT_GRAPHMOL_EXPORT ATOM_EQUALS_QUERY* RDKit::makeAtomTotalDegreeQuery ( int  what)

This is an overloaded member function, provided for convenience. It differs from the above function only in what argument(s) it accepts.

◆ makeAtomTotalValenceQuery() [1/2]

template<class T >
T* RDKit::makeAtomTotalValenceQuery ( int  what,
const std::string &  descr 
)

returns a Query for matching total valence

Definition at line 367 of file QueryOps.h.

References queryAtomTotalValence(), and RDKIT_GRAPHMOL_EXPORT.

◆ makeAtomTotalValenceQuery() [2/2]

RDKIT_GRAPHMOL_EXPORT ATOM_EQUALS_QUERY* RDKit::makeAtomTotalValenceQuery ( int  what)

This is an overloaded member function, provided for convenience. It differs from the above function only in what argument(s) it accepts.

◆ makeAtomType()

static int RDKit::makeAtomType ( int  atomic_num,
bool  aromatic 
)
inlinestatic

Definition at line 120 of file QueryOps.h.

Referenced by makeAtomTypeQuery(), and queryAtomType().

◆ makeAtomTypeQuery() [1/2]

template<class T >
T* RDKit::makeAtomTypeQuery ( int  num,
int  aromatic,
const std::string &  descr 
)

returns a Query for matching atomic number and aromaticity

Definition at line 341 of file QueryOps.h.

References makeAtomType(), queryAtomType(), and RDKIT_GRAPHMOL_EXPORT.

◆ makeAtomTypeQuery() [2/2]

RDKIT_GRAPHMOL_EXPORT ATOM_EQUALS_QUERY* RDKit::makeAtomTypeQuery ( int  num,
int  aromatic 
)

This is an overloaded member function, provided for convenience. It differs from the above function only in what argument(s) it accepts.

◆ makeAtomUnsaturatedQuery() [1/2]

template<class T >
T* RDKit::makeAtomUnsaturatedQuery ( const std::string &  descr)

returns a Query for matching atoms with unsaturation:

Definition at line 499 of file QueryOps.h.

References queryAtomUnsaturated(), and RDKIT_GRAPHMOL_EXPORT.

◆ makeAtomUnsaturatedQuery() [2/2]

RDKIT_GRAPHMOL_EXPORT ATOM_EQUALS_QUERY* RDKit::makeAtomUnsaturatedQuery ( )

This is an overloaded member function, provided for convenience. It differs from the above function only in what argument(s) it accepts.

◆ makeBondDirEqualsQuery()

RDKIT_GRAPHMOL_EXPORT BOND_EQUALS_QUERY* RDKit::makeBondDirEqualsQuery ( Bond::BondDir  what)

returns a Query for matching bond directions

Referenced by makeAtomHasAliphaticHeteroatomNbrsQuery().

◆ makeBondHasStereoQuery()

RDKIT_GRAPHMOL_EXPORT BOND_EQUALS_QUERY* RDKit::makeBondHasStereoQuery ( )

returns a Query for matching bonds with stereo set

Referenced by makeAtomHasAliphaticHeteroatomNbrsQuery().

◆ makeBondInNRingsQuery()

RDKIT_GRAPHMOL_EXPORT BOND_EQUALS_QUERY* RDKit::makeBondInNRingsQuery ( int  tgt)

returns a Query for matching bonds in a particular number of rings

Referenced by makeAtomHasAliphaticHeteroatomNbrsQuery().

◆ makeBondInRingOfSizeQuery()

RDKIT_GRAPHMOL_EXPORT BOND_EQUALS_QUERY* RDKit::makeBondInRingOfSizeQuery ( int  what)

returns a Query for matching bonds in rings of a particular size

Referenced by makeAtomHasAliphaticHeteroatomNbrsQuery().

◆ makeBondIsInRingQuery()

RDKIT_GRAPHMOL_EXPORT BOND_EQUALS_QUERY* RDKit::makeBondIsInRingQuery ( )

returns a Query for matching ring bonds

Referenced by makeAtomHasAliphaticHeteroatomNbrsQuery().

◆ makeBondMinRingSizeQuery()

RDKIT_GRAPHMOL_EXPORT BOND_EQUALS_QUERY* RDKit::makeBondMinRingSizeQuery ( int  what)

returns a Query for matching a bond's minimum ring size

Referenced by makeAtomHasAliphaticHeteroatomNbrsQuery().

◆ makeBondNullQuery()

RDKIT_GRAPHMOL_EXPORT BOND_NULL_QUERY* RDKit::makeBondNullQuery ( )

returns a Query for matching any bond

Referenced by makeAtomHasAliphaticHeteroatomNbrsQuery().

◆ makeBondOrderEqualsQuery()

RDKIT_GRAPHMOL_EXPORT BOND_EQUALS_QUERY* RDKit::makeBondOrderEqualsQuery ( Bond::BondType  what)

returns a Query for matching bond orders

Referenced by makeAtomHasAliphaticHeteroatomNbrsQuery().

◆ MakeFilterCatalogEntry()

FilterCatalogEntry* RDKit::MakeFilterCatalogEntry ( const FilterData_t ,
unsigned int  num_props = 0,
const FilterProperty_t props = 0 
)

◆ makeHasPropQuery()

template<class Target >
Queries::EqualityQuery<int, const Target *, true>* RDKit::makeHasPropQuery ( const std::string &  property)

returns a Query for matching atoms that have a particular property

Definition at line 787 of file QueryOps.h.

◆ makeMAtomQuery()

RDKIT_GRAPHMOL_EXPORT ATOM_OR_QUERY* RDKit::makeMAtomQuery ( )

returns a Query for matching generic M atoms (metals)

Referenced by makeAtomRingBondCountQuery().

◆ makeMHAtomQuery()

RDKIT_GRAPHMOL_EXPORT ATOM_OR_QUERY* RDKit::makeMHAtomQuery ( )

returns a Query for matching generic MH atoms (metals or H)

Referenced by makeAtomRingBondCountQuery().

◆ makePropQuery()

template<class Target , class T >
Queries::EqualityQuery<int, const Target *, true>* RDKit::makePropQuery ( const std::string &  propname,
const T &  val,
const T &  tolerance = T() 
)

Definition at line 926 of file QueryOps.h.

References isAtomAromatic(), isComplexQuery(), and RDKIT_GRAPHMOL_EXPORT.

◆ makeQAtomQuery()

RDKIT_GRAPHMOL_EXPORT ATOM_OR_QUERY* RDKit::makeQAtomQuery ( )

returns a Query for matching generic Q atoms (heteroatoms)

Referenced by makeAtomRingBondCountQuery().

◆ makeQHAtomQuery()

RDKIT_GRAPHMOL_EXPORT ATOM_EQUALS_QUERY* RDKit::makeQHAtomQuery ( )

returns a Query for matching generic QH atoms (heteroatom or H)

Referenced by makeAtomRingBondCountQuery().

◆ makeSingleOrAromaticBondQuery()

RDKIT_GRAPHMOL_EXPORT BOND_EQUALS_QUERY* RDKit::makeSingleOrAromaticBondQuery ( )

returns a Query for unspecified SMARTS bonds

Referenced by makeAtomHasAliphaticHeteroatomNbrsQuery().

◆ makeXAtomQuery()

RDKIT_GRAPHMOL_EXPORT ATOM_OR_QUERY* RDKit::makeXAtomQuery ( )

returns a Query for matching generic X atoms (halogens)

Referenced by makeAtomRingBondCountQuery().

◆ makeXHAtomQuery()

RDKIT_GRAPHMOL_EXPORT ATOM_OR_QUERY* RDKit::makeXHAtomQuery ( )

returns a Query for matching generic XH atoms (halogen or H)

Referenced by makeAtomRingBondCountQuery().

◆ MCSAtomCompareAny()

RDKIT_FMCS_EXPORT bool RDKit::MCSAtomCompareAny ( const MCSAtomCompareParameters p,
const ROMol mol1,
unsigned int  atom1,
const ROMol mol2,
unsigned int  atom2,
void *  userData 
)

◆ MCSAtomCompareElements()

RDKIT_FMCS_EXPORT bool RDKit::MCSAtomCompareElements ( const MCSAtomCompareParameters p,
const ROMol mol1,
unsigned int  atom1,
const ROMol mol2,
unsigned int  atom2,
void *  userData 
)

◆ MCSAtomCompareIsotopes()

RDKIT_FMCS_EXPORT bool RDKit::MCSAtomCompareIsotopes ( const MCSAtomCompareParameters p,
const ROMol mol1,
unsigned int  atom1,
const ROMol mol2,
unsigned int  atom2,
void *  userData 
)

◆ MCSBondCompareAny()

RDKIT_FMCS_EXPORT bool RDKit::MCSBondCompareAny ( const MCSBondCompareParameters p,
const ROMol mol1,
unsigned int  bond1,
const ROMol mol2,
unsigned int  bond2,
void *  userData 
)

◆ MCSBondCompareOrder()

RDKIT_FMCS_EXPORT bool RDKit::MCSBondCompareOrder ( const MCSBondCompareParameters p,
const ROMol mol1,
unsigned int  bond1,
const ROMol mol2,
unsigned int  bond2,
void *  userData 
)

◆ MCSBondCompareOrderExact()

RDKIT_FMCS_EXPORT bool RDKit::MCSBondCompareOrderExact ( const MCSBondCompareParameters p,
const ROMol mol1,
unsigned int  bond1,
const ROMol mol2,
unsigned int  bond2,
void *  userData 
)

◆ MCSProgressCallbackTimeout()

RDKIT_FMCS_EXPORT bool RDKit::MCSProgressCallbackTimeout ( const MCSProgressData stat,
const MCSParameters params,
void *  userData 
)

◆ Mol2BlockToMol()

RDKIT_FILEPARSERS_EXPORT RWMol* RDKit::Mol2BlockToMol ( const std::string &  molBlock,
bool  sanitize = true,
bool  removeHs = true,
Mol2Type  variant = CORINA,
bool  cleanupSubstructures = true 
)
Parameters
molBlock- string containing the mol block
sanitize- toggles sanitization of the molecule
removeHs- toggles removal of Hs from the molecule. H removal is only done if the molecule is sanitized
variant- the atom type definitions to use
cleanupSubstructures- toggles recognition and cleanup of common substructures

◆ Mol2DataStreamToMol() [1/2]

RDKIT_FILEPARSERS_EXPORT RWMol* RDKit::Mol2DataStreamToMol ( std::istream *  inStream,
bool  sanitize = true,
bool  removeHs = true,
Mol2Type  variant = CORINA,
bool  cleanupSubstructures = true 
)
Parameters
inStream- stream containing the data
sanitize- toggles sanitization of the molecule
removeHs- toggles removal of Hs from the molecule. H removal is only done if the molecule is sanitized
variant- the atom type definitions to use
cleanupSubstructures- toggles recognition and cleanup of common substructures

◆ Mol2DataStreamToMol() [2/2]

RDKIT_FILEPARSERS_EXPORT RWMol* RDKit::Mol2DataStreamToMol ( std::istream &  inStream,
bool  sanitize = true,
bool  removeHs = true,
Mol2Type  variant = CORINA,
bool  cleanupSubstructures = true 
)

◆ Mol2FileToMol()

RDKIT_FILEPARSERS_EXPORT RWMol* RDKit::Mol2FileToMol ( const std::string &  fName,
bool  sanitize = true,
bool  removeHs = true,
Mol2Type  variant = CORINA,
bool  cleanupSubstructures = true 
)
Parameters
fName- string containing the file name
sanitize- toggles sanitization of the molecule
removeHs- toggles removal of Hs from the molecule. H removal is only done if the molecule is sanitized
variant- the atom type definitions to use
cleanupSubstructures- toggles recognition and cleanup of common substructures

◆ MolBlockToMol()

RDKIT_FILEPARSERS_EXPORT RWMol* RDKit::MolBlockToMol ( const std::string &  molBlock,
bool  sanitize = true,
bool  removeHs = true,
bool  strictParsing = true 
)
Parameters
molBlock- string containing the mol block
sanitize- toggles sanitization and stereochemistry perception of the molecule
removeHs- toggles removal of Hs from the molecule. H removal is only done if the molecule is sanitized
strictParsing- if set, the parser is more lax about correctness of the contents.

◆ MolDataStreamToMol() [1/2]

RDKIT_FILEPARSERS_EXPORT RWMol* RDKit::MolDataStreamToMol ( std::istream *  inStream,
unsigned int &  line,
bool  sanitize = true,
bool  removeHs = true,
bool  strictParsing = true 
)
Parameters
inStream- stream containing the data
line- current line number (used for error reporting)
sanitize- toggles sanitization and stereochemistry perception of the molecule
removeHs- toggles removal of Hs from the molecule. H removal is only done if the molecule is sanitized
line- current line number (used for error reporting)
strictParsing- if not set, the parser is more lax about correctness of the contents.

◆ MolDataStreamToMol() [2/2]

RDKIT_FILEPARSERS_EXPORT RWMol* RDKit::MolDataStreamToMol ( std::istream &  inStream,
unsigned int &  line,
bool  sanitize = true,
bool  removeHs = true,
bool  strictParsing = true 
)

◆ MolFileToMol()

RDKIT_FILEPARSERS_EXPORT RWMol* RDKit::MolFileToMol ( const std::string &  fName,
bool  sanitize = true,
bool  removeHs = true,
bool  strictParsing = true 
)
Parameters
fName- string containing the file name
sanitize- toggles sanitization and stereochemistry perception of the molecule
removeHs- toggles removal of Hs from the molecule. H removal is only done if the molecule is sanitized
strictParsing- if set, the parser is more lax about correctness of the contents.

◆ MolFragmentToSmiles()

RDKIT_SMILESPARSE_EXPORT std::string RDKit::MolFragmentToSmiles ( const ROMol mol,
const std::vector< int > &  atomsToUse,
const std::vector< int > *  bondsToUse = 0,
const std::vector< std::string > *  atomSymbols = 0,
const std::vector< std::string > *  bondSymbols = 0,
bool  doIsomericSmiles = true,
bool  doKekule = false,
int  rootedAtAtom = -1,
bool  canonical = true,
bool  allBondsExplicit = false,
bool  allHsExplicit = false 
)

returns canonical SMILES for part of a molecule

Parameters
mol: the molecule in question.
atomsToUse: indices of the atoms in the fragment
bondsToUse: indices of the bonds in the fragment. If this is not provided, all bonds between the atoms in atomsToUse will be included
atomSymbols: symbols to use for the atoms in the output SMILES
bondSymbols: sybmols to use for the bonds in the output SMILES
doIsomericSmiles: include stereochemistry and isotope information in the SMILES
doKekule: do Kekule smiles (i.e. don't use aromatic bonds)
rootedAtAtom: make sure the SMILES starts at the specified atom. The resulting SMILES is not, of course, canonical.
canonical: if false, no attempt will be made to canonicalize the SMILES
allBondsExplicit: if true, symbols will be included for all bonds.
allHsExplicit: if true, hydrogen counts will be provided for every atom.

NOTE: the bondSymbols are not currently used in the canonicalization.

◆ MolToFASTA()

RDKIT_FILEPARSERS_EXPORT std::string RDKit::MolToFASTA ( const ROMol mol)
Parameters
mol- the molecule to work with
Note
mol should contain monomer information in AtomMonomerInfo structures

◆ MolToHELM()

RDKIT_FILEPARSERS_EXPORT std::string RDKit::MolToHELM ( const ROMol mol)
Parameters
mol- the molecule to work with
Note
mol should contain monomer information in AtomMonomerInfo structures

◆ MolToMolBlock()

RDKIT_FILEPARSERS_EXPORT std::string RDKit::MolToMolBlock ( const ROMol mol,
bool  includeStereo = true,
int  confId = -1,
bool  kekulize = true,
bool  forceV3000 = false 
)
Parameters
mol- the molecule in question
includeStereo- toggles inclusion of stereochemistry information
confId- selects the conformer to be used
kekulize- triggers kekulization of the molecule before it is written
forceV3000- force generation a V3000 mol block (happens automatically with more than 999 atoms or bonds)

◆ MolToMolFile()

RDKIT_FILEPARSERS_EXPORT void RDKit::MolToMolFile ( const ROMol mol,
const std::string &  fName,
bool  includeStereo = true,
int  confId = -1,
bool  kekulize = true,
bool  forceV3000 = false 
)
Parameters
mol- the molecule in question
fName- the name of the file to use
includeStereo- toggles inclusion of stereochemistry information
confId- selects the conformer to be used
kekulize- triggers kekulization of the molecule before it is written
forceV3000- force generation a V3000 mol block (happens automatically with more than 999 atoms or bonds)

◆ MolToPDBBlock()

RDKIT_FILEPARSERS_EXPORT std::string RDKit::MolToPDBBlock ( const ROMol mol,
int  confId = -1,
unsigned int  flavor = 0 
)
Parameters
mol- the molecule in question
confId- selects the conformer to be used
flavor- controls what gets written: flavor & 1 : Write MODEL/ENDMDL lines around each record flavor & 2 : Don't write any CONECT records flavor & 4 : Write CONECT records in both directions flavor & 8 : Don't use multiple CONECTs to encode bond order flavor & 16 : Write MASTER record flavor & 32 : Write TER record

◆ MolToPDBFile()

RDKIT_FILEPARSERS_EXPORT void RDKit::MolToPDBFile ( const ROMol mol,
const std::string &  fname,
int  confId = -1,
unsigned int  flavor = 0 
)
Parameters
mol- the molecule in question
fName- the name of the file to use
confId- selects the conformer to be used
flavor- controls what gets written: flavor & 1 : Write MODEL/ENDMDL lines around each record flavor & 2 : Don't write any CONECT records flavor & 4 : Write CONECT records in both directions flavor & 8 : Don't use multiple CONECTs to encode bond order flavor & 16 : Write MASTER record flavor & 32 : Write TER record

◆ MolToSequence()

RDKIT_FILEPARSERS_EXPORT std::string RDKit::MolToSequence ( const ROMol mol)
Parameters
mol- the molecule to work with
Note
mol should contain monomer information in AtomMonomerInfo structures

◆ MolToSmarts()

RDKIT_SMILESPARSE_EXPORT std::string RDKit::MolToSmarts ( ROMol mol,
bool  doIsomericSmarts = true 
)

returns the SMARTS for a molecule

◆ MolToSmiles()

RDKIT_SMILESPARSE_EXPORT std::string RDKit::MolToSmiles ( const ROMol mol,
bool  doIsomericSmiles = true,
bool  doKekule = false,
int  rootedAtAtom = -1,
bool  canonical = true,
bool  allBondsExplicit = false,
bool  allHsExplicit = false,
bool  doRandom = false 
)

returns canonical SMILES for a molecule

Parameters
mol: the molecule in question.
doIsomericSmiles: include stereochemistry and isotope information in the SMILES
doKekule: do Kekule smiles (i.e. don't use aromatic bonds)
rootedAtAtom: make sure the SMILES starts at the specified atom. The resulting SMILES is not, of course, canonical.
canonical: if false, no attempt will be made to canonicalize the SMILES
allBondsExplicit: if true, symbols will be included for all bonds.
allHsExplicit: if true, hydrogen counts will be provided for every atom.

Referenced by RDKit::CachedSmilesMolHolder::addMol(), and RDKit::CachedTrustedSmilesMolHolder::addMol().

◆ MolToTPLFile()

RDKIT_FILEPARSERS_EXPORT void RDKit::MolToTPLFile ( const ROMol mol,
const std::string &  fName,
const std::string &  partialChargeProp = "_GasteigerCharge",
bool  writeFirstConfTwice = false 
)

◆ MolToTPLText()

RDKIT_FILEPARSERS_EXPORT std::string RDKit::MolToTPLText ( const ROMol mol,
const std::string &  partialChargeProp = "_GasteigerCharge",
bool  writeFirstConfTwice = false 
)

◆ MurckoDecompose()

RDKIT_CHEMTRANSFORMS_EXPORT ROMol* RDKit::MurckoDecompose ( const ROMol mol)

Carries out a Murcko decomposition on the molecule provided.

Parameters
mol- the ROMol of interest
Returns
a new ROMol with the Murcko scaffold The client is responsible for deleting this molecule.

◆ nextCombination()

RDKIT_RDGENERAL_EXPORT int RDKit::nextCombination ( INT_VECT comb,
int  tot 
)

given a current combination of numbers change it to the next possible

Parameters
combthe sorted vector to consider
totthe maximum number possible in the vector
Returns
-1 on failure, the index of the last number changed on success. Example: for all combinations 3 of numbers between 0 and tot=5 given (0,1,2) the function wil return (0,1,3) etc.

Referenced by RDKit::charptr_functor::operator()().

◆ nullDataFun()

template<typename T >
int RDKit::nullDataFun ( )

Definition at line 737 of file QueryOps.h.

◆ nullQueryFun()

template<typename T >
bool RDKit::nullQueryFun ( )

Definition at line 741 of file QueryOps.h.

◆ operator"" _smarts()

std::unique_ptr<RDKit::RWMol> RDKit::operator"" _smarts ( const char *  text,
size_t  len 
)
inline

Definition at line 127 of file SmilesParse.h.

References SmartsToMol().

◆ operator"" _smiles()

std::unique_ptr<RDKit::RWMol> RDKit::operator"" _smiles ( const char *  text,
size_t  len 
)
inline

Definition at line 116 of file SmilesParse.h.

References SmilesToMol().

◆ operator+()

◆ operator-()

◆ parseAtomType()

static void RDKit::parseAtomType ( int  val,
int &  atomic_num,
bool &  aromatic 
)
inlinestatic

Definition at line 123 of file QueryOps.h.

◆ parseFeatureData() [1/2]

RDKIT_MOLCHEMICALFEATURES_EXPORT int RDKit::parseFeatureData ( const std::string &  defnText,
MolChemicalFeatureDef::CollectionType featDefs 
)

◆ parseFeatureData() [2/2]

RDKIT_MOLCHEMICALFEATURES_EXPORT int RDKit::parseFeatureData ( std::istream &  istream,
MolChemicalFeatureDef::CollectionType featDefs 
)

◆ parseFeatureFile()

RDKIT_MOLCHEMICALFEATURES_EXPORT int RDKit::parseFeatureFile ( const std::string &  fileName,
MolChemicalFeatureDef::CollectionType featDefs 
)

◆ parseMCSParametersJSON()

RDKIT_FMCS_EXPORT void RDKit::parseMCSParametersJSON ( const char *  json,
MCSParameters params 
)

◆ parseQueryDefFile() [1/2]

RDKIT_CHEMTRANSFORMS_EXPORT void RDKit::parseQueryDefFile ( const std::string &  filename,
std::map< std::string, ROMOL_SPTR > &  queryDefs,
bool  standardize = true 
)

parses a query definition file and sets up a set of definitions suitable for use by addRecursiveQueries()

Parameters
filename- the name of the file to be read
queryDefs- the dictionary of named queries (return value)
standardize- if true, query names will be converted to lower case
delimiter- the line delimiter in the file
comment- text used to recognize comment lines
nameColumn- column with the names of queries
smartsColumn- column with the SMARTS definitions of the queries

◆ parseQueryDefFile() [2/2]

RDKIT_CHEMTRANSFORMS_EXPORT void RDKit::parseQueryDefFile ( std::istream *  inStream,
std::map< std::string, ROMOL_SPTR > &  queryDefs,
bool  standardize = true 
)

This is an overloaded member function, provided for convenience. It differs from the above function only in what argument(s) it accepts.

◆ parseQueryDefText()

RDKIT_CHEMTRANSFORMS_EXPORT void RDKit::parseQueryDefText ( const std::string &  queryDefText,
std::map< std::string, ROMOL_SPTR > &  queryDefs,
bool  standardize = true 
)

equivalent to parseQueryDefFile() but the query definitions are

◆ PatternFingerprintMol()

RDKIT_FINGERPRINTS_EXPORT ExplicitBitVect* RDKit::PatternFingerprintMol ( const ROMol mol,
unsigned int  fpSize = 2048,
std::vector< unsigned int > *  atomCounts = 0,
ExplicitBitVect setOnlyBits = 0 
)

Generates a topological fingerprint for a molecule using a series of pre-defined structural patterns.

Experimental: This function is experimental. The API or results may change from release to release.

Parameters
molthe molecule to be fingerprinted
fpSizethe size of the fingerprint
atomCountsif provided, this will be used to provide the count of the number of paths that set bits each atom is involved in. The vector should have at least as many entries as the molecule has atoms and is not zeroed out here.
setOnlyBitsif provided, only bits that are set in this bit vector will be set in the result. This is essentially the same as doing: (*res) &= (*setOnlyBits); but also has an impact on the atomCounts (if being used)
Returns
the molecular fingerprint, as an ExplicitBitVect

Notes:

  • the caller is responsible for deleteing the result

Referenced by RDKit::PatternHolder::makeFingerprint().

◆ PDBBlockToMol() [1/2]

RDKIT_FILEPARSERS_EXPORT RWMol* RDKit::PDBBlockToMol ( const char *  str,
bool  sanitize = true,
bool  removeHs = true,
unsigned int  flavor = 0,
bool  proximityBonding = true 
)

◆ PDBBlockToMol() [2/2]

RDKIT_FILEPARSERS_EXPORT RWMol* RDKit::PDBBlockToMol ( const std::string &  str,
bool  sanitize = true,
bool  removeHs = true,
unsigned int  flavor = 0,
bool  proximityBonding = true 
)

◆ PDBDataStreamToMol() [1/2]

RDKIT_FILEPARSERS_EXPORT RWMol* RDKit::PDBDataStreamToMol ( std::istream *  inStream,
bool  sanitize = true,
bool  removeHs = true,
unsigned int  flavor = 0,
bool  proximityBonding = true 
)

◆ PDBDataStreamToMol() [2/2]

RDKIT_FILEPARSERS_EXPORT RWMol* RDKit::PDBDataStreamToMol ( std::istream &  inStream,
bool  sanitize = true,
bool  removeHs = true,
unsigned int  flavor = 0,
bool  proximityBonding = true 
)

◆ PDBFileToMol()

RDKIT_FILEPARSERS_EXPORT RWMol* RDKit::PDBFileToMol ( const std::string &  fname,
bool  sanitize = true,
bool  removeHs = true,
unsigned int  flavor = 0,
bool  proximityBonding = true 
)

◆ pickBondsToWedge()

RDKIT_FILEPARSERS_EXPORT INT_MAP_INT RDKit::pickBondsToWedge ( const ROMol mol)

◆ prepareMol()

RDKIT_FRAGCATALOG_EXPORT ROMol* RDKit::prepareMol ( const ROMol mol,
const FragCatParams fparams,
MatchVectType aToFmap 
)

◆ preprocessReaction() [1/4]

RDKIT_CHEMREACTIONS_EXPORT bool RDKit::preprocessReaction ( ChemicalReaction rxn,
const std::string &  propName = common_properties::molFileValue 
)

◆ preprocessReaction() [2/4]

RDKIT_CHEMREACTIONS_EXPORT bool RDKit::preprocessReaction ( ChemicalReaction rxn,
unsigned int &  numWarnings,
unsigned int &  numErrors,
std::vector< std::vector< std::pair< unsigned int, std::string > > > &  reactantLabels,
const std::string &  propName = common_properties::molFileValue 
)

◆ preprocessReaction() [3/4]

RDKIT_CHEMREACTIONS_EXPORT bool RDKit::preprocessReaction ( ChemicalReaction rxn,
const std::map< std::string, ROMOL_SPTR > &  queries,
const std::string &  propName = common_properties::molFileValue 
)

◆ preprocessReaction() [4/4]

RDKIT_CHEMREACTIONS_EXPORT bool RDKit::preprocessReaction ( ChemicalReaction rxn,
unsigned int &  numWarnings,
unsigned int &  numErrors,
std::vector< std::vector< std::pair< unsigned int, std::string > > > &  reactantLabels,
const std::map< std::string, ROMOL_SPTR > &  queries,
const std::string &  propName = common_properties::molFileValue 
)

◆ pullPackedIntFromString()

boost::uint32_t RDKit::pullPackedIntFromString ( const char *&  text)
inline

Reads an integer from a char * in packed format and returns the result. The argument is advanced

Definition at line 180 of file StreamOps.h.

◆ queryAtomAliphatic()

static int RDKit::queryAtomAliphatic ( Atom const *  at)
inlinestatic

Definition at line 72 of file QueryOps.h.

References RDKit::Atom::getIsAromatic().

Referenced by makeAtomAliphaticQuery().

◆ queryAtomAllBondProduct()

RDKIT_GRAPHMOL_EXPORT unsigned int RDKit::queryAtomAllBondProduct ( Atom const *  at)

◆ queryAtomAromatic()

static int RDKit::queryAtomAromatic ( Atom const *  at)
inlinestatic

Definition at line 69 of file QueryOps.h.

References RDKit::Atom::getIsAromatic().

Referenced by makeAtomAromaticQuery().

◆ queryAtomBondProduct()

RDKIT_GRAPHMOL_EXPORT unsigned int RDKit::queryAtomBondProduct ( Atom const *  at)

◆ queryAtomExplicitDegree()

static int RDKit::queryAtomExplicitDegree ( Atom const *  at)
inlinestatic

Definition at line 75 of file QueryOps.h.

References RDKit::Atom::getDegree().

Referenced by makeAtomExplicitDegreeQuery().

◆ queryAtomExplicitValence()

static int RDKit::queryAtomExplicitValence ( Atom const *  at)
inlinestatic

◆ queryAtomFormalCharge()

static int RDKit::queryAtomFormalCharge ( Atom const *  at)
inlinestatic

Definition at line 151 of file QueryOps.h.

References RDKit::Atom::getFormalCharge().

Referenced by makeAtomFormalChargeQuery().

◆ queryAtomHasAliphaticHeteroatomNbrs()

static int RDKit::queryAtomHasAliphaticHeteroatomNbrs ( Atom const *  at)
inlinestatic

◆ queryAtomHasChiralTag()

static int RDKit::queryAtomHasChiralTag ( Atom const *  at)
inlinestatic

Definition at line 160 of file QueryOps.h.

References RDKit::Atom::CHI_UNSPECIFIED, and RDKit::Atom::getChiralTag().

Referenced by makeAtomHasChiralTagQuery().

◆ queryAtomHasHeteroatomNbrs()

static int RDKit::queryAtomHasHeteroatomNbrs ( Atom const *  at)
inlinestatic

◆ queryAtomHasImplicitH()

static int RDKit::queryAtomHasImplicitH ( Atom const *  at)
inlinestatic

Definition at line 104 of file QueryOps.h.

References RDKit::Atom::getTotalNumHs().

Referenced by makeAtomHasImplicitHQuery().

◆ queryAtomHasRingBond()

static int RDKit::queryAtomHasRingBond ( Atom const *  at)
inlinestatic

◆ queryAtomHCount()

static int RDKit::queryAtomHCount ( Atom const *  at)
inlinestatic

Definition at line 98 of file QueryOps.h.

References RDKit::Atom::getTotalNumHs().

Referenced by makeAtomHCountQuery().

◆ queryAtomHeavyAtomDegree()

static int RDKit::queryAtomHeavyAtomDegree ( Atom const *  at)
inlinestatic

◆ queryAtomHybridization()

static int RDKit::queryAtomHybridization ( Atom const *  at)
inlinestatic

Definition at line 154 of file QueryOps.h.

References RDKit::Atom::getHybridization().

Referenced by makeAtomHybridizationQuery().

◆ queryAtomImplicitHCount()

static int RDKit::queryAtomImplicitHCount ( Atom const *  at)
inlinestatic

Definition at line 101 of file QueryOps.h.

References RDKit::Atom::getTotalNumHs().

Referenced by makeAtomImplicitHCountQuery().

◆ queryAtomImplicitValence()

static int RDKit::queryAtomImplicitValence ( Atom const *  at)
inlinestatic

Definition at line 107 of file QueryOps.h.

References RDKit::Atom::getImplicitValence().

Referenced by makeAtomImplicitValenceQuery().

◆ queryAtomIsInRingOfSize()

template<int tgt>
int RDKit::queryAtomIsInRingOfSize ( Atom const *  at)

◆ queryAtomIsotope()

static int RDKit::queryAtomIsotope ( Atom const *  at)
inlinestatic

Definition at line 148 of file QueryOps.h.

References RDKit::Atom::getIsotope().

Referenced by makeAtomIsotopeQuery().

◆ queryAtomMass()

static int RDKit::queryAtomMass ( Atom const *  at)
inlinestatic

Definition at line 145 of file QueryOps.h.

References RDKit::Atom::getMass(), and round().

Referenced by makeAtomMassQuery().

◆ queryAtomMinRingSize()

static int RDKit::queryAtomMinRingSize ( Atom const *  at)
inlinestatic

◆ queryAtomMissingChiralTag()

static int RDKit::queryAtomMissingChiralTag ( Atom const *  at)
inlinestatic

◆ queryAtomNonHydrogenDegree()

static int RDKit::queryAtomNonHydrogenDegree ( Atom const *  at)
inlinestatic

Definition at line 81 of file QueryOps.h.

References RDKit::Atom::getTotalDegree(), and RDKit::Atom::getTotalNumHs().

◆ queryAtomNum()

static int RDKit::queryAtomNum ( Atom const *  at)
inlinestatic

Definition at line 119 of file QueryOps.h.

References RDKit::Atom::getAtomicNum().

Referenced by makeAtomNumQuery().

◆ queryAtomNumAliphaticHeteroatomNbrs()

static int RDKit::queryAtomNumAliphaticHeteroatomNbrs ( Atom const *  at)
inlinestatic

◆ queryAtomNumHeteroatomNbrs()

static int RDKit::queryAtomNumHeteroatomNbrs ( Atom const *  at)
inlinestatic

◆ queryAtomNumRadicalElectrons()

static int RDKit::queryAtomNumRadicalElectrons ( Atom const *  at)
inlinestatic

Definition at line 157 of file QueryOps.h.

References RDKit::Atom::getNumRadicalElectrons().

Referenced by makeAtomNumRadicalElectronsQuery().

◆ queryAtomRingBondCount()

static int RDKit::queryAtomRingBondCount ( Atom const *  at)
inlinestatic

◆ queryAtomRingMembership()

static int RDKit::queryAtomRingMembership ( Atom const *  at)
inlinestatic

◆ queryAtomTotalDegree()

static int RDKit::queryAtomTotalDegree ( Atom const *  at)
inlinestatic

Definition at line 78 of file QueryOps.h.

References RDKit::Atom::getTotalDegree().

Referenced by makeAtomTotalDegreeQuery().

◆ queryAtomTotalValence()

static int RDKit::queryAtomTotalValence ( Atom const *  at)
inlinestatic

◆ queryAtomType()

static int RDKit::queryAtomType ( Atom const *  at)
inlinestatic

Definition at line 141 of file QueryOps.h.

References RDKit::Atom::getAtomicNum(), RDKit::Atom::getIsAromatic(), and makeAtomType().

Referenced by makeAtomTypeQuery().

◆ queryAtomUnsaturated()

static int RDKit::queryAtomUnsaturated ( Atom const *  at)
inlinestatic

Definition at line 116 of file QueryOps.h.

References RDKit::Atom::getDegree(), and RDKit::Atom::getExplicitValence().

Referenced by makeAtomUnsaturatedQuery().

◆ queryBondDir()

static int RDKit::queryBondDir ( Bond const *  bond)
inlinestatic

Definition at line 237 of file QueryOps.h.

References RDKit::Bond::getBondDir().

◆ queryBondHasStereo()

static int RDKit::queryBondHasStereo ( Bond const *  bnd)
inlinestatic

Definition at line 243 of file QueryOps.h.

References RDKit::Bond::getStereo(), and RDKit::Bond::STEREONONE.

◆ queryBondIsInRingOfSize()

template<int tgt>
int RDKit::queryBondIsInRingOfSize ( Bond const *  bond)

◆ queryBondIsSingleOrAromatic()

static int RDKit::queryBondIsSingleOrAromatic ( Bond const *  bond)
inlinestatic

◆ queryBondMinRingSize()

static int RDKit::queryBondMinRingSize ( Bond const *  bond)
inlinestatic

◆ queryBondOrder()

static int RDKit::queryBondOrder ( Bond const *  bond)
inlinestatic

Definition at line 230 of file QueryOps.h.

References RDKit::Bond::getBondType().

◆ queryIsAtomInNRings()

static int RDKit::queryIsAtomInNRings ( Atom const *  at)
inlinestatic

◆ queryIsAtomInRing()

static int RDKit::queryIsAtomInRing ( Atom const *  at)
inlinestatic

◆ queryIsBondInNRings()

static int RDKit::queryIsBondInNRings ( Bond const *  at)
inlinestatic

◆ queryIsBondInRing()

static int RDKit::queryIsBondInRing ( Bond const *  bond)
inlinestatic

◆ rdany_cast() [1/2]

template<class T >
const T RDKit::rdany_cast ( const RDAny d)

Definition at line 182 of file RDAny.h.

References RDKit::RDAny::m_value, and rdvalue_cast().

Referenced by from_rdany().

◆ rdany_cast() [2/2]

template<class T >
T RDKit::rdany_cast ( RDAny d)

Definition at line 188 of file RDAny.h.

References RDKit::RDAny::m_value, and rdvalue_cast().

◆ RDKFingerprintMol()

RDKIT_FINGERPRINTS_EXPORT ExplicitBitVect* RDKit::RDKFingerprintMol ( const ROMol mol,
unsigned int  minPath = 1,
unsigned int  maxPath = 7,
unsigned int  fpSize = 2048,
unsigned int  nBitsPerHash = 2,
bool  useHs = true,
double  tgtDensity = 0.0,
unsigned int  minSize = 128,
bool  branchedPaths = true,
bool  useBondOrder = true,
std::vector< boost::uint32_t > *  atomInvariants = 0,
const std::vector< boost::uint32_t > *  fromAtoms = 0,
std::vector< std::vector< boost::uint32_t > > *  atomBits = 0,
std::map< boost::uint32_t, std::vector< std::vector< int > > > *  bitInfo = 0 
)

Generates a topological (Daylight like) fingerprint for a molecule using an alternate (faster) hashing algorithm.

Parameters
molthe molecule to be fingerprinted
minPaththe minimum path length (in bonds) to be included
maxPaththe minimum path length (in bonds) to be included
fpSizethe size of the fingerprint
nBitsPerHashthe number of bits to be set by each path
useHstoggles inclusion of Hs in paths (if the molecule has explicit Hs)
tgtDensityif the generated fingerprint is below this density, it will be folded until the density is reached.
minSizethe minimum size to which the fingerprint will be folded
branchedPathstoggles generation of branched subgraphs, not just linear paths
useBondOrderstoggles inclusion of bond orders in the path hashes
atomInvariantsa vector of atom invariants to use while hashing the paths
fromAtomsonly paths starting at these atoms will be included
atomBitsused to return the bits that each atom is involved in (should be at least mol.numAtoms long)
Returns
the molecular fingerprint, as an ExplicitBitVect

Notes:

  • the caller is responsible for deleteing the result

◆ RDKitSVGToMol() [1/2]

RDKIT_FILEPARSERS_EXPORT RWMol* RDKit::RDKitSVGToMol ( const std::string &  svg,
bool  sanitize = true,
bool  removeHs = true 
)
Parameters
svg- string containing the SVG
sanitize- toggles sanitization of the molecule
removeHs- toggles removal of Hs from the molecule. H removal is only done if the molecule is sanitized

NOTE This functionality should be considered beta.

◆ RDKitSVGToMol() [2/2]

RDKIT_FILEPARSERS_EXPORT RWMol* RDKit::RDKitSVGToMol ( std::istream *  instream,
bool  sanitize = true,
bool  removeHs = true 
)

This is an overloaded member function, provided for convenience. It differs from the above function only in what argument(s) it accepts.

◆ rdvalue_cast()

template<class T >
T RDKit::rdvalue_cast ( RDValue  v)
inline

◆ rdvalue_cast< bool >()

template<>
bool RDKit::rdvalue_cast< bool > ( RDValue  v)
inline

Definition at line 413 of file RDValue-doublemagic.h.

References RDKit::RDTypeTag::BoolTag.

Referenced by streamWriteProp().

◆ rdvalue_cast< boost::any & >()

template<>
boost::any& RDKit::rdvalue_cast< boost::any &> ( RDValue_cast_t  v)
inline

Definition at line 138 of file RDValue.h.

◆ rdvalue_cast< boost::any >()

template<>
boost::any RDKit::rdvalue_cast< boost::any > ( RDValue_cast_t  v)
inline

Definition at line 130 of file RDValue.h.

◆ rdvalue_cast< const boost::any & >()

template<>
const boost::any& RDKit::rdvalue_cast< const boost::any &> ( RDValue_cast_t  v)
inline

Definition at line 146 of file RDValue.h.

◆ rdvalue_cast< double >()

template<>
double RDKit::rdvalue_cast< double > ( RDValue  v)
inline

Definition at line 382 of file RDValue-doublemagic.h.

References rdvalue_is< double >().

Referenced by streamWriteProp().

◆ rdvalue_cast< float >()

template<>
float RDKit::rdvalue_cast< float > ( RDValue  v)
inline

Definition at line 388 of file RDValue-doublemagic.h.

Referenced by streamWriteProp().

◆ rdvalue_cast< int >()

template<>
int RDKit::rdvalue_cast< int > ( RDValue  v)
inline

Definition at line 400 of file RDValue-doublemagic.h.

References RDKit::RDTypeTag::IntTag.

Referenced by streamWriteProp().

◆ rdvalue_cast< std::string & >()

template<>
std::string& RDKit::rdvalue_cast< std::string &> ( RDValue_cast_t  v)
inline

Definition at line 52 of file RDValue.h.

◆ rdvalue_cast< std::string >()

template<>
std::string RDKit::rdvalue_cast< std::string > ( RDValue_cast_t  v)
inline

Definition at line 46 of file RDValue.h.

◆ rdvalue_cast< std::vector< double > & >()

template<>
std::vector<double>& RDKit::rdvalue_cast< std::vector< double > &> ( RDValue_cast_t  v)
inline

Definition at line 66 of file RDValue.h.

References rdvalue_is().

◆ rdvalue_cast< std::vector< double > >()

template<>
std::vector<double> RDKit::rdvalue_cast< std::vector< double > > ( RDValue_cast_t  v)
inline

Definition at line 59 of file RDValue.h.

References rdvalue_is().

◆ rdvalue_cast< std::vector< float > & >()

template<>
std::vector<float>& RDKit::rdvalue_cast< std::vector< float > &> ( RDValue_cast_t  v)
inline

Definition at line 80 of file RDValue.h.

References rdvalue_is().

◆ rdvalue_cast< std::vector< float > >()

template<>
std::vector<float> RDKit::rdvalue_cast< std::vector< float > > ( RDValue_cast_t  v)
inline

Definition at line 73 of file RDValue.h.

References rdvalue_is().

◆ rdvalue_cast< std::vector< int > & >()

template<>
std::vector<int>& RDKit::rdvalue_cast< std::vector< int > &> ( RDValue_cast_t  v)
inline

Definition at line 108 of file RDValue.h.

References rdvalue_is().

◆ rdvalue_cast< std::vector< int > >()

template<>
std::vector<int> RDKit::rdvalue_cast< std::vector< int > > ( RDValue_cast_t  v)
inline

Definition at line 101 of file RDValue.h.

References rdvalue_is().

◆ rdvalue_cast< std::vector< std::string > & >()

template<>
std::vector<std::string>& RDKit::rdvalue_cast< std::vector< std::string > &> ( RDValue_cast_t  v)
inline

Definition at line 94 of file RDValue.h.

References rdvalue_is().

◆ rdvalue_cast< std::vector< std::string > >()

template<>
std::vector<std::string> RDKit::rdvalue_cast< std::vector< std::string > > ( RDValue_cast_t  v)
inline

Definition at line 87 of file RDValue.h.

References rdvalue_is().

◆ rdvalue_cast< std::vector< unsigned int > & >()

template<>
std::vector<unsigned int>& RDKit::rdvalue_cast< std::vector< unsigned int > &> ( RDValue_cast_t  v)
inline

Definition at line 122 of file RDValue.h.

References rdvalue_is().

◆ rdvalue_cast< std::vector< unsigned int > >()

template<>
std::vector<unsigned int> RDKit::rdvalue_cast< std::vector< unsigned int > > ( RDValue_cast_t  v)
inline

Definition at line 115 of file RDValue.h.

References rdvalue_is().

◆ rdvalue_cast< unsigned int >()

template<>
unsigned int RDKit::rdvalue_cast< unsigned int > ( RDValue  v)
inline

Definition at line 406 of file RDValue-doublemagic.h.

References RDKit::RDTypeTag::UnsignedIntTag.

Referenced by streamWriteProp().

◆ rdvalue_is()

◆ rdvalue_is< const double & >()

template<>
bool RDKit::rdvalue_is< const double &> ( RDValue  v)
inline

Definition at line 335 of file RDValue-doublemagic.h.

References rdvalue_is< double >().

◆ rdvalue_is< double >()

◆ rdvalue_tostring()

◆ readAmberTrajectory()

RDKIT_TRAJECTORY_EXPORT unsigned int RDKit::readAmberTrajectory ( const std::string &  fName,
Trajectory traj 
)

Reads coordinates from an AMBER trajectory file into the traj Trajectory object.

Returns
the number of Snapshot objects read in

Referenced by RDKit::Trajectory::clear().

◆ readFuncGroups() [1/2]

RDKIT_FRAGCATALOG_EXPORT MOL_SPTR_VECT RDKit::readFuncGroups ( std::string  fileName)

◆ readFuncGroups() [2/2]

RDKIT_FRAGCATALOG_EXPORT MOL_SPTR_VECT RDKit::readFuncGroups ( std::istream &  inStream,
int  nToRead = -1 
)

◆ readGromosTrajectory()

RDKIT_TRAJECTORY_EXPORT unsigned int RDKit::readGromosTrajectory ( const std::string &  fName,
Trajectory traj 
)

Reads coordinates from a GROMOS trajectory file into the traj Trajectory object.

Returns
the number of Snapshot objects read in

Referenced by RDKit::Trajectory::clear().

◆ readPackedIntFromStream()

boost::uint32_t RDKit::readPackedIntFromStream ( std::stringstream &  ss)
inline

Reads an integer from a stream in packed format and returns the result.

Definition at line 142 of file StreamOps.h.

◆ readRDStringVecValue()

void RDKit::readRDStringVecValue ( std::istream &  ss,
RDValue value 
)
inline

Definition at line 453 of file StreamOps.h.

References streamReadStringVec().

Referenced by streamReadProp().

◆ readRDValue()

template<class T >
void RDKit::readRDValue ( std::istream &  ss,
RDValue value 
)

Definition at line 433 of file StreamOps.h.

References streamRead().

◆ readRDValueString()

void RDKit::readRDValueString ( std::istream &  ss,
RDValue value 
)
inline

Definition at line 446 of file StreamOps.h.

References streamRead().

Referenced by streamReadProp().

◆ readRDVecValue()

template<class T >
void RDKit::readRDVecValue ( std::istream &  ss,
RDValue value 
)

Definition at line 440 of file StreamOps.h.

References streamReadVec().

◆ reduceProductToSideChains()

RDKIT_CHEMREACTIONS_EXPORT ROMol* RDKit::reduceProductToSideChains ( const ROMOL_SPTR product,
bool  addDummyAtoms = true 
)

Reduce the product generated by run_Reactants or run_Reactant to.

Parameters
addDummyAtomsIf true, add dummy atoms to the sidechains for the non-reagent parts of the sidechain. Dummy atoms are annotated with the atom maps from the reaction. If False, then any sidechain atom where a bond was cleaved is annotated with: _rgroupAtomMaps property which indicates the scaffold atommaps that where bonded _rgroupBonds property which indicates the bondtype for each atommap bonded

◆ removeDuplicates()

RDKIT_SUBSTRUCTMATCH_EXPORT void RDKit::removeDuplicates ( std::vector< MatchVectType > &  v,
unsigned int  nAtoms 
)

◆ removeGroupsWithAtom()

RDKIT_GRAPHMOL_EXPORT void RDKit::removeGroupsWithAtom ( const Atom atom,
std::vector< StereoGroup > &  groups 
)

◆ removeGroupsWithAtoms()

RDKIT_GRAPHMOL_EXPORT void RDKit::removeGroupsWithAtoms ( const std::vector< Atom *> &  atoms,
std::vector< StereoGroup > &  groups 
)

◆ removeMappingNumbersFromReactions()

RDKIT_CHEMREACTIONS_EXPORT void RDKit::removeMappingNumbersFromReactions ( const ChemicalReaction rxn)

◆ removeNonmatchingReagents()

RDKIT_CHEMREACTIONS_EXPORT EnumerationTypes::BBS RDKit::removeNonmatchingReagents ( const ChemicalReaction rxn,
EnumerationTypes::BBS  bbs,
const EnumerationParams params = EnumerationParams() 
)

Helper function, remove reagents that are incompatible.

Referenced by RDKit::EnumerationParams::EnumerationParams().

◆ replaceCore() [1/2]

RDKIT_CHEMTRANSFORMS_EXPORT ROMol* RDKit::replaceCore ( const ROMol mol,
const ROMol core,
const MatchVectType matchVect,
bool  replaceDummies = true,
bool  labelByIndex = false,
bool  requireDummyMatch = false 
)

Returns a copy of an ROMol with the atoms and bonds that are referenced by the MatchVector removed. MatchVector must be defined between mol and the specified core.

dummy atoms are left to indicate attachment points. These dummy atoms can be labeled either by the matching index in the query or by an arbitrary "first match" found. Additional matching options are given below.

Note that this is essentially identical to the replaceSidechains function, except we invert the query and replace the atoms that do match the query.

Parameters
mol- the ROMol of interest
core- the core being matched against
matchVect- a matchVect of the type returned by Substructure Matching
replaceDummies- if set, atoms matching dummies in the core will also be replaced
labelByIndex- if set, the dummy atoms at attachment points are labelled with the index+1 of the corresponding atom in the core
requireDummyMatch- if set, only side chains that are connected to atoms in the core that have attached dummies will be considered. Molecules that have sidechains that are attached at other points will be rejected (NULL returned).
useChirality- if set, match the coreQuery using chirality
Returns
a copy of mol with the non-matching atoms and bonds (if any) removed and dummies at the connection points. The client is responsible for deleting this molecule. If the core query is not matched, NULL is returned.

◆ replaceCore() [2/2]

RDKIT_CHEMTRANSFORMS_EXPORT ROMol* RDKit::replaceCore ( const ROMol mol,
const ROMol coreQuery,
bool  replaceDummies = true,
bool  labelByIndex = false,
bool  requireDummyMatch = false,
bool  useChirality = false 
)

Returns a copy of an ROMol with the atoms and bonds that do fall within a substructure match removed.

dummy atoms are left to indicate attachment points.

Note that this is essentially identical to the replaceSidechains function, except we invert the query and replace the atoms that do match the query.

Parameters
mol- the ROMol of interest
coreQuery- a query ROMol to be used to match the core
replaceDummies- if set, atoms matching dummies in the core will also be replaced
labelByIndex- if set, the dummy atoms at attachment points are labelled with the index+1 of the corresponding atom in the core
requireDummyMatch- if set, only side chains that are connected to atoms in the core that have attached dummies will be considered. Molecules that have sidechains that are attached at other points will be rejected (NULL returned).
useChirality- if set, match the coreQuery using chirality
Returns
a copy of mol with the non-matching atoms and bonds (if any) removed and dummies at the connection points. The client is responsible for deleting this molecule. If the core query is not matched, NULL is returned.

◆ replaceSidechains()

RDKIT_CHEMTRANSFORMS_EXPORT ROMol* RDKit::replaceSidechains ( const ROMol mol,
const ROMol coreQuery,
bool  useChirality = false 
)

Returns a copy of an ROMol with the atoms and bonds that don't fall within a substructure match removed.

dummy atoms are left to indicate attachment points.

Parameters
molthe ROMol of interest
coreQuerya query ROMol to be used to match the core
useChirality- if set, match the coreQuery using chirality
Returns
a copy of mol with the non-matching atoms and bonds (if any) removed and dummies at the connection points.

◆ replaceSubstructs()

RDKIT_CHEMTRANSFORMS_EXPORT std::vector<ROMOL_SPTR> RDKit::replaceSubstructs ( const ROMol mol,
const ROMol query,
const ROMol replacement,
bool  replaceAll = false,
unsigned int  replacementConnectionPoint = 0,
bool  useChirality = false 
)

Returns a list of copies of an ROMol with the atoms and bonds that match a pattern replaced with the atoms contained in another molecule.

Bonds are created between the joining atom in the existing molecule and the atoms in the new molecule. So, using SMILES instead of molecules: replaceSubstructs('OC(=O)NCCNC(=O)O','C(=O)O','[X]') -> ['[X]NCCNC(=O)O','OC(=O)NCCN[X]'] replaceSubstructs('OC(=O)NCCNC(=O)O','C(=O)O','[X]',true) -> ['[X]NCCN[X]'] Chains should be handled "correctly": replaceSubstructs('CC(=O)C','C(=O)','[X]') -> ['C[X]C'] As should rings: replaceSubstructs('C1C(=O)C1','C(=O)','[X]') -> ['C1[X]C1'] And higher order branches: replaceSubstructs('CC(=O)(C)C','C(=O)','[X]') -> ['C[X](C)C'] Note that the client is responsible for making sure that the resulting molecule actually makes sense - this function does not perform sanitization.

Parameters
molthe ROMol of interest
querythe query ROMol
replacementthe ROMol to be inserted
replaceAllif this is true, only a single result, with all
useChirality- if set, match the coreQuery using chirality

occurances of the substructure replaced, will be returned.

Parameters
replacementConnectionPointindex of the atom in the replacement that the bond should made to
Returns
a vector of pointers to copies of mol with the matching atoms and bonds (if any) replaced

◆ RGroupDecompose() [1/2]

RDKIT_RGROUPDECOMPOSITION_EXPORT unsigned int RDKit::RGroupDecompose ( const std::vector< ROMOL_SPTR > &  cores,
const std::vector< ROMOL_SPTR > &  mols,
RGroupRows rows,
std::vector< unsigned int > *  unmatched = 0,
const RGroupDecompositionParameters options = RGroupDecompositionParameters() 
)

◆ RGroupDecompose() [2/2]

RDKIT_RGROUPDECOMPOSITION_EXPORT unsigned int RDKit::RGroupDecompose ( const std::vector< ROMOL_SPTR > &  cores,
const std::vector< ROMOL_SPTR > &  mols,
RGroupColumns columns,
std::vector< unsigned int > *  unmatched = 0,
const RGroupDecompositionParameters options = RGroupDecompositionParameters() 
)

◆ round()

RDKIT_RDGENERAL_EXPORT double RDKit::round ( double  v)

rounds a value to the closest int

Referenced by RDKit::charptr_functor::operator()(), and queryAtomMass().

◆ run_Reactant()

RDKIT_CHEMREACTIONS_EXPORT std::vector<MOL_SPTR_VECT> RDKit::run_Reactant ( const ChemicalReaction rxn,
const ROMOL_SPTR reactant,
unsigned int  reactantIdx 
)

Runs a single reactant against a single reactant template.

Parameters
reactantThe single reactant to use
reactantTemplateIdxthe reactant template to target in the reaction
Returns
a vector of vectors of products. Each subvector will be rxn->getNumProductTemplates() long.

We return a vector of vectors of products because each individual template may map multiple times onto its reactant. This leads to multiple possible result sets.

◆ run_Reactants()

RDKIT_CHEMREACTIONS_EXPORT std::vector<MOL_SPTR_VECT> RDKit::run_Reactants ( const ChemicalReaction rxn,
const MOL_SPTR_VECT reactants,
unsigned int  maxProducts = 1000 
)

Runs the reaction on a set of reactants.

Parameters
rxnthe template reaction we are interested
reactantsthe reactants to be used. The length of this must be equal to rxn->getNumReactantTemplates() Caution: The order of the reactant templates determines the order of the reactants!
maxProductsif non zero, the maximum number of products to generate before stopping. If hit a warning will be generated.
Returns
a vector of vectors of products. Each subvector will be rxn->getNumProductTemplates() long.

We return a vector of vectors of products because each individual template may map multiple times onto its reactant. This leads to multiple possible result sets.

◆ RxnBlockToChemicalReaction()

RDKIT_CHEMREACTIONS_EXPORT ChemicalReaction* RDKit::RxnBlockToChemicalReaction ( const std::string &  rxnBlock)

Parse a text block in MDL rxn format into a ChemicalReaction.

Referenced by RDKit::ChemicalReactionParserException::~ChemicalReactionParserException().

◆ RxnDataStreamToChemicalReaction()

RDKIT_CHEMREACTIONS_EXPORT ChemicalReaction* RDKit::RxnDataStreamToChemicalReaction ( std::istream &  rxnStream,
unsigned int &  line 
)

Parse a text stream in MDL rxn format into a ChemicalReaction.

Referenced by RDKit::ChemicalReactionParserException::~ChemicalReactionParserException().

◆ RxnFileToChemicalReaction()

RDKIT_CHEMREACTIONS_EXPORT ChemicalReaction* RDKit::RxnFileToChemicalReaction ( const std::string &  fileName)

◆ RxnMolToChemicalReaction()

RDKIT_CHEMREACTIONS_EXPORT ChemicalReaction* RDKit::RxnMolToChemicalReaction ( const ROMol mol)

Parse a ROMol into a ChemicalReaction, RXN role must be set before.

Alternative to build a reaction from a molecule (fragments) which have RXN roles set as atom properties: common_properties::molRxnRole (1=reactant, 2=product, 3=agent)

Parameters
molROMol with RXN roles set

Referenced by RDKit::ChemicalReactionParserException::~ChemicalReactionParserException().

◆ RxnSmartsToChemicalReaction()

RDKIT_CHEMREACTIONS_EXPORT ChemicalReaction* RDKit::RxnSmartsToChemicalReaction ( const std::string &  text,
std::map< std::string, std::string > *  replacements = 0,
bool  useSmiles = false 
)

Parse a string containing "Reaction SMARTS" into a ChemicalReaction.

Our definition of Reaction SMARTS is something that looks a lot like reaction SMILES, except that SMARTS queries are allowed on the reactant side and that atom-map numbers are required (at least for now)

Parameters
textthe SMARTS to convert
replacementsa string->string map of replacement strings.
See also
SmilesToMol for more information about replacements
Parameters
useSmilesif set, the SMILES parser will be used instead of the SMARTS parserfor the individual components

Referenced by RDKit::ChemicalReactionParserException::~ChemicalReactionParserException().

◆ SamePDBResidue()

RDKIT_FILEPARSERS_EXPORT bool RDKit::SamePDBResidue ( AtomPDBResidueInfo p,
AtomPDBResidueInfo q 
)

◆ SequenceToMol() [1/4]

RDKIT_FILEPARSERS_EXPORT RWMol* RDKit::SequenceToMol ( const char *  seq,
bool  sanitize,
bool  lowerD 
)
Parameters
seq- the string to be processed
sanitize- toggles sanitization and stereochemistry perception of the molecule
lowerD- if set, lower case letters will be parsed as the d form of the corresponding amino acid

◆ SequenceToMol() [2/4]

RDKIT_FILEPARSERS_EXPORT RWMol* RDKit::SequenceToMol ( const std::string &  seq,
bool  sanitize,
bool  lowerD 
)

This is an overloaded member function, provided for convenience. It differs from the above function only in what argument(s) it accepts.

◆ SequenceToMol() [3/4]

RDKIT_FILEPARSERS_EXPORT RWMol* RDKit::SequenceToMol ( const char *  seq,
bool  sanitize = true,
int  flavor = 0 
)
Parameters
seq- the string to be processed
sanitize- toggles sanitization and stereochemistry perception of the molecule
flavor- 0 Protein, L amino acids (default) 1 Protein, D amino acids 2 RNA, no cap 3 RNA, 5' cap 4 RNA, 3' cap 5 RNA, both caps 6 DNA, no cap 7 DNA, 5' cap 8 DNA, 3' cap 9 DNA, both caps

◆ SequenceToMol() [4/4]

RDKIT_FILEPARSERS_EXPORT RWMol* RDKit::SequenceToMol ( const std::string &  seq,
bool  sanitize = true,
int  flavor = 0 
)

This is an overloaded member function, provided for convenience. It differs from the above function only in what argument(s) it accepts.

◆ setAtomAlias()

RDKIT_GRAPHMOL_EXPORT void RDKit::setAtomAlias ( Atom atom,
const std::string &  alias 
)

Set the atom's MDL atom alias.

◆ setAtomRLabel()

RDKIT_GRAPHMOL_EXPORT void RDKit::setAtomRLabel ( Atom atm,
int  rlabel 
)

Set the atom's MDL integer RLabel.

◆ setAtomValue()

RDKIT_GRAPHMOL_EXPORT void RDKit::setAtomValue ( Atom atom,
const std::string &  value 
)

Set the atom's MDL atom value.

◆ setSupplementalSmilesLabel()

RDKIT_GRAPHMOL_EXPORT void RDKit::setSupplementalSmilesLabel ( Atom atom,
const std::string &  label 
)

Sets the supplemental label that will follow the atom when writing.

◆ SLNQueryToMol()

RDKIT_SLNPARSE_EXPORT RWMol* RDKit::SLNQueryToMol ( const std::string &  smi,
bool  mergeHs = true,
int  debugParse = 0 
)

◆ SLNToMol()

RDKIT_SLNPARSE_EXPORT RWMol* RDKit::SLNToMol ( const std::string &  smi,
bool  sanitize = true,
int  debugParse = 0 
)

◆ SmartsToAtom()

RDKIT_SMILESPARSE_EXPORT Atom* RDKit::SmartsToAtom ( const std::string &  sma)

Referenced by SmilesToMol().

◆ SmartsToBond()

RDKIT_SMILESPARSE_EXPORT Bond* RDKit::SmartsToBond ( const std::string &  sma)

Referenced by SmilesToMol().

◆ SmartsToMol()

RDKIT_SMILESPARSE_EXPORT RWMol* RDKit::SmartsToMol ( const std::string &  sma,
int  debugParse = 0,
bool  mergeHs = false,
std::map< std::string, std::string > *  replacements = 0 
)

Construct a molecule from a SMARTS string.

Parameters
smathe SMARTS to convert
debugParsetoggles verbose debugging information from the parser
mergeHstoggles merging H atoms in the SMARTS into neighboring atoms
replacementsa string->string map of replacement strings.
See also
SmilesToMol for more information about replacements
Returns
a pointer to the new molecule; the caller is responsible for free'ing this.

Referenced by operator"" _smarts(), and SmilesToMol().

◆ SmilesToAtom()

RDKIT_SMILESPARSE_EXPORT Atom* RDKit::SmilesToAtom ( const std::string &  smi)

◆ SmilesToBond()

RDKIT_SMILESPARSE_EXPORT Bond* RDKit::SmilesToBond ( const std::string &  smi)

◆ SmilesToMol() [1/2]

◆ SmilesToMol() [2/2]

RWMol* RDKit::SmilesToMol ( const std::string &  smi,
int  debugParse = 0,
bool  sanitize = true,
std::map< std::string, std::string > *  replacements = 0 
)
inline

Construct a molecule from a SMILES string.

Parameters
smithe SMILES to convert
debugParsetoggles verbose debugging information from the parser
sanitizetoggles H removal and sanitization of the molecule
replacementsa string->string map of replacement strings. See below for more information about replacements.
Returns
a pointer to the new molecule; the caller is responsible for free'ing this.

The optional replacements map can be used to do string substitution of abbreviations in the input SMILES. The set of substitutions is repeatedly looped through until the string no longer changes. It is the responsiblity of the caller to make sure that substitutions results in legal and sensible SMILES.

Examples of substitutions:

CC{Q}C with {"{Q}":"OCCO"} -> CCOCCOC
C{A}C{Q}C with {"{Q}":"OCCO", "{A}":"C1(CC1)"} -> CC1(CC1)COCCOC
C{A}C{Q}C with {"{Q}":"{X}CC{X}", "{A}":"C1CC1", "{X}":"N"} -> CC1CC1CCNCCNC

Definition at line 70 of file SmilesParse.h.

References RDKit::SmilesParserParams::debugParse, RDKIT_SMILESPARSE_EXPORT, RDKit::SmilesParserParams::removeHs, RDKit::SmilesParserParams::replacements, RDKit::SmilesParserParams::sanitize, SmartsToAtom(), SmartsToBond(), SmartsToMol(), and SmilesToMol().

◆ StandardPDBResidueBondOrders()

RDKIT_FILEPARSERS_EXPORT void RDKit::StandardPDBResidueBondOrders ( RWMol mol)

◆ streamRead() [1/3]

template<typename T >
void RDKit::streamRead ( std::istream &  ss,
T &  loc 
)

◆ streamRead() [2/3]

template<class T >
void RDKit::streamRead ( std::istream &  ss,
T &  obj,
int  version 
)

special case for string

Definition at line 253 of file StreamOps.h.

References RDUNUSED_PARAM, and streamRead().

◆ streamRead() [3/3]

void RDKit::streamRead ( std::istream &  ss,
std::string &  what,
int  version 
)
inline

Definition at line 258 of file StreamOps.h.

References RDUNUSED_PARAM.

◆ streamReadProp()

◆ streamReadProps()

unsigned int RDKit::streamReadProps ( std::istream &  ss,
RDProps props 
)
inline

◆ streamReadStringVec()

void RDKit::streamReadStringVec ( std::istream &  ss,
std::vector< std::string > &  val,
int  version 
)
inline

Definition at line 278 of file StreamOps.h.

References streamRead().

Referenced by readRDStringVecValue().

◆ streamReadVec()

template<class T >
void RDKit::streamReadVec ( std::istream &  ss,
T &  val 
)

Definition at line 270 of file StreamOps.h.

References streamRead().

Referenced by readRDVecValue().

◆ streamWrite() [1/2]

template<typename T >
void RDKit::streamWrite ( std::ostream &  ss,
const T &  val 
)

◆ streamWrite() [2/2]

void RDKit::streamWrite ( std::ostream &  ss,
const std::string &  what 
)
inline

special case for string

Definition at line 231 of file StreamOps.h.

◆ streamWriteProp()

◆ streamWriteProps()

bool RDKit::streamWriteProps ( std::ostream &  ss,
const RDProps props,
bool  savePrivate = false,
bool  saveComputed = false 
)
inline

◆ streamWriteVec()

template<typename T >
void RDKit::streamWriteVec ( std::ostream &  ss,
const T &  val 
)

Definition at line 238 of file StreamOps.h.

References streamWrite().

Referenced by streamWriteProp().

◆ strip()

RDKIT_FILEPARSERS_EXPORT std::string RDKit::strip ( const std::string &  orig)

◆ StructuralFingerprintChemReaction()

RDKIT_CHEMREACTIONS_EXPORT ExplicitBitVect* RDKit::StructuralFingerprintChemReaction ( const ChemicalReaction rxn,
const ReactionFingerprintParams params = DefaultStructuralFPParams 
)

Generates a structural fingerprint for a reaction to use in screening

A structural fingerprint is generated as an ExplicitBitVect to use for searching e.g. substructure in reactions. By default the fingerprint is generated as 4096 BitVect using a PatternFP for reactants and products and tentatively agents which were finally concatenated

Parameters
rxnthe reaction to be fingerprinted
paramsspecific settings to manipulate fingerprint generation
Returns
the reaction fingerprint, as an ExplicitBitVect

Notes:

  • the caller is responsible for deleteing the result

◆ SubstructMatch() [1/10]

RDKIT_SUBSTRUCTMATCH_EXPORT bool RDKit::SubstructMatch ( const ROMol mol,
const ROMol query,
MatchVectType matchVect,
bool  recursionPossible = true,
bool  useChirality = false,
bool  useQueryQueryMatches = false 
)

Find a substructure match for a query in a molecule.

Parameters
molThe ROMol to be searched
queryThe query ROMol
matchVectUsed to return the match (pre-existing contents will be deleted)
recursionPossibleflags whether or not recursive matches are allowed
useChiralityuse atomic CIP codes as part of the comparison
useQueryQueryMatchesif set, the contents of atom and bond queries will be used as part of the matching
Returns
whether or not a match was found

◆ SubstructMatch() [2/10]

RDKIT_SUBSTRUCTMATCH_EXPORT bool RDKit::SubstructMatch ( ResonanceMolSupplier resMolSuppl,
const ROMol query,
MatchVectType matchVect,
bool  recursionPossible = true,
bool  useChirality = false,
bool  useQueryQueryMatches = false 
)

Find a substructure match for a query in a ResonanceMolSupplier object.

Parameters
resMolSupplThe ResonanceMolSupplier object to be searched
queryThe query ROMol
matchVectUsed to return the match (pre-existing contents will be deleted)
recursionPossibleflags whether or not recursive matches are allowed
useChiralityuse atomic CIP codes as part of the comparison
useQueryQueryMatchesif set, the contents of atom and bond queries will be used as part of the matching
Returns
whether or not a match was found

◆ SubstructMatch() [3/10]

RDKIT_SUBSTRUCTMATCH_EXPORT unsigned int RDKit::SubstructMatch ( const ROMol mol,
const ROMol query,
std::vector< MatchVectType > &  matchVect,
bool  uniquify = true,
bool  recursionPossible = true,
bool  useChirality = false,
bool  useQueryQueryMatches = false,
unsigned int  maxMatches = 1000 
)

Find all substructure matches for a query in a molecule.

Parameters
molThe ROMol to be searched
queryThe query ROMol
matchVectUsed to return the matches (pre-existing contents will be deleted)
uniquifyToggles uniquification (by atom index) of the results
recursionPossibleflags whether or not recursive matches are allowed
useChiralityuse atomic CIP codes as part of the comparison
useQueryQueryMatchesif set, the contents of atom and bond queries will be used as part of the matching
maxMatchesThe maximum number of matches that will be returned. In high-symmetry cases with medium-sized molecules, it is very easy to end up with a combinatorial explosion in the number of possible matches. This argument prevents that from having unintended consequences
Returns
the number of matches found

◆ SubstructMatch() [4/10]

RDKIT_SUBSTRUCTMATCH_EXPORT unsigned int RDKit::SubstructMatch ( ResonanceMolSupplier resMolSuppl,
const ROMol query,
std::vector< MatchVectType > &  matchVect,
bool  uniquify = false,
bool  recursionPossible = true,
bool  useChirality = false,
bool  useQueryQueryMatches = false,
unsigned int  maxMatches = 1000,
int  numThreads = 1 
)

Find all substructure matches for a query in a ResonanceMolSupplier object.

Parameters
resMolSupplThe ResonanceMolSupplier object to be searched
queryThe query ROMol
matchVectUsed to return the matches (pre-existing contents will be deleted)
uniquifyToggles uniquification (by atom index) of the results
recursionPossibleflags whether or not recursive matches are allowed
useChiralityuse atomic CIP codes as part of the comparison
useQueryQueryMatchesif set, the contents of atom and bond queries will be used as part of the matching
maxMatchesThe maximum number of matches that will be returned. In high-symmetry cases with medium-sized molecules, it is very easy to end up with a combinatorial explosion in the number of possible matches. This argument prevents that from having unintended consequences
numThreadsThe number of threads used during the search (defaults to 1; 0 selects the number of concurrent threads supported by the hardware; negative values are added to the number of concurrent threads supported by the hardware)
Returns
the number of matches found

◆ SubstructMatch() [5/10]

RDKIT_SUBSTRUCTMATCH_EXPORT bool RDKit::SubstructMatch ( const MolBundle bundle,
const ROMol query,
MatchVectType matchVect,
bool  recursionPossible = true,
bool  useChirality = false,
bool  useQueryQueryMatches = false 
)

This is an overloaded member function, provided for convenience. It differs from the above function only in what argument(s) it accepts. finds the first match in the bundle

◆ SubstructMatch() [6/10]

RDKIT_SUBSTRUCTMATCH_EXPORT bool RDKit::SubstructMatch ( const ROMol bundle,
const MolBundle query,
MatchVectType matchVect,
bool  recursionPossible = true,
bool  useChirality = false,
bool  useQueryQueryMatches = false 
)

This is an overloaded member function, provided for convenience. It differs from the above function only in what argument(s) it accepts. finds the first match in the bundle

◆ SubstructMatch() [7/10]

RDKIT_SUBSTRUCTMATCH_EXPORT bool RDKit::SubstructMatch ( const MolBundle bundle,
const MolBundle query,
MatchVectType matchVect,
bool  recursionPossible = true,
bool  useChirality = false,
bool  useQueryQueryMatches = false 
)

This is an overloaded member function, provided for convenience. It differs from the above function only in what argument(s) it accepts. finds the first match in the bundle

◆ SubstructMatch() [8/10]

RDKIT_SUBSTRUCTMATCH_EXPORT unsigned int RDKit::SubstructMatch ( const MolBundle mol,
const ROMol query,
std::vector< MatchVectType > &  matchVect,
bool  uniquify = true,
bool  recursionPossible = true,
bool  useChirality = false,
bool  useQueryQueryMatches = false,
unsigned int  maxMatches = 1000 
)

This is an overloaded member function, provided for convenience. It differs from the above function only in what argument(s) it accepts. finds all matches in the first molecule of the bundle that matches the query

◆ SubstructMatch() [9/10]

RDKIT_SUBSTRUCTMATCH_EXPORT unsigned int RDKit::SubstructMatch ( const MolBundle mol,
const MolBundle query,
std::vector< MatchVectType > &  matchVect,
bool  uniquify = true,
bool  recursionPossible = true,
bool  useChirality = false,
bool  useQueryQueryMatches = false,
unsigned int  maxMatches = 1000 
)

This is an overloaded member function, provided for convenience. It differs from the above function only in what argument(s) it accepts. finds all matches in the first molecule of the bundle that matches

◆ SubstructMatch() [10/10]

RDKIT_SUBSTRUCTMATCH_EXPORT unsigned int RDKit::SubstructMatch ( const ROMol mol,
const MolBundle query,
std::vector< MatchVectType > &  matchVect,
bool  uniquify = true,
bool  recursionPossible = true,
bool  useChirality = false,
bool  useQueryQueryMatches = false,
unsigned int  maxMatches = 1000 
)

This is an overloaded member function, provided for convenience. It differs from the above function only in what argument(s) it accepts. finds all matches against the first molecule of the query bundle that matches

◆ SwapBytes()

template<class T , unsigned int size>
T RDKit::SwapBytes ( value)
inline

Definition at line 42 of file StreamOps.h.

◆ TanimotoSimilarity()

template<typename IndexType >
double RDKit::TanimotoSimilarity ( const SparseIntVect< IndexType > &  v1,
const SparseIntVect< IndexType > &  v2,
bool  returnDistance = false,
double  bounds = 0.0 
)

Definition at line 541 of file SparseIntVect.h.

References TverskySimilarity().

◆ toPrime()

RDKIT_SUBSTRUCTMATCH_EXPORT double RDKit::toPrime ( const MatchVectType v)

◆ TPLDataStreamToMol()

RDKIT_FILEPARSERS_EXPORT RWMol* RDKit::TPLDataStreamToMol ( std::istream *  inStream,
unsigned int &  line,
bool  sanitize = true,
bool  skipFirstConf = false 
)

translate TPL data (BioCad format) into a multi-conf molecule

Parameters
inStreamthe stream from which to read
lineused to track the line number of errors
sanitizetoggles sanitization and stereochemistry perception of the molecule
skipFirstConfaccording to the TPL format description, the atomic coords in the atom-information block describe the first conformation and the first conf block describes second conformation. The CombiCode, on the other hand, writes the first conformation data both to the atom-information block and to the first conf block. We want to be able to read CombiCode-style tpls, so we'll allow this mis-feature to be parsed when this flag is set.

◆ TPLFileToMol()

RDKIT_FILEPARSERS_EXPORT RWMol* RDKit::TPLFileToMol ( const std::string &  fName,
bool  sanitize = true,
bool  skipFirstConf = false 
)

construct a multi-conf molecule from a TPL (BioCad format) file

Parameters
fNamethe name of the file from which to read
sanitizetoggles sanitization and stereochemistry perception of the molecule
skipFirstConfaccording to the TPL format description, the atomic coords in the atom-information block describe the first conformation and the first conf block describes second conformation. The CombiCode, on the other hand, writes the first conformation data both to the atom-information block and to the first conf block. We want to be able to read CombiCode-style tpls, so we'll allow this mis-feature to be parsed when this flag is set.

◆ TverskySimilarity()

template<typename IndexType >
double RDKit::TverskySimilarity ( const SparseIntVect< IndexType > &  v1,
const SparseIntVect< IndexType > &  v2,
double  a,
double  b,
bool  returnDistance = false,
double  bounds = 0.0 
)

Definition at line 514 of file SparseIntVect.h.

References RDKit::SparseIntVect< IndexType >::getLength(), and RDUNUSED_PARAM.

Referenced by TanimotoSimilarity().

◆ Union() [1/2]

RDKIT_RDGENERAL_EXPORT void RDKit::Union ( const INT_VECT r1,
const INT_VECT r2,
INT_VECT res 
)

calculate the union of two INT_VECTs and put the results in a third vector

Referenced by RDKit::charptr_functor::operator()().

◆ Union() [2/2]

RDKIT_RDGENERAL_EXPORT void RDKit::Union ( const VECT_INT_VECT rings,
INT_VECT res,
const INT_VECT exclude = NULL 
)

calculating the union of the INT_VECT's in a VECT_INT_VECT

Parameters
ringsthe INT_VECT's to consider
resused to return results
excludeany values in this optional INT_VECT will be excluded from the union.

◆ updateFromSequence()

template<typename IndexType , typename SequenceType >
void RDKit::updateFromSequence ( SparseIntVect< IndexType > &  vect,
const SequenceType &  seq 
)

◆ updateProductsStereochem()

RDKIT_CHEMREACTIONS_EXPORT void RDKit::updateProductsStereochem ( ChemicalReaction rxn)

◆ vectToString()

template<class T >
std::string RDKit::vectToString ( RDValue  val)

Definition at line 156 of file RDValue.h.

References rdvalue_cast().

◆ WedgeBond()

RDKIT_FILEPARSERS_EXPORT void RDKit::WedgeBond ( Bond bond,
unsigned int  fromAtomIdx,
const Conformer conf 
)

◆ WedgeMolBonds()

RDKIT_FILEPARSERS_EXPORT void RDKit::WedgeMolBonds ( ROMol mol,
const Conformer conf 
)

Variable Documentation

◆ additionalParamData

std::string RDKit::additionalParamData

◆ BITS_PER_INT

const unsigned int RDKit::BITS_PER_INT = 32

Definition at line 21 of file DiscreteValueVect.h.

◆ boostVersion

RDKIT_RDGENERAL_EXPORT const char* RDKit::boostVersion

◆ ci_ATOM_HOLDER

RDKIT_GRAPHMOL_EXPORT const int RDKit::ci_ATOM_HOLDER

◆ ci_LEADING_BOND

RDKIT_GRAPHMOL_EXPORT const int RDKit::ci_LEADING_BOND

◆ ci_RIGHTMOST_ATOM

RDKIT_GRAPHMOL_EXPORT const int RDKit::ci_RIGHTMOST_ATOM

◆ ctdIGNORE_H_H_CONTACTS

const unsigned int RDKit::ctdIGNORE_H_H_CONTACTS = 0x1
static

Definition at line 16 of file ProximityBonds.h.

◆ DAMP

const double RDKit::DAMP = 0.5

Definition at line 28 of file GasteigerParams.h.

◆ DAMP_SCALE

const double RDKit::DAMP_SCALE = 0.5

Definition at line 27 of file GasteigerParams.h.

◆ DEFAULT_FILTERMATCHERBASE_NAME

RDKIT_FILTERCATALOG_EXPORT const char* RDKit::DEFAULT_FILTERMATCHERBASE_NAME

◆ defaultConfId

int RDKit::defaultConfId = -1
static

Definition at line 23 of file MolWriters.h.

◆ DefaultDifferenceFPParams

RDKIT_CHEMREACTIONS_EXPORT const ReactionFingerprintParams RDKit::DefaultDifferenceFPParams

◆ DefaultStructuralFPParams

RDKIT_CHEMREACTIONS_EXPORT const ReactionFingerprintParams RDKit::DefaultStructuralFPParams

◆ EPS_DOUBLE

RDKIT_RDGENERAL_EXPORT const double RDKit::EPS_DOUBLE

◆ FILE_MAXLINE

const int RDKit::FILE_MAXLINE
Initial value:
=
256

an assumed maximum length for lines read from files

Definition at line 26 of file utils.h.

◆ firstThousandPrimes

RDKIT_RDGENERAL_EXPORT int RDKit::firstThousandPrimes

Definition at line 24 of file utils.h.

◆ IONXH

const double RDKit::IONXH = 20.02

Definition at line 25 of file GasteigerParams.h.

◆ isotopesAtomData

RDKIT_GRAPHMOL_EXPORT const std::string RDKit::isotopesAtomData[]

◆ LayeredFingerprintMolVersion

const std::string RDKit::LayeredFingerprintMolVersion = "0.7.0"

Definition at line 112 of file Fingerprints.h.

◆ massIntegerConversionFactor

const int RDKit::massIntegerConversionFactor = 1000

Definition at line 144 of file QueryOps.h.

◆ MAX_DOUBLE

RDKIT_RDGENERAL_EXPORT const double RDKit::MAX_DOUBLE

◆ MAX_INT

RDKIT_RDGENERAL_EXPORT const double RDKit::MAX_INT

◆ MAX_LONGINT

RDKIT_RDGENERAL_EXPORT const double RDKit::MAX_LONGINT

◆ maxFingerprintLayers

const unsigned int RDKit::maxFingerprintLayers = 10

Definition at line 111 of file Fingerprints.h.

◆ MOLFILE_MAXLINE

const int RDKit::MOLFILE_MAXLINE = 256

Definition at line 25 of file FileParsers.h.

◆ NUM_PRIMES_AVAIL

const int RDKit::NUM_PRIMES_AVAIL = 1000

the number of primes available and stored

Definition at line 15 of file primes.h.

◆ paramData

◆ periodicTableAtomData

RDKIT_GRAPHMOL_EXPORT const std::string RDKit::periodicTableAtomData

◆ RDKFingerprintMolVersion

const std::string RDKit::RDKFingerprintMolVersion = "2.0.0"

Definition at line 62 of file Fingerprints.h.

◆ rdkitBuild

RDKIT_RDGENERAL_EXPORT const char* RDKit::rdkitBuild

◆ rdkitVersion

RDKIT_RDGENERAL_EXPORT const char* RDKit::rdkitVersion

◆ SMALL_DOUBLE

RDKIT_RDGENERAL_EXPORT const double RDKit::SMALL_DOUBLE

◆ SMARTS_MATCH_NAME_DEFAULT

RDKIT_FILTERCATALOG_EXPORT const char* RDKit::SMARTS_MATCH_NAME_DEFAULT

◆ substructLayers

const unsigned int RDKit::substructLayers = 0x07

Definition at line 113 of file Fingerprints.h.