 |
RDKit
Open-source cheminformatics and machine learning.
|
Go to the documentation of this file.
11 #ifndef _RD_ALIGNMOLECULES_H_
12 #define _RD_ALIGNMOLECULES_H_
31 const char *
what() const noexcept
override {
return _msg.c_str(); };
32 const char *
message() const noexcept {
return what(); };
69 int prbCid = -1,
int refCid = -1,
const MatchVectType *atomMap = 0,
71 unsigned int maxIters = 50);
101 ROMol &prbMol,
const ROMol &refMol,
int prbCid = -1,
int refCid = -1,
104 unsigned int maxIters = 50);
131 ROMol &probeMol,
ROMol &refMol,
int probeId = -1,
int refId = -1,
132 const std::vector<MatchVectType> &map = std::vector<MatchVectType>(),
133 int maxMatches = 1e6);
152 ROMol &mol,
const std::vector<unsigned int> *atomIds = 0,
153 const std::vector<unsigned int> *confIds = 0,
155 unsigned int maxIters = 50, std::vector<double> *RMSlist = 0);
MolAlignException(const char *msg)
construct with an error message
RDKIT_MOLALIGN_EXPORT double alignMol(ROMol &prbMol, const ROMol &refMol, int prbCid=-1, int refCid=-1, const MatchVectType *atomMap=0, const RDNumeric::DoubleVector *weights=0, bool reflect=false, unsigned int maxIters=50)
Optimally (minimum RMSD) align a molecule to another molecule.
#define RDKIT_MOLALIGN_EXPORT
MolAlignException(const std::string msg)
construct with an error message
const char * message() const noexcept
A class to represent vectors of numbers.
RDKIT_MOLALIGN_EXPORT const RDGeom::POINT3D_VECT * reflect(const Conformer &conf)
RDKIT_MOLALIGN_EXPORT void alignMolConformers(ROMol &mol, const std::vector< unsigned int > *atomIds=0, const std::vector< unsigned int > *confIds=0, const RDNumeric::DoubleVector *weights=0, bool reflect=false, unsigned int maxIters=50, std::vector< double > *RMSlist=0)
Align the conformations of a molecule using a common set of atoms. If.
RDKIT_MOLALIGN_EXPORT double getAlignmentTransform(const ROMol &prbMol, const ROMol &refMol, RDGeom::Transform3D &trans, int prbCid=-1, int refCid=-1, const MatchVectType *atomMap=0, const RDNumeric::DoubleVector *weights=0, bool reflect=false, unsigned int maxIters=50)
Alignment functions.
~MolAlignException() noexcept
RDKIT_MOLALIGN_EXPORT double getBestRMS(ROMol &probeMol, ROMol &refMol, int probeId=-1, int refId=-1, const std::vector< MatchVectType > &map=std::vector< MatchVectType >(), int maxMatches=1e6)
Returns the optimal RMS for aligning two molecules, taking.
const char * what() const noexcept override
get the error message
std::vector< std::pair< int, int > > MatchVectType
used to return matches from substructure searching, The format is (queryAtomIdx, molAtomIdx)