RDKit
Open-source cheminformatics and machine learning.
Loading...
Searching...
No Matches
RDKit::MolStandardize Namespace Reference

Namespaces

namespace  defaults
 
namespace  TautomerScoringFunctions
 

Classes

class  AcidBaseCatalogEntry
 
class  AcidBaseCatalogParams
 
class  AllowedAtomsValidation
 
struct  ChargeCorrection
 
struct  CleanupParameters
 
class  DisallowedAtomsValidation
 
class  FragmentCatalogEntry
 
class  FragmentCatalogParams
 
class  FragmentRemover
 
class  FragmentValidation
 The FragmentValidation class logs if certain fragments are present. More...
 
class  IsotopeValidation
 The IsotopeValidation class logs if molecule contains isotopes. More...
 
class  LargestFragmentChooser
 
class  MetalDisconnector
 
struct  MetalDisconnectorOptions
 
class  MolVSValidation
 The MolVSValidation class can be used to perform all MolVSValidions. More...
 
class  MolVSValidations
 MolVS Validations. More...
 
class  NeutralValidation
 The NeutralValidation class logs if not an overall neutral system. More...
 
class  NoAtomValidation
 
class  Normalizer
 The Normalizer class for applying Normalization transforms. More...
 
class  RDKitValidation
 
class  Reionizer
 
class  Tautomer
 
class  TautomerCatalogEntry
 
class  TautomerCatalogParams
 
class  TautomerEnumerator
 
class  TautomerEnumeratorCallback
 
class  TautomerEnumeratorResult
 Contains results of tautomer enumeration. More...
 
class  TautomerTransform
 
class  TransformCatalogEntry
 
class  TransformCatalogParams
 
class  Uncharger
 The Uncharger class for neutralizing ionized acids and bases. More...
 
class  ValidationErrorInfo
 
class  ValidationMethod
 

Typedefs

typedef RDCatalog::HierarchCatalog< AcidBaseCatalogEntry, AcidBaseCatalogParams, intAcidBaseCatalog
 
typedef RDCatalog::HierarchCatalog< FragmentCatalogEntry, FragmentCatalogParams, intFragmentCatalog
 
typedef RDCatalog::HierarchCatalog< TransformCatalogEntry, TransformCatalogParams, intTransformCatalog
 
typedef std::pair< std::string, ROMOL_SPTRSmilesMolPair
 
typedef RDCatalog::HierarchCatalog< TautomerCatalogEntry, TautomerCatalogParams, intTautomerCatalog
 
typedef std::map< std::string, TautomerSmilesTautomerMap
 
typedef std::pair< std::string, TautomerSmilesTautomerPair
 
using TautomerTransformDefs = std::vector< std::tuple< std::string, std::string, std::string, std::string > >
 

Enumerations

enum class  TautomerEnumeratorStatus { Completed = 0 , MaxTautomersReached , MaxTransformsReached , Canceled }
 

Functions

RDKIT_MOLSTANDARDIZE_EXPORT std::vector< std::pair< ROMOL_SPTR, ROMOL_SPTR > > readPairs (std::string fileName)
 
RDKIT_MOLSTANDARDIZE_EXPORT std::vector< std::pair< ROMOL_SPTR, ROMOL_SPTR > > readPairs (std::istream &inStream, int nToRead=-1)
 
RDKIT_MOLSTANDARDIZE_EXPORT std::vector< std::pair< ROMOL_SPTR, ROMOL_SPTR > > readPairs (const std::vector< std::tuple< std::string, std::string, std::string > > &data)
 
ReionizerreionizerFromParams (const CleanupParameters &params)
 
FragmentRemoverfragmentRemoverFromParams (const CleanupParameters &params, bool leave_last=true, bool skip_if_all_match=false)
 
RDKIT_MOLSTANDARDIZE_EXPORT std::vector< std::shared_ptr< ROMol > > readFuncGroups (std::string fileName)
 
RDKIT_MOLSTANDARDIZE_EXPORT std::vector< std::shared_ptr< ROMol > > readFuncGroups (std::istream &inStream, int nToRead=-1)
 
RDKIT_MOLSTANDARDIZE_EXPORT std::vector< std::shared_ptr< ROMol > > readFuncGroups (const std::vector< std::pair< std::string, std::string > > &data)
 
RDKIT_MOLSTANDARDIZE_EXPORT void updateCleanupParamsFromJSON (CleanupParameters &params, const std::string &json)
 
RDKIT_MOLSTANDARDIZE_EXPORT RWMolcleanup (const RWMol *mol, const CleanupParameters &params=defaultCleanupParameters)
 
