![]() |
RDKit
Open-source cheminformatics and machine learning.
|
Namespaces | |
namespace | defaults |
namespace | TautomerScoringFunctions |
Typedefs | |
typedef RDCatalog::HierarchCatalog< AcidBaseCatalogEntry, AcidBaseCatalogParams, int > | AcidBaseCatalog |
typedef RDCatalog::HierarchCatalog< FragmentCatalogEntry, FragmentCatalogParams, int > | FragmentCatalog |
typedef RDCatalog::HierarchCatalog< TransformCatalogEntry, TransformCatalogParams, int > | TransformCatalog |
typedef std::pair< std::string, ROMOL_SPTR > | SmilesMolPair |
typedef RDCatalog::HierarchCatalog< TautomerCatalogEntry, TautomerCatalogParams, int > | TautomerCatalog |
typedef std::map< std::string, Tautomer > | SmilesTautomerMap |
typedef std::pair< std::string, Tautomer > | SmilesTautomerPair |
using | TautomerTransformDefs = std::vector< std::tuple< std::string, std::string, std::string, std::string > > |
Enumerations | |
enum class | TautomerEnumeratorStatus { Completed = 0 , MaxTautomersReached , MaxTransformsReached , Canceled } |
Variables | |
RDKIT_MOLSTANDARDIZE_EXPORT const CleanupParameters | defaultCleanupParameters |
RDKIT_MOLSTANDARDIZE_EXPORT std::vector< ChargeCorrection > | CHARGE_CORRECTIONS |
typedef RDCatalog::HierarchCatalog<FragmentCatalogEntry, FragmentCatalogParams, int> RDKit::MolStandardize::FragmentCatalog |
Definition at line 29 of file Fragment.h.
typedef std::pair<std::string, ROMOL_SPTR> RDKit::MolStandardize::SmilesMolPair |
Definition at line 35 of file Normalize.h.
typedef std::map<std::string, Tautomer> RDKit::MolStandardize::SmilesTautomerMap |
Definition at line 74 of file MolStandardize/Tautomer.h.
typedef std::pair<std::string, Tautomer> RDKit::MolStandardize::SmilesTautomerPair |
Definition at line 75 of file MolStandardize/Tautomer.h.
typedef RDCatalog::HierarchCatalog<TautomerCatalogEntry, TautomerCatalogParams, int> RDKit::MolStandardize::TautomerCatalog |
Definition at line 33 of file MolStandardize/Tautomer.h.
using RDKit::MolStandardize::TautomerTransformDefs = typedef std::vector<std::tuple<std::string, std::string, std::string, std::string> > |
Definition at line 27 of file TautomerCatalogParams.h.
typedef RDCatalog::HierarchCatalog<TransformCatalogEntry, TransformCatalogParams, int> RDKit::MolStandardize::TransformCatalog |
Definition at line 34 of file Normalize.h.
Enumerator | |
---|---|
Completed | |
MaxTautomersReached | |
MaxTransformsReached | |
Canceled |
Definition at line 47 of file MolStandardize/Tautomer.h.
RDKIT_MOLSTANDARDIZE_EXPORT RWMol * RDKit::MolStandardize::canonicalTautomer | ( | const RWMol * | mol, |
const CleanupParameters & | params = defaultCleanupParameters |
||
) |
Works the same as TautomerEnumerator().canonicalize(mol)
RDKIT_MOLSTANDARDIZE_EXPORT RWMol * RDKit::MolStandardize::chargeParent | ( | const RWMol & | mol, |
const CleanupParameters & | params = defaultCleanupParameters , |
||
bool | skip_standardize = false |
||
) |
Returns the charge parent of a given molecule. The charge parent is the uncharged version of the fragment parent.
|
inline |
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 102 of file MolStandardize.h.
References cleanup().
RDKIT_MOLSTANDARDIZE_EXPORT RWMol * RDKit::MolStandardize::cleanup | ( | const RWMol * | mol, |
const CleanupParameters & | params = defaultCleanupParameters |
||
) |
The cleanup function is equivalent to the molvs.Standardizer().standardize(mol) function. It calls the same steps, namely: RemoveHs, RDKit SanitizeMol, MetalDisconnector, Normalizer, Reionizer, RDKit AssignStereochemistry.
Referenced by cleanup().
RDKIT_MOLSTANDARDIZE_EXPORT void RDKit::MolStandardize::cleanupInPlace | ( | RWMol & | mol, |
const CleanupParameters & | params = defaultCleanupParameters |
||
) |
Works the same as cleanup(mol)
RDKIT_MOLSTANDARDIZE_EXPORT ROMol * RDKit::MolStandardize::disconnectOrganometallics | ( | const ROMol & | mol, |
RDKit::MolStandardize::MetalDisconnectorOptions | mdo = { true, true, false, true} |
||
) |
As above, but returns new disconnected molecule.
RDKIT_MOLSTANDARDIZE_EXPORT void RDKit::MolStandardize::disconnectOrganometallics | ( | RWMol & | mol, |
RDKit::MolStandardize::MetalDisconnectorOptions | mdo = { true, true, false, true} |
||
) |
Do a disconnection of an organometallic complex according to rules preferred by Syngenta. All bonds to metals are broken, including covalent bonds to Group I/II metals (so including Grignards, lithium complexes etc.). The ligands are left in the charge states they came in with. If there are haptic bonds defined by a dummy atom bonded to a metal by a bond that has a _MolFileBondEndPts (which will contain the indices of the atoms involved in the haptic bond) then the dummy atom is removed also. Do the disconnection in place. The options are splitGrignards, splitAromaticC, adjustCharges and removeHapticDummies. Roll on C++20 and designated initializers!
|
inline |
As above, included for API consistency.
Definition at line 204 of file MolStandardize.h.
RDKIT_MOLSTANDARDIZE_EXPORT std::vector< std::string > RDKit::MolStandardize::enumerateTautomerSmiles | ( | const std::string & | smiles, |
const CleanupParameters & | params = defaultCleanupParameters |
||
) |
TODO.
RDKIT_MOLSTANDARDIZE_EXPORT RWMol * RDKit::MolStandardize::fragmentParent | ( | const RWMol & | mol, |
const CleanupParameters & | params = defaultCleanupParameters , |
||
bool | skip_standardize = false |
||
) |
Returns the fragment parent of a given molecule. The fragment parent is the largest organic covalent unit in the molecule.
|
inline |
Definition at line 62 of file Fragment.h.
References RDKit::MolStandardize::CleanupParameters::fragmentData, RDKit::MolStandardize::CleanupParameters::fragmentFile, and RDKit::rdvalue_is().
|
inline |
Definition at line 419 of file MolStandardize/Tautomer.h.
References RDKit::MolStandardize::defaults::defaultTautomerTransformsv1, and RDKit::rdvalue_is().
RDKIT_MOLSTANDARDIZE_EXPORT RWMol * RDKit::MolStandardize::isotopeParent | ( | const RWMol & | mol, |
const CleanupParameters & | params = defaultCleanupParameters , |
||
bool | skip_standardize = false |
||
) |
removes all isotopes specifications from the given molecule
RDKIT_MOLSTANDARDIZE_EXPORT RWMol * RDKit::MolStandardize::normalize | ( | const RWMol * | mol, |
const CleanupParameters & | params = defaultCleanupParameters |
||
) |
Works the same as Normalizer().normalize(mol)
RDKIT_MOLSTANDARDIZE_EXPORT void RDKit::MolStandardize::normalizeInPlace | ( | RWMol & | mol, |
const CleanupParameters & | params = defaultCleanupParameters |
||
) |
Works the same as Normalizer().normalizeInPlace(mol)
|
inline |
Definition at line 95 of file Normalize.h.
References RDKit::MolStandardize::CleanupParameters::maxRestarts, RDKit::MolStandardize::CleanupParameters::normalizationData, and RDKit::MolStandardize::CleanupParameters::normalizations.
RDKIT_MOLSTANDARDIZE_EXPORT std::vector< std::shared_ptr< ROMol > > RDKit::MolStandardize::readFuncGroups | ( | const std::vector< std::pair< std::string, std::string > > & | data | ) |
RDKIT_MOLSTANDARDIZE_EXPORT std::vector< std::shared_ptr< ROMol > > RDKit::MolStandardize::readFuncGroups | ( | std::istream & | inStream, |
int | nToRead = -1 |
||
) |
RDKIT_MOLSTANDARDIZE_EXPORT std::vector< std::shared_ptr< ROMol > > RDKit::MolStandardize::readFuncGroups | ( | std::string | fileName | ) |
RDKIT_MOLSTANDARDIZE_EXPORT std::vector< std::pair< ROMOL_SPTR, ROMOL_SPTR > > RDKit::MolStandardize::readPairs | ( | const std::vector< std::tuple< std::string, std::string, std::string > > & | data | ) |
RDKIT_MOLSTANDARDIZE_EXPORT std::vector< std::pair< ROMOL_SPTR, ROMOL_SPTR > > RDKit::MolStandardize::readPairs | ( | std::istream & | inStream, |
int | nToRead = -1 |
||
) |
RDKIT_MOLSTANDARDIZE_EXPORT std::vector< std::pair< ROMOL_SPTR, ROMOL_SPTR > > RDKit::MolStandardize::readPairs | ( | std::string | fileName | ) |
RDKIT_MOLSTANDARDIZE_EXPORT std::vector< TautomerTransform > RDKit::MolStandardize::readTautomers | ( | const std::vector< std::tuple< std::string, std::string, std::string, std::string > > & | data | ) |
RDKIT_MOLSTANDARDIZE_EXPORT std::vector< TautomerTransform > RDKit::MolStandardize::readTautomers | ( | std::istream & | inStream, |
int | nToRead = -1 |
||
) |
RDKIT_MOLSTANDARDIZE_EXPORT std::vector< TautomerTransform > RDKit::MolStandardize::readTautomers | ( | std::string | fileName | ) |
RDKIT_MOLSTANDARDIZE_EXPORT std::vector< std::shared_ptr< ChemicalReaction > > RDKit::MolStandardize::readTransformations | ( | const std::vector< std::pair< std::string, std::string > > & | data | ) |
RDKIT_MOLSTANDARDIZE_EXPORT std::vector< std::shared_ptr< ChemicalReaction > > RDKit::MolStandardize::readTransformations | ( | std::istream & | inStream, |
int | nToRead = -1 |
||
) |
RDKIT_MOLSTANDARDIZE_EXPORT std::vector< std::shared_ptr< ChemicalReaction > > RDKit::MolStandardize::readTransformations | ( | std::string | fileName | ) |
RDKIT_MOLSTANDARDIZE_EXPORT RWMol * RDKit::MolStandardize::reionize | ( | const RWMol * | mol, |
const CleanupParameters & | params = defaultCleanupParameters |
||
) |
Works the same as Reionizer().reionize(mol)
RDKIT_MOLSTANDARDIZE_EXPORT void RDKit::MolStandardize::reionizeInPlace | ( | RWMol & | mol, |
const CleanupParameters & | params = defaultCleanupParameters |
||
) |
Works the same as Reionizer().reionizeInPlace(mol)
|
inline |
Definition at line 106 of file Charge.h.
References RDKit::MolStandardize::CleanupParameters::acidbaseData, and RDKit::MolStandardize::CleanupParameters::acidbaseFile.
RDKIT_MOLSTANDARDIZE_EXPORT RWMol * RDKit::MolStandardize::removeFragments | ( | const RWMol * | mol, |
const CleanupParameters & | params = defaultCleanupParameters |
||
) |
Works the same as FragmentRemover().remove(mol)
RDKIT_MOLSTANDARDIZE_EXPORT void RDKit::MolStandardize::removeFragmentsInPlace | ( | RWMol & | mol, |
const CleanupParameters & | params = defaultCleanupParameters |
||
) |
Works the same as FragmentRemover().removeInPlace(mol)
RDKIT_MOLSTANDARDIZE_EXPORT std::string RDKit::MolStandardize::standardizeSmiles | ( | const std::string & | smiles | ) |
Convenience function for quickly standardizing a single SMILES string. Returns a standardized canonical SMILES string given a SMILES string. This is the equivalent of calling cleanup() on each of the molecules
RDKIT_MOLSTANDARDIZE_EXPORT RWMol * RDKit::MolStandardize::stereoParent | ( | const RWMol & | mol, |
const CleanupParameters & | params = defaultCleanupParameters , |
||
bool | skip_standardize = false |
||
) |
calls removeStereochemistry() on the given molecule
RDKIT_MOLSTANDARDIZE_EXPORT std::vector< Bond::BondType > RDKit::MolStandardize::stringToBondType | ( | std::string | bond_str | ) |
RDKIT_MOLSTANDARDIZE_EXPORT std::vector< int > RDKit::MolStandardize::stringToCharge | ( | std::string | charge_str | ) |
RDKIT_MOLSTANDARDIZE_EXPORT RWMol * RDKit::MolStandardize::superParent | ( | const RWMol & | mol, |
const CleanupParameters & | params = defaultCleanupParameters , |
||
bool | skip_standardize = false |
||
) |
Returns the super parent. The super parent is the fragment, charge, isotope, stereo, and tautomer parent of the molecule.
|
inline |
Definition at line 414 of file MolStandardize/Tautomer.h.
RDKIT_MOLSTANDARDIZE_EXPORT RWMol * RDKit::MolStandardize::tautomerParent | ( | const RWMol & | mol, |
const CleanupParameters & | params = defaultCleanupParameters , |
||
bool | skipStandardize = false |
||
) |
Returns the tautomer parent of a given molecule. The fragment parent is the standardized canonical tautomer of the molecule
RDKIT_MOLSTANDARDIZE_EXPORT void RDKit::MolStandardize::updateCleanupParamsFromJSON | ( | CleanupParameters & | params, |
const std::string & | json | ||
) |
RDKIT_MOLSTANDARDIZE_EXPORT std::vector< ValidationErrorInfo > RDKit::MolStandardize::validateSmiles | ( | const std::string & | smiles | ) |
A convenience function for quickly validating a single SMILES string.
References validateSmiles().
Referenced by validateSmiles().
|
extern |
|
extern |
Definition at line 25 of file Fragment.h.