 |
RDKit
Open-source cheminformatics and machine learning.
|
Go to the documentation of this file.
13 #ifndef __RD_MMFFNONBONDED_H__
14 #define __RD_MMFFNONBONDED_H__
21 class MMFFVdWCollection;
38 void getGrad(
double *pos,
double *grad)
const;
42 int d_at1Idx, d_at2Idx;
60 double chargeTerm, std::uint8_t dielModel,
bool is1_4);
62 void getGrad(
double *pos,
double *grad)
const;
67 int d_at1Idx, d_at2Idx;
79 const MMFFVdW *mmffVdWParamsAtom2);
83 double R_star_ij,
const MMFFVdW *mmffVdWParamsIAtom,
84 const MMFFVdW *mmffVdWParamsJAtom);
89 const MMFFVdW *mmffVdWParamsIAtom,
90 const MMFFVdW *mmffVdWParamsJAtom);
93 const double R_star_ij,
94 const double wellDepth);
97 unsigned int idx2,
double dist,
99 std::uint8_t dielModel,
RDKIT_FORCEFIELD_EXPORT double calcUnscaledVdWMinimum(const MMFFVdWCollection *mmffVdW, const MMFFVdW *mmffVdWParamsAtom1, const MMFFVdW *mmffVdWParamsAtom2)
calculates and returns the unscaled minimum distance (R*ij) for a MMFF VdW
RDKIT_FORCEFIELD_EXPORT double calcUnscaledVdWWellDepth(double R_star_ij, const MMFFVdW *mmffVdWParamsIAtom, const MMFFVdW *mmffVdWParamsJAtom)
calculates and returns the unscaled well depth (epsilon) for a MMFF VdW
double getEnergy(double *pos) const
returns our contribution to the energy of a position
the electrostatic term for MMFF
A class to store forcefields and handle minimization.
RDKIT_FORCEFIELD_EXPORT double calcVdWEnergy(const double dist, const double R_star_ij, const double wellDepth)
calculates and returns the Van der Waals MMFF energy
pulls in the core RDKit functionality
VdWContrib(ForceField *owner, unsigned int idx1, unsigned int idx2, const MMFFVdWRijstarEps *mmffVdWConstants)
Constructor.
void getGrad(double *pos, double *grad) const
calculates our contribution to the gradients of a position
virtual VdWContrib * copy() const
return a copy
abstract base class for contributions to ForceFields
EleContrib(ForceField *owner, unsigned int idx1, unsigned int idx2, double chargeTerm, std::uint8_t dielModel, bool is1_4)
Constructor.
#define RDKIT_FORCEFIELD_EXPORT
double getEnergy(double *pos) const
returns our contribution to the energy of a position
the van der Waals term for MMFF
virtual EleContrib * copy() const
return a copy
RDKIT_FORCEFIELD_EXPORT double calcEleEnergy(unsigned int idx1, unsigned int idx2, double dist, double chargeTerm, std::uint8_t dielModel, bool is1_4)
calculates and returns the electrostatic MMFF energy
RDKIT_FORCEFIELD_EXPORT void scaleVdWParams(double &R_star_ij, double &wellDepth, const MMFFVdWCollection *mmffVdW, const MMFFVdW *mmffVdWParamsIAtom, const MMFFVdW *mmffVdWParamsJAtom)
scales the VdW parameters
class to store MMFF parameters for non-bonded Van der Waals
void getGrad(double *pos, double *grad) const
calculates our contribution to the gradients of a position