RWMolcleanup (const RWMol &mol, const CleanupParameters &params=defaultCleanupParameters)
 This is an overloaded member function, provided for convenience. It differs from the above function only in what argument(s) it accepts.
 
RDKIT_MOLSTANDARDIZE_EXPORT void cleanupInPlace (RWMol &mol, const CleanupParameters &params=defaultCleanupParameters)
 Works the same as cleanup(mol)
 
RDKIT_MOLSTANDARDIZE_EXPORT void cleanupInPlace (std::vector< RWMol * > &mols, int numThreads=1, const CleanupParameters &params=defaultCleanupParameters)
 Operates on multiple molecules.
 
RDKIT_MOLSTANDARDIZE_EXPORT RWMolnormalize (const RWMol *mol, const CleanupParameters &params=defaultCleanupParameters)
 Works the same as Normalizer().normalize(mol)
 
RDKIT_MOLSTANDARDIZE_EXPORT void normalizeInPlace (RWMol &mol, const CleanupParameters &params=defaultCleanupParameters)
 Works the same as Normalizer().normalizeInPlace(mol)
 
RDKIT_MOLSTANDARDIZE_EXPORT void normalizeInPlace (std::vector< RWMol * > &mols, int numThreads=1, const CleanupParameters &params=defaultCleanupParameters)
 Operates on multiple molecules.
 
RDKIT_MOLSTANDARDIZE_EXPORT RWMolreionize (const RWMol *mol, const CleanupParameters &params=defaultCleanupParameters)
 Works the same as Reionizer().reionize(mol)
 
RDKIT_MOLSTANDARDIZE_EXPORT void reionizeInPlace (RWMol &mol, const CleanupParameters &params=defaultCleanupParameters)
 Works the same as Reionizer().reionizeInPlace(mol)
 
RDKIT_MOLSTANDARDIZE_EXPORT void reionizeInPlace (std::vector< RWMol * > &mols, int numThreads=1, const CleanupParameters &params=defaultCleanupParameters)
 Operates on multiple molecules.
 
RDKIT_MOLSTANDARDIZE_EXPORT RWMolremoveFragments (const RWMol *mol, const CleanupParameters &params=defaultCleanupParameters)
 Works the same as FragmentRemover().remove(mol)
 
RDKIT_MOLSTANDARDIZE_EXPORT void removeFragmentsInPlace (RWMol &mol, const CleanupParameters &params=defaultCleanupParameters)
 Works the same as FragmentRemover().removeInPlace(mol)
 
RDKIT_MOLSTANDARDIZE_EXPORT void removeFragmentsInPlace (std::vector< RWMol * > &mols, int numThreads=1, const CleanupParameters &params=defaultCleanupParameters)
 Operates on multiple molecules.
 
RDKIT_MOLSTANDARDIZE_EXPORT RWMolcanonicalTautomer (const RWMol *mol, const CleanupParameters &params=defaultCleanupParameters)
 Works the same as TautomerEnumerator().canonicalize(mol)
 
RDKIT_MOLSTANDARDIZE_EXPORT RWMoltautomerParent (const RWMol &mol, const CleanupParameters &params=defaultCleanupParameters, bool skipStandardize=false)
 
RDKIT_MOLSTANDARDIZE_EXPORT RWMolfragmentParent (const RWMol &mol, const CleanupParameters &params=defaultCleanupParameters, bool skip_standardize=false)
 
RDKIT_MOLSTANDARDIZE_EXPORT RWMolstereoParent (const RWMol &mol, const CleanupParameters &params=defaultCleanupParameters, bool skip_standardize=false)
 calls removeStereochemistry() on the given molecule
 
RDKIT_MOLSTANDARDIZE_EXPORT RWMolisotopeParent (const RWMol &mol, const CleanupParameters &params=defaultCleanupParameters, bool skip_standardize=false)
 removes all isotopes specifications from the given molecule
 
RDKIT_MOLSTANDARDIZE_EXPORT RWMolchargeParent (const RWMol &mol, const CleanupParameters &params=defaultCleanupParameters, bool skip_standardize=false)
 
RDKIT_MOLSTANDARDIZE_EXPORT RWMolsuperParent (const RWMol &mol, const CleanupParameters &params=defaultCleanupParameters, bool skip_standardize=false)
 
RDKIT_MOLSTANDARDIZE_EXPORT std::string standardizeSmiles (const std::string &smiles)
 
RDKIT_MOLSTANDARDIZE_EXPORT void disconnectOrganometallics (RWMol &mol, RDKit::MolStandardize::MetalDisconnectorOptions mdo={ true, true, false, true})
 
