![]() |
RDKit
Open-source cheminformatics and machine learning.
|
#include <AtomTyper.h>
Public Member Functions | |
MMFFMolProperties (ROMol &mol, const std::string &mmffVariant="MMFF94", std::uint8_t verbosity=MMFF_VERBOSITY_NONE, std::ostream &oStream=std::cout) | |
~MMFFMolProperties () | |
unsigned int | getMMFFBondType (const Bond *bond) |
unsigned int | getMMFFAngleType (const ROMol &mol, const unsigned int idx1, const unsigned int idx2, const unsigned int idx3) |
const std::pair< unsigned int, unsigned int > | getMMFFTorsionType (const ROMol &mol, const unsigned int idx1, const unsigned int idx2, const unsigned int idx3, const unsigned int idx4) |
void | computeMMFFCharges (const ROMol &mol) |
const ForceFields::MMFF::MMFFTor * | getMMFFTorsionEmpiricalRuleParams (const ROMol &mol, unsigned int idx2, unsigned int idx3) |
const ForceFields::MMFF::MMFFBond * | getMMFFBondStretchEmpiricalRuleParams (const ROMol &mol, const Bond *bond) |
std::uint8_t | getMMFFAtomType (const unsigned int idx) |
double | getMMFFFormalCharge (const unsigned int idx) |
double | getMMFFPartialCharge (const unsigned int idx) |
void | setMMFFBondTerm (const bool state) |
bool | getMMFFBondTerm () |
void | setMMFFAngleTerm (const bool state) |
bool | getMMFFAngleTerm () |
void | setMMFFStretchBendTerm (const bool state) |
bool | getMMFFStretchBendTerm () |
void | setMMFFOopTerm (const bool state) |
bool | getMMFFOopTerm () |
void | setMMFFTorsionTerm (const bool state) |
bool | getMMFFTorsionTerm () |
void | setMMFFVdWTerm (const bool state) |
bool | getMMFFVdWTerm () |
void | setMMFFEleTerm (const bool state) |
bool | getMMFFEleTerm () |
void | setMMFFVariant (const std::string &mmffVariant) |
const std::string | getMMFFVariant () |
void | setMMFFDielectricConstant (const double dielConst) |
double | getMMFFDielectricConstant () |
void | setMMFFDielectricModel (std::uint8_t dielModel) |
std::uint8_t | getMMFFDielectricModel () |
void | setMMFFVerbosity (std::uint8_t verbosity) |
std::uint8_t | getMMFFVerbosity () |
void | setMMFFOStream (std::ostream *oStream) |
std::ostream & | getMMFFOStream () |
bool | isValid () |
bool | getMMFFBondStretchParams (const ROMol &mol, const unsigned int idx1, const unsigned int idx2, unsigned int &bondType, MMFFBond &mmffBondStretchParams) |
bool | getMMFFAngleBendParams (const ROMol &mol, const unsigned int idx1, const unsigned int idx2, const unsigned int idx3, unsigned int &angleType, MMFFAngle &mmffAngleBendParams) |
bool | getMMFFStretchBendParams (const ROMol &mol, const unsigned int idx1, const unsigned int idx2, const unsigned int idx3, unsigned int &stretchBendType, MMFFStbn &mmffStretchBendParams, MMFFBond mmffBondStretchParams[2], MMFFAngle &mmffAngleBendParams) |
bool | getMMFFTorsionParams (const ROMol &mol, const unsigned int idx1, const unsigned int idx2, const unsigned int idx3, const unsigned int idx4, unsigned int &torsionType, MMFFTor &mmffTorsionParams) |
bool | getMMFFOopBendParams (const ROMol &mol, const unsigned int idx1, const unsigned int idx2, const unsigned int idx3, const unsigned int idx4, MMFFOop &mmffOopBendParams) |
bool | getMMFFVdWParams (const unsigned int idx1, const unsigned int idx2, MMFFVdWRijstarEps &mmffVdWParams) |
Definition at line 64 of file MMFF/AtomTyper.h.
RDKit::MMFF::MMFFMolProperties::MMFFMolProperties | ( | ROMol & | mol, |
const std::string & | mmffVariant = "MMFF94" , |
||
std::uint8_t | verbosity = MMFF_VERBOSITY_NONE , |
||
std::ostream & | oStream = std::cout |
||
) |
|
inline |
Definition at line 69 of file MMFF/AtomTyper.h.
void RDKit::MMFF::MMFFMolProperties::computeMMFFCharges | ( | const ROMol & | mol | ) |
bool RDKit::MMFF::MMFFMolProperties::getMMFFAngleBendParams | ( | const ROMol & | mol, |
const unsigned int | idx1, | ||
const unsigned int | idx2, | ||
const unsigned int | idx3, | ||
unsigned int & | angleType, | ||
MMFFAngle & | mmffAngleBendParams | ||
) |
|
inline |
Definition at line 100 of file MMFF/AtomTyper.h.
unsigned int RDKit::MMFF::MMFFMolProperties::getMMFFAngleType | ( | const ROMol & | mol, |
const unsigned int | idx1, | ||
const unsigned int | idx2, | ||
const unsigned int | idx3 | ||
) |
|
inline |
Definition at line 82 of file MMFF/AtomTyper.h.
References URANGE_CHECK.
const ForceFields::MMFF::MMFFBond* RDKit::MMFF::MMFFMolProperties::getMMFFBondStretchEmpiricalRuleParams | ( | const ROMol & | mol, |
const Bond * | bond | ||
) |
bool RDKit::MMFF::MMFFMolProperties::getMMFFBondStretchParams | ( | const ROMol & | mol, |
const unsigned int | idx1, | ||
const unsigned int | idx2, | ||
unsigned int & | bondType, | ||
MMFFBond & | mmffBondStretchParams | ||
) |
|
inline |
Definition at line 98 of file MMFF/AtomTyper.h.
unsigned int RDKit::MMFF::MMFFMolProperties::getMMFFBondType | ( | const Bond * | bond | ) |
|
inline |
Definition at line 127 of file MMFF/AtomTyper.h.
|
inline |
Definition at line 131 of file MMFF/AtomTyper.h.
|
inline |
Definition at line 112 of file MMFF/AtomTyper.h.
|
inline |
Definition at line 87 of file MMFF/AtomTyper.h.
References URANGE_CHECK.
bool RDKit::MMFF::MMFFMolProperties::getMMFFOopBendParams | ( | const ROMol & | mol, |
const unsigned int | idx1, | ||
const unsigned int | idx2, | ||
const unsigned int | idx3, | ||
const unsigned int | idx4, | ||
MMFFOop & | mmffOopBendParams | ||
) |
|
inline |
Definition at line 106 of file MMFF/AtomTyper.h.
|
inline |
Definition at line 137 of file MMFF/AtomTyper.h.
|
inline |
Definition at line 92 of file MMFF/AtomTyper.h.
References URANGE_CHECK.
bool RDKit::MMFF::MMFFMolProperties::getMMFFStretchBendParams | ( | const ROMol & | mol, |
const unsigned int | idx1, | ||
const unsigned int | idx2, | ||
const unsigned int | idx3, | ||
unsigned int & | stretchBendType, | ||
MMFFStbn & | mmffStretchBendParams, | ||
MMFFBond | mmffBondStretchParams[2], | ||
MMFFAngle & | mmffAngleBendParams | ||
) |
|
inline |
Definition at line 104 of file MMFF/AtomTyper.h.
const ForceFields::MMFF::MMFFTor* RDKit::MMFF::MMFFMolProperties::getMMFFTorsionEmpiricalRuleParams | ( | const ROMol & | mol, |
unsigned int | idx2, | ||
unsigned int | idx3 | ||
) |
bool RDKit::MMFF::MMFFMolProperties::getMMFFTorsionParams | ( | const ROMol & | mol, |
const unsigned int | idx1, | ||
const unsigned int | idx2, | ||
const unsigned int | idx3, | ||
const unsigned int | idx4, | ||
unsigned int & | torsionType, | ||
MMFFTor & | mmffTorsionParams | ||
) |
|
inline |
Definition at line 108 of file MMFF/AtomTyper.h.
const std::pair<unsigned int, unsigned int> RDKit::MMFF::MMFFMolProperties::getMMFFTorsionType | ( | const ROMol & | mol, |
const unsigned int | idx1, | ||
const unsigned int | idx2, | ||
const unsigned int | idx3, | ||
const unsigned int | idx4 | ||
) |
|
inline |
Definition at line 119 of file MMFF/AtomTyper.h.
bool RDKit::MMFF::MMFFMolProperties::getMMFFVdWParams | ( | const unsigned int | idx1, |
const unsigned int | idx2, | ||
MMFFVdWRijstarEps & | mmffVdWParams | ||
) |
|
inline |
Definition at line 110 of file MMFF/AtomTyper.h.
|
inline |
Definition at line 135 of file MMFF/AtomTyper.h.
|
inline |
Definition at line 138 of file MMFF/AtomTyper.h.
Referenced by RDKit::MMFF::MMFFOptimizeMolecule(), and RDKit::MMFF::MMFFOptimizeMoleculeConfs().
|
inline |
Definition at line 99 of file MMFF/AtomTyper.h.
|
inline |
Definition at line 97 of file MMFF/AtomTyper.h.
|
inline |
Definition at line 122 of file MMFF/AtomTyper.h.
References PRECONDITION.
|
inline |
Definition at line 128 of file MMFF/AtomTyper.h.
|
inline |
Definition at line 111 of file MMFF/AtomTyper.h.
|
inline |
Definition at line 105 of file MMFF/AtomTyper.h.
|
inline |
Definition at line 136 of file MMFF/AtomTyper.h.
|
inline |
Definition at line 101 of file MMFF/AtomTyper.h.
|
inline |
Definition at line 107 of file MMFF/AtomTyper.h.
|
inline |
Definition at line 113 of file MMFF/AtomTyper.h.
References PRECONDITION.
|
inline |
Definition at line 109 of file MMFF/AtomTyper.h.
|
inline |
Definition at line 132 of file MMFF/AtomTyper.h.