![]() |
RDKit
Open-source cheminformatics and machine learning.
|
#include <ROMol.h>
Public Member Functions | |
CXXAtomIterator< MolGraph, Atom * > | atoms () |
C++11 Range iterator. More... | |
CXXAtomIterator< const MolGraph, Atom *const > | atoms () const |
CXXBondIterator< MolGraph, Bond * > | bonds () |
CXXBondIterator< const MolGraph, Bond *const > | bonds () const |
ROMol () | |
ROMol (const ROMol &other, bool quickCopy=false, int confId=-1) | |
copy constructor with a twist More... | |
ROMol (const std::string &binStr) | |
construct a molecule from a pickle string More... | |
virtual | ~ROMol () |
Atoms | |
unsigned int | getNumAtoms (bool onlyExplicit=1) const |
returns our number of atoms More... | |
unsigned int | getNumHeavyAtoms () const |
returns our number of heavy atoms (atomic number > 1) More... | |
Atom * | getAtomWithIdx (unsigned int idx) |
returns a pointer to a particular Atom More... | |
const Atom * | getAtomWithIdx (unsigned int idx) const |
This is an overloaded member function, provided for convenience. It differs from the above function only in what argument(s) it accepts. More... | |
template<class U > | |
Atom * | getAtomWithIdx (const U idx) |
This is an overloaded member function, provided for convenience. It differs from the above function only in what argument(s) it accepts. More... | |
template<class U > | |
const Atom * | getAtomWithIdx (const U idx) const |
This is an overloaded member function, provided for convenience. It differs from the above function only in what argument(s) it accepts. More... | |
unsigned int | getAtomDegree (const Atom *at) const |
returns the degree (number of neighbors) of an Atom in the graph More... | |
Bonds | |
unsigned int | getNumBonds (bool onlyHeavy=1) const |
returns our number of Bonds More... | |
Bond * | getBondWithIdx (unsigned int idx) |
returns a pointer to a particular Bond More... | |
const Bond * | getBondWithIdx (unsigned int idx) const |
This is an overloaded member function, provided for convenience. It differs from the above function only in what argument(s) it accepts. More... | |
template<class U > | |
Bond * | getBondWithIdx (const U idx) |
This is an overloaded member function, provided for convenience. It differs from the above function only in what argument(s) it accepts. More... | |
template<class U > | |
const Bond * | getBondWithIdx (const U idx) const |
This is an overloaded member function, provided for convenience. It differs from the above function only in what argument(s) it accepts. More... | |
Bond * | getBondBetweenAtoms (unsigned int idx1, unsigned int idx2) |
returns a pointer to the bond between two atoms, Null on failure More... | |
const Bond * | getBondBetweenAtoms (unsigned int idx1, unsigned int idx2) const |
This is an overloaded member function, provided for convenience. It differs from the above function only in what argument(s) it accepts. More... | |
template<class U , class V > | |
Bond * | getBondBetweenAtoms (const U idx1, const V idx2) |
This is an overloaded member function, provided for convenience. It differs from the above function only in what argument(s) it accepts. More... | |
template<class U , class V > | |
const Bond * | getBondBetweenAtoms (const U idx1, const V idx2) const |
This is an overloaded member function, provided for convenience. It differs from the above function only in what argument(s) it accepts. More... | |
Bookmarks | |
void | setAtomBookmark (Atom *at, int mark) |
associates an Atom pointer with a bookmark More... | |
void | replaceAtomBookmark (Atom *at, int mark) |
associates an Atom pointer with a bookmark More... | |
Atom * | getAtomWithBookmark (int mark) |
returns the first Atom associated with the bookmark provided More... | |
Atom * | getUniqueAtomWithBookmark (int mark) |
ATOM_PTR_LIST & | getAllAtomsWithBookmark (int mark) |
returns all Atoms associated with the bookmark provided More... | |
void | clearAtomBookmark (int mark) |
removes a bookmark from our collection More... | |
void | clearAtomBookmark (int mark, const Atom *atom) |
removes a particular Atom from the list associated with the bookmark More... | |
void | clearAllAtomBookmarks () |
blows out all atomic bookmarks More... | |
bool | hasAtomBookmark (int mark) const |
queries whether or not any atoms are associated with a bookmark More... | |
ATOM_BOOKMARK_MAP * | getAtomBookmarks () |
returns a pointer to all of our atom bookmarks More... | |
void | setBondBookmark (Bond *bond, int mark) |
associates a Bond pointer with a bookmark More... | |
Bond * | getBondWithBookmark (int mark) |
returns the first Bond associated with the bookmark provided More... | |
Bond * | getUniqueBondWithBookmark (int mark) |
BOND_PTR_LIST & | getAllBondsWithBookmark (int mark) |
returns all bonds associated with the bookmark provided More... | |
void | clearBondBookmark (int mark) |
removes a bookmark from our collection More... | |
void | clearBondBookmark (int mark, const Bond *bond) |
removes a particular Bond from the list associated with the bookmark More... | |
void | clearAllBondBookmarks () |
blows out all bond bookmarks More... | |
bool | hasBondBookmark (int mark) const |
queries whether or not any bonds are associated with a bookmark More... | |
BOND_BOOKMARK_MAP * | getBondBookmarks () |
returns a pointer to all of our bond bookmarks More... | |
Conformers | |
const Conformer & | getConformer (int id=-1) const |
Conformer & | getConformer (int id=-1) |
void | removeConformer (unsigned int id) |
Delete the conformation with the specified ID. More... | |
void | clearConformers () |
Clear all the conformations on the molecule. More... | |
unsigned int | addConformer (Conformer *conf, bool assignId=false) |
Add a new conformation to the molecule. More... | |
unsigned int | getNumConformers () const |
Topology | |
RingInfo * | getRingInfo () const |
ADJ_ITER_PAIR | getAtomNeighbors (Atom const *at) const |
provides access to all neighbors around an Atom More... | |
OBOND_ITER_PAIR | getAtomBonds (Atom const *at) const |
provides access to all Bond objects connected to an Atom More... | |
ATOM_ITER_PAIR | getVertices () |
returns an iterator pair for looping over all Atoms More... | |
BOND_ITER_PAIR | getEdges () |
returns an iterator pair for looping over all Bonds More... | |
ATOM_ITER_PAIR | getVertices () const |
This is an overloaded member function, provided for convenience. It differs from the above function only in what argument(s) it accepts. More... | |
BOND_ITER_PAIR | getEdges () const |
This is an overloaded member function, provided for convenience. It differs from the above function only in what argument(s) it accepts. More... | |
const MolGraph & | getTopology () const |
brief returns a pointer to our underlying BGL object More... | |
Iterators | |
AtomIterator | beginAtoms () |
get an AtomIterator pointing at our first Atom More... | |
ConstAtomIterator | beginAtoms () const |
This is an overloaded member function, provided for convenience. It differs from the above function only in what argument(s) it accepts. More... | |
AtomIterator | endAtoms () |
get an AtomIterator pointing at the end of our Atoms More... | |
ConstAtomIterator | endAtoms () const |
This is an overloaded member function, provided for convenience. It differs from the above function only in what argument(s) it accepts. More... | |
BondIterator | beginBonds () |
get a BondIterator pointing at our first Bond More... | |
ConstBondIterator | beginBonds () const |
This is an overloaded member function, provided for convenience. It differs from the above function only in what argument(s) it accepts. More... | |
BondIterator | endBonds () |
get a BondIterator pointing at the end of our Bonds More... | |
ConstBondIterator | endBonds () const |
This is an overloaded member function, provided for convenience. It differs from the above function only in what argument(s) it accepts. More... | |
AromaticAtomIterator | beginAromaticAtoms () |
get an AtomIterator pointing at our first aromatic Atom More... | |
ConstAromaticAtomIterator | beginAromaticAtoms () const |
This is an overloaded member function, provided for convenience. It differs from the above function only in what argument(s) it accepts. More... | |
AromaticAtomIterator | endAromaticAtoms () |
get an AtomIterator pointing at the end of our Atoms More... | |
ConstAromaticAtomIterator | endAromaticAtoms () const |
This is an overloaded member function, provided for convenience. It differs from the above function only in what argument(s) it accepts. More... | |
HeteroatomIterator | beginHeteros () |
get an AtomIterator pointing at our first hetero Atom More... | |
ConstHeteroatomIterator | beginHeteros () const |
This is an overloaded member function, provided for convenience. It differs from the above function only in what argument(s) it accepts. More... | |
HeteroatomIterator | endHeteros () |
get an AtomIterator pointing at the end of our Atoms More... | |
ConstHeteroatomIterator | endHeteros () const |
This is an overloaded member function, provided for convenience. It differs from the above function only in what argument(s) it accepts. More... | |
QueryAtomIterator | beginQueryAtoms (QueryAtom const *query) |
get an AtomIterator pointing at our first Atom that matches query More... | |
ConstQueryAtomIterator | beginQueryAtoms (QueryAtom const *) const |
This is an overloaded member function, provided for convenience. It differs from the above function only in what argument(s) it accepts. More... | |
QueryAtomIterator | endQueryAtoms () |
get an AtomIterator pointing at the end of our Atoms More... | |
ConstQueryAtomIterator | endQueryAtoms () const |
This is an overloaded member function, provided for convenience. It differs from the above function only in what argument(s) it accepts. More... | |
MatchingAtomIterator | beginMatchingAtoms (bool(*query)(Atom *)) |
get an AtomIterator pointing at our first Atom that matches query More... | |
ConstMatchingAtomIterator | beginMatchingAtoms (bool(*query)(const Atom *)) const |
This is an overloaded member function, provided for convenience. It differs from the above function only in what argument(s) it accepts. More... | |
MatchingAtomIterator | endMatchingAtoms () |
get an AtomIterator pointing at the end of our Atoms More... | |
ConstMatchingAtomIterator | endMatchingAtoms () const |
This is an overloaded member function, provided for convenience. It differs from the above function only in what argument(s) it accepts. More... | |
ConformerIterator | beginConformers () |
ConformerIterator | endConformers () |
ConstConformerIterator | beginConformers () const |
ConstConformerIterator | endConformers () const |
Properties | |
void | clearComputedProps (bool includeRings=true) const |
clears all of our computed properties More... | |
void | updatePropertyCache (bool strict=true) |
calculates any of our lazy properties More... | |
bool | needsUpdatePropertyCache () const |
![]() | |
RDProps () | |
RDProps (const RDProps &rhs) | |
RDProps & | operator= (const RDProps &rhs) |
void | clear () |
const Dict & | getDict () const |
gets the underlying Dictionary More... | |
Dict & | getDict () |
STR_VECT | getPropList (bool includePrivate=true, bool includeComputed=true) const |
returns a list with the names of our properties More... | |
template<typename T > | |
void | setProp (const std::string &key, T val, bool computed=false) const |
sets a property value More... | |
template<typename T > | |
void | getProp (const std::string &key, T &res) const |
allows retrieval of a particular property value More... | |
template<typename T > | |
T | getProp (const std::string &key) const |
This is an overloaded member function, provided for convenience. It differs from the above function only in what argument(s) it accepts. More... | |
template<typename T > | |
bool | getPropIfPresent (const std::string &key, T &res) const |
bool | hasProp (const std::string &key) const |
This is an overloaded member function, provided for convenience. It differs from the above function only in what argument(s) it accepts. More... | |
void | clearProp (const std::string &key) const |
clears the value of a property More... | |
void | clearComputedProps () const |
clears all of our computed properties More... | |
void | updateProps (const RDProps &source, bool preserveExisting=false) |
update the properties from another More... | |
Friends | |
class | MolPickler |
class | RWMol |
Misc | |
RDKIT_GRAPHMOL_EXPORT std::vector< SubstanceGroup > & | getSubstanceGroups (ROMol &) |
const RDKIT_GRAPHMOL_EXPORT std::vector< SubstanceGroup > & | getSubstanceGroups (const ROMol &) |
unsigned int | numBonds |
void | debugMol (std::ostream &str) const |
sends some debugging info to a stream More... | |
Atom * | operator[] (const vertex_descriptor &v) |
const Atom * | operator[] (const vertex_descriptor &v) const |
Bond * | operator[] (const edge_descriptor &e) |
const Bond * | operator[] (const edge_descriptor &e) const |
const std::vector< StereoGroup > & | getStereoGroups () const |
Gets a reference to the groups of atoms with relative stereochemistry. More... | |
Additional Inherited Members | |
![]() | |
Dict | d_props |
|
inline |
copy constructor with a twist
other | the molecule to be copied |
quickCopy | (optional) if this is true, the resulting ROMol will not copy any of the properties or bookmarks and conformers from other . This can make the copy substantially faster (thus the name). |
confId | (optional) if this is >=0, the resulting ROMol will contain only the specified conformer from other . |
RDKit::ROMol::ROMol | ( | const std::string & | binStr | ) |
construct a molecule from a pickle string
unsigned int RDKit::ROMol::addConformer | ( | Conformer * | conf, |
bool | assignId = false |
||
) |
Add a new conformation to the molecule.
conf | - conformation to be added to the molecule, this molecule takes ownership of the conformer |
assignId | - a unique ID will be assigned to the conformation if true otherwise it is assumed that the conformation already has an (unique) ID set |
|
inline |
C++11 Range iterator.
Usage
Definition at line 249 of file ROMol.h.
Referenced by RDKit::FileParserUtils::getAtomPropertyList().
|
inline |
AromaticAtomIterator RDKit::ROMol::beginAromaticAtoms | ( | ) |
get an AtomIterator pointing at our first aromatic Atom
ConstAromaticAtomIterator RDKit::ROMol::beginAromaticAtoms | ( | ) | const |
This is an overloaded member function, provided for convenience. It differs from the above function only in what argument(s) it accepts.
AtomIterator RDKit::ROMol::beginAtoms | ( | ) |
get an AtomIterator pointing at our first Atom
ConstAtomIterator RDKit::ROMol::beginAtoms | ( | ) | const |
This is an overloaded member function, provided for convenience. It differs from the above function only in what argument(s) it accepts.
BondIterator RDKit::ROMol::beginBonds | ( | ) |
get a BondIterator pointing at our first Bond
ConstBondIterator RDKit::ROMol::beginBonds | ( | ) | const |
This is an overloaded member function, provided for convenience. It differs from the above function only in what argument(s) it accepts.
|
inline |
Definition at line 615 of file ROMol.h.
Referenced by RDKit::ForceFieldsHelper::detail::OptimizeMoleculeConfsST().
|
inline |
HeteroatomIterator RDKit::ROMol::beginHeteros | ( | ) |
get an AtomIterator pointing at our first hetero Atom
ConstHeteroatomIterator RDKit::ROMol::beginHeteros | ( | ) | const |
This is an overloaded member function, provided for convenience. It differs from the above function only in what argument(s) it accepts.
MatchingAtomIterator RDKit::ROMol::beginMatchingAtoms | ( | bool(*)(Atom *) | query | ) |
get an AtomIterator pointing at our first Atom that matches query
ConstMatchingAtomIterator RDKit::ROMol::beginMatchingAtoms | ( | bool(*)(const Atom *) | query | ) | const |
This is an overloaded member function, provided for convenience. It differs from the above function only in what argument(s) it accepts.
ConstQueryAtomIterator RDKit::ROMol::beginQueryAtoms | ( | QueryAtom const * | ) | const |
This is an overloaded member function, provided for convenience. It differs from the above function only in what argument(s) it accepts.
QueryAtomIterator RDKit::ROMol::beginQueryAtoms | ( | QueryAtom const * | query | ) |
get an AtomIterator pointing at our first Atom that matches query
|
inline |
|
inline |
|
inline |
|
inline |
void RDKit::ROMol::clearAtomBookmark | ( | int | mark | ) |
removes a bookmark
from our collection
void RDKit::ROMol::clearAtomBookmark | ( | int | mark, |
const Atom * | atom | ||
) |
removes a particular Atom from the list associated with the bookmark
void RDKit::ROMol::clearBondBookmark | ( | int | mark | ) |
removes a bookmark
from our collection
void RDKit::ROMol::clearBondBookmark | ( | int | mark, |
const Bond * | bond | ||
) |
removes a particular Bond from the list associated with the bookmark
void RDKit::ROMol::clearComputedProps | ( | bool | includeRings = true | ) | const |
clears all of our computed
properties
|
inline |
void RDKit::ROMol::debugMol | ( | std::ostream & | str | ) | const |
sends some debugging info to a stream
AromaticAtomIterator RDKit::ROMol::endAromaticAtoms | ( | ) |
get an AtomIterator pointing at the end of our Atoms
ConstAromaticAtomIterator RDKit::ROMol::endAromaticAtoms | ( | ) | const |
This is an overloaded member function, provided for convenience. It differs from the above function only in what argument(s) it accepts.
AtomIterator RDKit::ROMol::endAtoms | ( | ) |
get an AtomIterator pointing at the end of our Atoms
ConstAtomIterator RDKit::ROMol::endAtoms | ( | ) | const |
This is an overloaded member function, provided for convenience. It differs from the above function only in what argument(s) it accepts.
BondIterator RDKit::ROMol::endBonds | ( | ) |
get a BondIterator pointing at the end of our Bonds
ConstBondIterator RDKit::ROMol::endBonds | ( | ) | const |
This is an overloaded member function, provided for convenience. It differs from the above function only in what argument(s) it accepts.
|
inline |
Definition at line 617 of file ROMol.h.
Referenced by RDKit::ForceFieldsHelper::detail::OptimizeMoleculeConfsST().
|
inline |
HeteroatomIterator RDKit::ROMol::endHeteros | ( | ) |
get an AtomIterator pointing at the end of our Atoms
ConstHeteroatomIterator RDKit::ROMol::endHeteros | ( | ) | const |
This is an overloaded member function, provided for convenience. It differs from the above function only in what argument(s) it accepts.
MatchingAtomIterator RDKit::ROMol::endMatchingAtoms | ( | ) |
get an AtomIterator pointing at the end of our Atoms
ConstMatchingAtomIterator RDKit::ROMol::endMatchingAtoms | ( | ) | const |
This is an overloaded member function, provided for convenience. It differs from the above function only in what argument(s) it accepts.
QueryAtomIterator RDKit::ROMol::endQueryAtoms | ( | ) |
get an AtomIterator pointing at the end of our Atoms
ConstQueryAtomIterator RDKit::ROMol::endQueryAtoms | ( | ) | const |
This is an overloaded member function, provided for convenience. It differs from the above function only in what argument(s) it accepts.
ATOM_PTR_LIST& RDKit::ROMol::getAllAtomsWithBookmark | ( | int | mark | ) |
returns all Atoms associated with the bookmark
provided
BOND_PTR_LIST& RDKit::ROMol::getAllBondsWithBookmark | ( | int | mark | ) |
returns all bonds associated with the bookmark
provided
OBOND_ITER_PAIR RDKit::ROMol::getAtomBonds | ( | Atom const * | at | ) | const |
provides access to all Bond objects connected to an Atom
at | the atom whose neighbors we are looking for |
Usage
or, if you need a non-const Bond *:
Referenced by RDKit::queryAtomHasRingBond(), and RDKit::queryAtomRingBondCount().
|
inline |
returns a pointer to all of our atom bookmarks
Definition at line 387 of file ROMol.h.
Referenced by RDKit::SLNParse::addBranchToMol().
unsigned int RDKit::ROMol::getAtomDegree | ( | const Atom * | at | ) | const |
returns the degree (number of neighbors) of an Atom in the graph
ADJ_ITER_PAIR RDKit::ROMol::getAtomNeighbors | ( | Atom const * | at | ) | const |
provides access to all neighbors around an Atom
at | the atom whose neighbors we are looking for |
Usage
Referenced by RDKit::queryAtomHasAliphaticHeteroatomNbrs(), RDKit::queryAtomHasHeteroatomNbrs(), RDKit::queryAtomHeavyAtomDegree(), RDKit::queryAtomNumAliphaticHeteroatomNbrs(), and RDKit::queryAtomNumHeteroatomNbrs().
Atom* RDKit::ROMol::getAtomWithBookmark | ( | int | mark | ) |
returns the first Atom associated with the bookmark
provided
Referenced by RDKit::SLNParse::closeRingBond().
|
inline |
|
inline |
Atom* RDKit::ROMol::getAtomWithIdx | ( | unsigned int | idx | ) |
returns a pointer to a particular Atom
Referenced by RDKit::SLNParse::addBranchToMol(), and RDKit::FileParserUtils::applyMolListPropToAtoms().
const Atom* RDKit::ROMol::getAtomWithIdx | ( | unsigned int | idx | ) | const |
This is an overloaded member function, provided for convenience. It differs from the above function only in what argument(s) it accepts.
|
inline |
|
inline |
Bond* RDKit::ROMol::getBondBetweenAtoms | ( | unsigned int | idx1, |
unsigned int | idx2 | ||
) |
returns a pointer to the bond between two atoms, Null on failure
Referenced by RDKit::FMCS::TargetMatch::init().
const Bond* RDKit::ROMol::getBondBetweenAtoms | ( | unsigned int | idx1, |
unsigned int | idx2 | ||
) | const |
This is an overloaded member function, provided for convenience. It differs from the above function only in what argument(s) it accepts.
|
inline |
returns a pointer to all of our bond bookmarks
Definition at line 410 of file ROMol.h.
Referenced by RDKit::SLNParse::addBranchToMol().
Bond* RDKit::ROMol::getBondWithBookmark | ( | int | mark | ) |
returns the first Bond associated with the bookmark
provided
|
inline |
|
inline |
const Bond* RDKit::ROMol::getBondWithIdx | ( | unsigned int | idx | ) | const |
This is an overloaded member function, provided for convenience. It differs from the above function only in what argument(s) it accepts.
Conformer& RDKit::ROMol::getConformer | ( | int | id = -1 | ) |
return the conformer with a specified ID if the ID is negative the first conformation will be returned
const Conformer& RDKit::ROMol::getConformer | ( | int | id = -1 | ) | const |
return the conformer with a specified ID if the ID is negative the first conformation will be returned
BOND_ITER_PAIR RDKit::ROMol::getEdges | ( | ) |
returns an iterator pair for looping over all Bonds
Usage
BOND_ITER_PAIR RDKit::ROMol::getEdges | ( | ) | const |
This is an overloaded member function, provided for convenience. It differs from the above function only in what argument(s) it accepts.
unsigned int RDKit::ROMol::getNumAtoms | ( | bool | onlyExplicit = 1 | ) | const |
unsigned int RDKit::ROMol::getNumBonds | ( | bool | onlyHeavy = 1 | ) | const |
returns our number of Bonds
Referenced by RDKit::FMCS::RingMatchTableSet::addTargetBondRingsIndeces(), RDKit::FMCS::TargetMatch::init(), and RDKit::FMCS::RingMatchTableSet::init().
|
inline |
Definition at line 443 of file ROMol.h.
Referenced by RDKit::MMFF::MMFFOptimizeMoleculeConfs(), RDKit::ForceFieldsHelper::OptimizeMoleculeConfs(), and RDKit::ForceFieldsHelper::detail::OptimizeMoleculeConfsST().
unsigned int RDKit::ROMol::getNumHeavyAtoms | ( | ) | const |
returns our number of heavy atoms (atomic number > 1)
|
inline |
returns a pointer to our RingInfo structure Note: the client should not delete this.
Definition at line 452 of file ROMol.h.
Referenced by RDKit::FMCS::RingMatchTableSet::addTargetBondRingsIndeces(), RDKit::FMCS::RingMatchTableSet::computeRingMatchTable(), RDKit::FMCS::RingMatchTableSet::init(), RDKit::queryAtomHasRingBond(), RDKit::queryAtomIsInRingOfSize(), RDKit::queryAtomMinRingSize(), RDKit::queryAtomRingBondCount(), RDKit::queryAtomRingMembership(), RDKit::queryBondIsInRingOfSize(), RDKit::queryBondMinRingSize(), RDKit::queryIsAtomInNRings(), RDKit::queryIsAtomInRing(), RDKit::queryIsBondInNRings(), and RDKit::queryIsBondInRing().
|
inline |
|
inline |
brief returns a pointer to our underlying BGL object
This can be useful if you need to call other BGL algorithms:
Here's an example:
Definition at line 555 of file ROMol.h.
Referenced by RDKit::queryAtomHasRingBond(), and RDKit::queryAtomRingBondCount().
Atom* RDKit::ROMol::getUniqueAtomWithBookmark | ( | int | mark | ) |
returns the Atom associated with the bookmark
provided a check is made to ensure it is the only atom with that bookmark
Bond* RDKit::ROMol::getUniqueBondWithBookmark | ( | int | mark | ) |
returns the Bond associated with the bookmark
provided a check is made to ensure it is the only bond with that bookmark
ATOM_ITER_PAIR RDKit::ROMol::getVertices | ( | ) |
returns an iterator pair for looping over all Atoms
Usage
ATOM_ITER_PAIR RDKit::ROMol::getVertices | ( | ) | const |
This is an overloaded member function, provided for convenience. It differs from the above function only in what argument(s) it accepts.
|
inline |
queries whether or not any atoms are associated with a bookmark
Definition at line 385 of file ROMol.h.
Referenced by RDKit::SLNParse::addBranchToMol(), and RDKit::SLNParse::closeRingBond().
|
inline |
queries whether or not any bonds are associated with a bookmark
Definition at line 408 of file ROMol.h.
Referenced by RDKit::SLNParse::addBranchToMol().
bool RDKit::ROMol::needsUpdatePropertyCache | ( | ) | const |
|
inline |
|
inline |
|
inline |
|
inline |
void RDKit::ROMol::removeConformer | ( | unsigned int | id | ) |
Delete the conformation with the specified ID.
|
inline |
|
inline |
associates an Atom pointer with a bookmark
Definition at line 362 of file ROMol.h.
Referenced by RDKit::SLNParse::addBranchToMol().
|
inline |
associates a Bond pointer with a bookmark
Definition at line 390 of file ROMol.h.
Referenced by RDKit::SLNParse::addBranchToMol(), and RDKit::SLNParse::closeRingBond().
void RDKit::ROMol::updatePropertyCache | ( | bool | strict = true | ) |
calculates any of our lazy properties
Notes:
updatePropertyCache()
on each of our Atoms and Bonds Referenced by RDKit::CachedTrustedSmilesMolHolder::getMol().
|
friend |
|
friend |
|
friend |