RDKIT_MOLSTANDARDIZE_EXPORT ROMoldisconnectOrganometallics (const ROMol &mol, RDKit::MolStandardize::MetalDisconnectorOptions mdo={ true, true, false, true})
 As above, but returns new disconnected molecule.
 
void disconnectOrganometallicsInPlace (RWMol &mol, RDKit::MolStandardize::MetalDisconnectorOptions mdo={ true, true, false, true})
 As above, included for API consistency.
 
RDKIT_MOLSTANDARDIZE_EXPORT std::vector< std::string > enumerateTautomerSmiles (const std::string &smiles, const CleanupParameters &params=defaultCleanupParameters)
 TODO.
 
NormalizernormalizerFromParams (const CleanupParameters &params)
 
TautomerEnumeratortautomerEnumeratorFromParams (const CleanupParameters &params)
 
TautomerEnumeratorgetV1TautomerEnumerator ()
 
RDKIT_MOLSTANDARDIZE_EXPORT std::vector< Bond::BondTypestringToBondType (std::string bond_str)
 
RDKIT_MOLSTANDARDIZE_EXPORT std::vector< intstringToCharge (std::string charge_str)
 
RDKIT_MOLSTANDARDIZE_EXPORT std::vector< TautomerTransformreadTautomers (std::string fileName)
 
RDKIT_MOLSTANDARDIZE_EXPORT std::vector< TautomerTransformreadTautomers (std::istream &inStream, int nToRead=-1)
 
RDKIT_MOLSTANDARDIZE_EXPORT std::vector< TautomerTransformreadTautomers (const std::vector< std::tuple< std::string, std::string, std::string, std::string > > &data)
 
RDKIT_MOLSTANDARDIZE_EXPORT std::vector< std::shared_ptr< ChemicalReaction > > readTransformations (std::string fileName)
 
RDKIT_MOLSTANDARDIZE_EXPORT std::vector< std::shared_ptr< ChemicalReaction > > readTransformations (std::istream &inStream, int nToRead=-1)
 
RDKIT_MOLSTANDARDIZE_EXPORT std::vector< std::shared_ptr< ChemicalReaction > > readTransformations (const std::vector< std::pair< std::string, std::string > > &data)
 
RDKIT_MOLSTANDARDIZE_EXPORT std::vector< ValidationErrorInfovalidateSmiles (const std::string &smiles)
 A convenience function for quickly validating a single SMILES string.
 

Variables

RDKIT_MOLSTANDARDIZE_EXPORT const CleanupParameters defaultCleanupParameters
 
RDKIT_MOLSTANDARDIZE_EXPORT std::vector< ChargeCorrectionCHARGE_CORRECTIONS
 

Typedef Documentation

◆ AcidBaseCatalog

◆ FragmentCatalog

◆ SmilesMolPair

Definition at line 35 of file Normalize.h.

◆ SmilesTautomerMap

Definition at line 74 of file MolStandardize/Tautomer.h.

◆ SmilesTautomerPair

Definition at line 75 of file MolStandardize/Tautomer.h.

◆ TautomerCatalog

◆ TautomerTransformDefs

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.

◆ TransformCatalog

Enumeration Type Documentation

◆ TautomerEnumeratorStatus

Enumerator
Completed 
MaxTautomersReached 
MaxTransformsReached 
Canceled 

Definition at line 47 of file MolStandardize/Tautomer.h.

Function Documentation

◆ canonicalTautomer()

RDKIT_MOLSTANDARDIZE_EXPORT RWMol * RDKit::MolStandardize::canonicalTautomer ( const RWMol mol,
const CleanupParameters params = defaultCleanupParameters 
)

Works the same as TautomerEnumerator().canonicalize(mol)

◆ chargeParent()

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.

◆ cleanup() [1/2]

RWMol * RDKit::MolStandardize::cleanup ( const RWMol mol,
const CleanupParameters params = defaultCleanupParameters 
)
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().

◆ cleanup() [2/2]

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().

◆ cleanupInPlace() [1/2]

RDKIT_MOLSTANDARDIZE_EXPORT void RDKit::MolStandardize::cleanupInPlace ( RWMol mol,
const CleanupParameters params = defaultCleanupParameters 
)

Works the same as cleanup(mol)

◆ cleanupInPlace() [2/2]

RDKIT_MOLSTANDARDIZE_EXPORT void RDKit::MolStandardize::cleanupInPlace ( std::vector< RWMol * > &  mols,
int  numThreads = 1,
const CleanupParameters params = defaultCleanupParameters 
)

Operates on multiple molecules.

◆ disconnectOrganometallics() [1/2]

RDKIT_MOLSTANDARDIZE_EXPORT ROMol * RDKit::MolStandardize::disconnectOrganometallics ( const ROMol mol,
RDKit::MolStandardize::MetalDisconnectorOptions  mdo = truetruefalsetrue} 
)

As above, but returns new disconnected molecule.

◆ disconnectOrganometallics() [2/2]

RDKIT_MOLSTANDARDIZE_EXPORT void RDKit::MolStandardize::disconnectOrganometallics ( RWMol mol,
RDKit::MolStandardize::MetalDisconnectorOptions  mdo = truetruefalsetrue} 
)

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!

◆ disconnectOrganometallicsInPlace()

void RDKit::MolStandardize::disconnectOrganometallicsInPlace ( RWMol mol,
RDKit::MolStandardize::MetalDisconnectorOptions  mdo = truetruefalsetrue} 
)
inline

As above, included for API consistency.

Definition at line 220 of file MolStandardize.h.

◆ enumerateTautomerSmiles()

RDKIT_MOLSTANDARDIZE_EXPORT std::vector< std::string > RDKit::MolStandardize::enumerateTautomerSmiles ( const std::string &  smiles,
const CleanupParameters params = defaultCleanupParameters 
)

TODO.

◆ fragmentParent()

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.

◆ fragmentRemoverFromParams()

FragmentRemover * RDKit::MolStandardize::fragmentRemoverFromParams ( const CleanupParameters params,
bool  leave_last = true,
bool  skip_if_all_match = false 
)
inline

◆ getV1TautomerEnumerator()

TautomerEnumerator * RDKit::MolStandardize::getV1TautomerEnumerator ( )
inline

◆ isotopeParent()

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

◆ normalize()

RDKIT_MOLSTANDARDIZE_EXPORT RWMol * RDKit::MolStandardize::normalize ( const RWMol mol,
const CleanupParameters params = defaultCleanupParameters 
)

Works the same as Normalizer().normalize(mol)

◆ normalizeInPlace() [1/2]

RDKIT_MOLSTANDARDIZE_EXPORT void RDKit::MolStandardize::normalizeInPlace ( RWMol mol,
const CleanupParameters params = defaultCleanupParameters 
)

Works the same as Normalizer().normalizeInPlace(mol)

◆ normalizeInPlace() [2/2]

RDKIT_MOLSTANDARDIZE_EXPORT void RDKit::MolStandardize::normalizeInPlace ( std::vector< RWMol * > &  mols,
int  numThreads = 1,
const CleanupParameters params = defaultCleanupParameters 
)

Operates on multiple molecules.

◆ normalizerFromParams()

◆ readFuncGroups() [1/3]

RDKIT_MOLSTANDARDIZE_EXPORT std::vector< std::shared_ptr< ROMol > > RDKit::MolStandardize::readFuncGroups ( const std::vector< std::pair< std::string, std::string > > &  data)

◆ readFuncGroups() [2/3]

RDKIT_MOLSTANDARDIZE_EXPORT std::vector< std::shared_ptr< ROMol > > RDKit::MolStandardize::readFuncGroups ( std::istream &  inStream,
int  nToRead = -1 
)

◆ readFuncGroups() [3/3]

RDKIT_MOLSTANDARDIZE_EXPORT std::vector< std::shared_ptr< ROMol > > RDKit::MolStandardize::readFuncGroups ( std::string  fileName)

◆ readPairs() [1/3]

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)

◆ readPairs() [2/3]

RDKIT_MOLSTANDARDIZE_EXPORT std::vector< std::pair< ROMOL_SPTR, ROMOL_SPTR > > RDKit::MolStandardize::readPairs ( std::istream &  inStream,
int  nToRead = -1 
)

◆ readPairs() [3/3]

RDKIT_MOLSTANDARDIZE_EXPORT std::vector< std::pair< ROMOL_SPTR, ROMOL_SPTR > > RDKit::MolStandardize::readPairs ( std::string  fileName)

◆ readTautomers() [1/3]

RDKIT_MOLSTANDARDIZE_EXPORT std::vector< TautomerTransform > RDKit::MolStandardize::readTautomers ( const std::vector< std::tuple< std::string, std::string, std::string, std::string > > &  data)

◆ readTautomers() [2/3]

RDKIT_MOLSTANDARDIZE_EXPORT std::vector< TautomerTransform > RDKit::MolStandardize::readTautomers ( std::istream &  inStream,
int  nToRead = -1 
)

◆ readTautomers() [3/3]

RDKIT_MOLSTANDARDIZE_EXPORT std::vector< TautomerTransform > RDKit::MolStandardize::readTautomers ( std::string  fileName)

◆ readTransformations() [1/3]

RDKIT_MOLSTANDARDIZE_EXPORT std::vector< std::shared_ptr< ChemicalReaction > > RDKit::MolStandardize::readTransformations ( const std::vector< std::pair< std::string, std::string > > &  data)

◆ readTransformations() [2/3]

RDKIT_MOLSTANDARDIZE_EXPORT std::vector< std::shared_ptr< ChemicalReaction > > RDKit::MolStandardize::readTransformations ( std::istream &  inStream,
int  nToRead = -1 
)

◆ readTransformations() [3/3]

RDKIT_MOLSTANDARDIZE_EXPORT std::vector< std::shared_ptr< ChemicalReaction > > RDKit::MolStandardize::readTransformations ( std::string  fileName)

◆ reionize()

RDKIT_MOLSTANDARDIZE_EXPORT RWMol * RDKit::MolStandardize::reionize ( const RWMol mol,
const CleanupParameters params = defaultCleanupParameters 
)

Works the same as Reionizer().reionize(mol)

◆ reionizeInPlace() [1/2]

RDKIT_MOLSTANDARDIZE_EXPORT void RDKit::MolStandardize::reionizeInPlace ( RWMol mol,
const CleanupParameters params = defaultCleanupParameters 
)

Works the same as Reionizer().reionizeInPlace(mol)

◆ reionizeInPlace() [2/2]

RDKIT_MOLSTANDARDIZE_EXPORT void RDKit::MolStandardize::reionizeInPlace ( std::vector< RWMol * > &  mols,
int  numThreads = 1,
const CleanupParameters params = defaultCleanupParameters 
)

Operates on multiple molecules.

◆ reionizerFromParams()

Reionizer * RDKit::MolStandardize::reionizerFromParams ( const CleanupParameters params)
inline

◆ removeFragments()

RDKIT_MOLSTANDARDIZE_EXPORT RWMol * RDKit::MolStandardize::removeFragments ( const RWMol mol,
const CleanupParameters params = defaultCleanupParameters 
)

Works the same as FragmentRemover().remove(mol)

◆ removeFragmentsInPlace() [1/2]

RDKIT_MOLSTANDARDIZE_EXPORT void RDKit::MolStandardize::removeFragmentsInPlace ( RWMol mol,
const CleanupParameters params = defaultCleanupParameters 
)

Works the same as FragmentRemover().removeInPlace(mol)

◆ removeFragmentsInPlace() [2/2]

RDKIT_MOLSTANDARDIZE_EXPORT void RDKit::MolStandardize::removeFragmentsInPlace ( std::vector< RWMol * > &  mols,
int  numThreads = 1,
const CleanupParameters params = defaultCleanupParameters 
)

Operates on multiple molecules.

◆ standardizeSmiles()

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

◆ stereoParent()

RDKIT_MOLSTANDARDIZE_EXPORT RWMol * RDKit::MolStandardize::stereoParent ( const RWMol mol,
const CleanupParameters params = defaultCleanupParameters,
bool  skip_standardize = false 
)

calls removeStereochemistry() on the given molecule

◆ stringToBondType()

RDKIT_MOLSTANDARDIZE_EXPORT std::vector< Bond::BondType > RDKit::MolStandardize::stringToBondType ( std::string  bond_str)

◆ stringToCharge()

RDKIT_MOLSTANDARDIZE_EXPORT std::vector< int > RDKit::MolStandardize::stringToCharge ( std::string  charge_str)

◆ superParent()

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.

◆ tautomerEnumeratorFromParams()

TautomerEnumerator * RDKit::MolStandardize::tautomerEnumeratorFromParams ( const CleanupParameters params)
inline

Definition at line 414 of file MolStandardize/Tautomer.h.

◆ tautomerParent()

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

◆ updateCleanupParamsFromJSON()

RDKIT_MOLSTANDARDIZE_EXPORT void RDKit::MolStandardize::updateCleanupParamsFromJSON ( CleanupParameters params,
const std::string &  json 
)

◆ validateSmiles()

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().

Variable Documentation

◆ CHARGE_CORRECTIONS

RDKIT_MOLSTANDARDIZE_EXPORT std::vector<ChargeCorrection> RDKit::MolStandardize::CHARGE_CORRECTIONS
extern

◆ defaultCleanupParameters

RDKIT_MOLSTANDARDIZE_EXPORT const CleanupParameters RDKit::MolStandardize::defaultCleanupParameters
extern

Definition at line 25 of file Fragment.h.