NAMD
|
Molecule stores the structural information for the system. More...
#include <Molecule.h>
Friends | |
class | ExclElem |
class | BondElem |
class | AngleElem |
class | DihedralElem |
class | ImproperElem |
class | TholeElem |
class | AnisoElem |
class | OneFourNbTholeElem |
class | CrosstermElem |
class | GromacsPairElem |
class | WorkDistrib |
Molecule stores the structural information for the system.
This class is used to store all of the structural
information for a simulation. It reads in this information from a .psf file, cross checks and obtains some information from the Parameters object that is passed in, and then
stores all this information for later use.
One Molecule instance is kept on each PE (or node for SMP build), accessed by Node::Object()->molecule. There is an initial setup and file reading phase, after which there is a communication phase using the Communicate MIStream / MOStream to update all copies, all before simulation begins.
Keeps list maintaining the global atom indicies sorted by helix groups, and also bond connectivity and exclusion lists.
Reads PSF file, compressed PSF file (for memory optimized version), Gromacs topology file, and PDB files for various per atom constants and flags (Langevin, fixed atoms, FEP, Go residue IDs, grid force parameters, moving/rotating drag parameters, torque parameters, stirred atoms, pressure exclusions).
Definition at line 174 of file Molecule.h.
Molecule::Molecule | ( | SimParameters * | simParams, |
Parameters * | param | ||
) |
Definition at line 442 of file Molecule.C.
References simParams.
Molecule::Molecule | ( | SimParameters * | simParams, |
Parameters * | param, | ||
char * | filename, | ||
ConfigList * | cfgList = NULL |
||
) |
Definition at line 455 of file Molecule.C.
References NAMD_EVENT_START, NAMD_EVENT_STOP, and simParams.
Molecule::Molecule | ( | SimParameters * | simParams, |
Parameters * | param, | ||
molfile_plugin_t * | pIOHdl, | ||
void * | pIOFileHdl, | ||
int | natoms | ||
) |
Definition at line 480 of file Molecule.C.
References NAMD_die(), and simParams.
Molecule::Molecule | ( | SimParameters * | , |
Parameters * | , | ||
Ambertoppar * | |||
) |
Molecule::Molecule | ( | SimParameters * | , |
Parameters * | , | ||
AmberParm7Reader::Ambertoppar * | |||
) |
Molecule::Molecule | ( | SimParameters * | , |
Parameters * | , | ||
const GromacsTopFile * | |||
) |
Molecule::~Molecule | ( | ) |
void Molecule::add_dcd_selection_file | ( | int | dcdIndex, |
char * | userDcdFile | ||
) |
void Molecule::add_dcd_selection_freq | ( | int | dcdIndex, |
int | freq | ||
) |
|
inline |
Definition at line 1124 of file Molecule.h.
Referenced by WorkDistrib::createAtomLists(), NamdState::loadStructure(), Sequencer::reloadCharges(), Sequencer::rescaleSoluteCharges(), colvarproxy_namd::update_atom_properties(), and colvarproxy_namd::update_group_properties().
|
inline |
Definition at line 1114 of file Molecule.h.
Referenced by WorkDistrib::createAtomLists(), GlobalMasterEasy::getMass(), GlobalMasterFreeEnergy::getMass(), NamdState::loadStructure(), Tcl_centerOfMass(), Tcl_radiusOfGyration(), colvarproxy_namd::update_atom_properties(), and colvarproxy_namd::update_group_properties().
Bool Molecule::atoms_1to4 | ( | unsigned int | atom1, |
unsigned int | atom2 | ||
) |
Definition at line 1538 of file GoMolecule.C.
References bond::atom1, angle::atom1, dihedral::atom1, bond::atom2, angle::atom2, dihedral::atom2, angle::atom3, dihedral::atom3, dihedral::atom4, DebugM, FALSE, get_angle(), get_angles_for_atom(), get_bond(), get_bonds_for_atom(), get_dihedral(), get_dihedrals_for_atom(), and TRUE.
Referenced by build_go_arrays(), build_go_sigmas(), and build_go_sigmas2().
|
inline |
Definition at line 1134 of file Molecule.h.
Referenced by WorkDistrib::createAtomLists(), and dumpbench().
void Molecule::build_alch_unpert_bond_lists | ( | char * | ) |
Referenced by NamdState::loadStructure().
void Molecule::build_constant_forces | ( | char * | ) |
Referenced by NamdState::loadStructure().
void Molecule::build_constorque_params | ( | StringList * | , |
StringList * | , | ||
StringList * | , | ||
StringList * | , | ||
StringList * | , | ||
StringList * | , | ||
PDB * | , | ||
char * | |||
) |
Referenced by NamdState::loadStructure().
void Molecule::build_constraint_params | ( | StringList * | , |
StringList * | , | ||
StringList * | , | ||
PDB * | , | ||
char * | |||
) |
Referenced by NamdState::loadStructure().
void Molecule::build_dcd_selection_list_pdb | ( | int | dcdIndex, |
char * | userDcdInputFile | ||
) |
void Molecule::build_exPressure_atoms | ( | StringList * | , |
StringList * | , | ||
PDB * | , | ||
char * | |||
) |
Referenced by NamdState::loadStructure().
void Molecule::build_extra_bonds | ( | Parameters * | parameters, |
StringList * | file | ||
) |
Referenced by NamdState::loadStructure().
void Molecule::build_fep_flags | ( | StringList * | , |
StringList * | , | ||
PDB * | , | ||
char * | , | ||
const char * | |||
) |
Referenced by NamdState::loadStructure().
void Molecule::build_fixed_atoms | ( | StringList * | , |
StringList * | , | ||
PDB * | , | ||
char * | |||
) |
Referenced by NamdState::loadStructure().
void Molecule::build_go_arrays | ( | StringList * | goCoordFile, |
char * | cwd | ||
) |
goSigmas = new Real[numGoAtoms*numGoAtoms]; goWithinCutoff = new bool[numGoAtoms*numGoAtoms]; for (i=0; i<numGoAtoms; i++) { for (j=0; j<numGoAtoms; j++) { goSigmas[i*numGoAtoms + j] = 0.0; goWithinCutoff[i*numGoAtoms + j] = false; } }
Definition at line 951 of file GoMolecule.C.
References PDB::atom(), atomChainTypes, atoms_1to4(), StringList::data, DebugM, endi(), energyNative, energyNonnative, get_go_cutoff(), go_restricted(), goCoordinates, goPDB, goResids, goSigmaIndices, iINFO(), iout, NAMD_die(), NAMD_FILENAME_BUFFER_SIZE, StringList::next, PDB::num_atoms(), numAtoms, numGoAtoms, PDBAtom::residueseq(), PDBAtom::xcoor(), PDBAtom::ycoor(), and PDBAtom::zcoor().
Referenced by NamdState::loadStructure().
void Molecule::build_go_params | ( | StringList * | g | ) |
Definition at line 80 of file GoMolecule.C.
References StringList::data, endi(), iINFO(), iout, NAMD_die(), StringList::next, and read_go_file().
Referenced by NamdState::loadStructure().
void Molecule::build_go_sigmas | ( | StringList * | goCoordFile, |
char * | cwd | ||
) |
Definition at line 578 of file GoMolecule.C.
References PDB::atom(), atomChainTypes, atoms_1to4(), StringList::data, DebugM, endi(), get_go_cutoff(), get_go_exp_a(), get_go_exp_b(), go_restricted(), goPDB, goSigmaIndices, goSigmas, goWithinCutoff, iINFO(), iout, NAMD_die(), NAMD_FILENAME_BUFFER_SIZE, StringList::next, PDB::num_atoms(), numAtoms, and numGoAtoms.
Referenced by NamdState::loadStructure().
void Molecule::build_go_sigmas2 | ( | StringList * | goCoordFile, |
char * | cwd | ||
) |
Definition at line 748 of file GoMolecule.C.
References go_pair::A, ResizeArray< Elem >::add(), PDB::atom(), atomChainTypes, atoms_1to4(), go_pair::B, ResizeArray< Elem >::begin(), StringList::data, DebugM, ResizeArray< Elem >::end(), endi(), get_go_cutoff(), get_go_exp_a(), get_go_exp_b(), go_restricted(), go_pair::goIndxA, go_pair::goIndxB, goIndxLJA, goIndxLJB, goNumLJPair, goPDB, goResidIndices, goSigmaIndices, goSigmaPairA, goSigmaPairB, iINFO(), iout, NAMD_die(), NAMD_FILENAME_BUFFER_SIZE, StringList::next, PDB::num_atoms(), numAtoms, numGoAtoms, numLJPair, pointerToGoBeg, and pointerToGoEnd.
Referenced by NamdState::loadStructure().
void Molecule::build_gridforce_params | ( | StringList * | gridfrcfile, |
StringList * | gridfrccol, | ||
StringList * | gridfrcchrgcol, | ||
StringList * | potfile, | ||
PDB * | initial_pdb, | ||
char * | cwd | ||
) |
Definition at line 6607 of file Molecule.C.
References PDB::atom(), DebugM, endi(), MGridforceParams::gridforceCol, MGridforceParams::gridforceFile, MGridforceParams::gridforceQcol, MGridforceParams::gridforceVfile, iout, iWARN(), NAMD_die(), NAMD_FILENAME_BUFFER_SIZE, GridforceGrid::new_grid(), MGridforceParams::next, PDB::num_atoms(), and simParams.
Referenced by NamdState::loadStructure().
void Molecule::build_gro_pair | ( | ) |
Referenced by NamdState::loadStructure().
void Molecule::build_langevin_params | ( | StringList * | , |
StringList * | , | ||
PDB * | , | ||
char * | |||
) |
void Molecule::build_molecule | ( | ) |
Definition at line 3303 of file Molecule.C.
References LARGEMOLTH, and sizeColumn().
Referenced by NamdState::loadStructure().
void Molecule::build_movdrag_params | ( | StringList * | , |
StringList * | , | ||
StringList * | , | ||
PDB * | , | ||
char * | |||
) |
Referenced by NamdState::loadStructure().
void Molecule::build_rotdrag_params | ( | StringList * | , |
StringList * | , | ||
StringList * | , | ||
StringList * | , | ||
StringList * | , | ||
StringList * | , | ||
PDB * | , | ||
char * | |||
) |
Referenced by NamdState::loadStructure().
void Molecule::build_ss_flags | ( | const StringList * | ssfile, |
const StringList * | sscol, | ||
PDB * | initial_pdb, | ||
const char * | cwd | ||
) |
Build the flags needed for solute scaling.
A PDB file is read, indicating which atoms are to be scaled, and an array is maintained marking which are to be included. Each marked atom then has its corresponding van der Waals type number reassigned to enable extending the LJTable with scaled interaction values.
ssfile | config "soluteScalingFile = my.pdb" for PDB filename |
sscol | config "soluteScalingCol = O" for column of PDB ATOM records |
initial_pdb | the initial PDB file |
cwd | current working directory |
Referenced by NamdState::loadStructure().
void Molecule::build_stirred_atoms | ( | StringList * | , |
StringList * | , | ||
PDB * | , | ||
char * | |||
) |
Referenced by NamdState::loadStructure().
int Molecule::checkexcl | ( | int | atom1, |
int | atom2 | ||
) | const |
Referenced by LjPmeCompute::computeNonbonded().
void Molecule::compute_LJcorrection | ( | ) |
Referenced by NamdState::loadStructure().
void Molecule::compute_LJcorrection_alternative | ( | ) |
Referenced by NamdState::loadStructure().
void Molecule::delete_alch_bonded | ( | void | ) |
Referenced by NamdState::loadStructure().
void Molecule::delete_qm_bonded | ( | void | ) |
Definition at line 1579 of file MoleculeQM.C.
References bond::atom1, angle::atom1, dihedral::atom1, improper::atom1, crossterm::atom1, DebugM, endi(), SimParameters::extraBondsOn, iERROR(), iINFO(), iout, NAMD_die(), numAngles, numBonds, numCrossterms, numDihedrals, numImpropers, and numRealBonds.
uint16_t Molecule::find_dcd_selection_index | ( | const char * | keystr | ) |
uint16_t Molecule::find_or_create_dcd_selection_index | ( | const char * | keystr | ) |
Referenced by Output::replicaDcdSelectInit().
|
inline |
Definition at line 1110 of file Molecule.h.
Referenced by NamdState::loadStructure().
|
inline |
Definition at line 1106 of file Molecule.h.
Referenced by NamdState::loadStructure().
|
inline |
Definition at line 1181 of file Molecule.h.
|
inline |
Definition at line 1144 of file Molecule.h.
Referenced by atoms_1to4(), and dumpbench().
|
inline |
Definition at line 1222 of file Molecule.h.
Referenced by atoms_1to4(), and dumpbench().
|
inline |
Definition at line 883 of file Molecule.h.
References per_atom_flags::dcdSelection, and AtomCstInfo::flags.
int Molecule::get_atom_from_index_in_residue | ( | const char * | segid, |
int | resid, | ||
int | index | ||
) | const |
Definition at line 163 of file Molecule.C.
References NAMD_die().
Referenced by GlobalMasterEasy::getAtomID(), and GlobalMasterFreeEnergy::getAtomID().
int Molecule::get_atom_from_name | ( | const char * | segid, |
int | resid, | ||
const char * | aname | ||
) | const |
Definition at line 126 of file Molecule.C.
References atomNamePool, and NAMD_die().
Referenced by colvarproxy_namd::check_atom_id(), GlobalMasterEasy::getAtomID(), and GlobalMasterFreeEnergy::getAtomID().
|
inline |
Definition at line 884 of file Molecule.h.
References dcd_params::dcdSelectionIndex, and dcdSelectionParams.
Referenced by wrap_coor_int_dcd_selection().
|
inline |
Definition at line 1192 of file Molecule.h.
References AtomNameIdx::atomtypeIdx, atomTypePool, and NAMD_die().
|
inline |
Definition at line 1141 of file Molecule.h.
Referenced by atoms_1to4(), and dumpbench().
|
inline |
Definition at line 1220 of file Molecule.h.
Referenced by atoms_1to4(), and dumpbench().
|
inline |
Definition at line 1099 of file Molecule.h.
Referenced by wrap_coor_int(), and wrap_coor_int_dcd_selection().
|
inline |
Definition at line 1100 of file Molecule.h.
Referenced by wrap_coor_int(), and wrap_coor_int_dcd_selection().
Definition at line 1354 of file Molecule.h.
Referenced by ComputeRestraints::doForce().
|
inline |
Definition at line 1428 of file Molecule.h.
References consTorqueIndexes, and consTorqueParams.
Referenced by ComputeConsTorque::doForce().
|
inline |
Definition at line 1153 of file Molecule.h.
|
inline |
Definition at line 1228 of file Molecule.h.
|
inline |
Definition at line 928 of file Molecule.h.
Referenced by ComputeQMMgr::recvPartQM().
|
inline |
Definition at line 924 of file Molecule.h.
Referenced by ComputeQMMgr::recvPartQM().
|
inline |
Definition at line 923 of file Molecule.h.
Referenced by ComputeQMMgr::recvPartQM().
|
inline |
Definition at line 926 of file Molecule.h.
Referenced by ComputeQMMgr::recvPartQM().
|
inline |
Definition at line 922 of file Molecule.h.
Referenced by ComputeQMMgr::recvPartQM().
|
inline |
Definition at line 925 of file Molecule.h.
Referenced by ComputeQMMgr::recvPartQM().
|
inline |
Definition at line 927 of file Molecule.h.
Referenced by ComputeQMMgr::recvPartQM().
|
inline |
Definition at line 888 of file Molecule.h.
References dcd_params::dcdSelectionIndexReverse, and dcdSelectionParams.
Referenced by CollectionMaster::CollectVectorInstanceDcdSelection::append(), Output::coordinate(), and wrap_coor_int_dcd_selection().
|
inline |
Definition at line 893 of file Molecule.h.
References dcdSelectionParams, and dcd_params::size.
Referenced by Output::coordinate(), and wrap_coor_int_dcd_selection().
|
inline |
Definition at line 1150 of file Molecule.h.
Referenced by atoms_1to4(), and dumpbench().
|
inline |
Definition at line 1224 of file Molecule.h.
Referenced by atoms_1to4(), and dumpbench().
|
inline |
Definition at line 1178 of file Molecule.h.
|
inline |
Definition at line 1248 of file Molecule.h.
Referenced by dumpbench().
|
inline |
Definition at line 1188 of file Molecule.h.
|
inline |
Definition at line 1230 of file Molecule.h.
|
inline |
Definition at line 1482 of file Molecule.h.
References NAMD_die(), order, and simParams.
Referenced by AngleElem::computeForce(), ImproperElem::computeForce(), DihedralElem::computeForce(), AnisoElem::computeForce(), and BondElem::computeForce().
|
inline |
Definition at line 1437 of file Molecule.h.
Referenced by CrosstermElem::computeForce(), TholeElem::computeForce(), WorkDistrib::createAtomLists(), and ComputeHomeTuples< TholeElem, Thole, TholeValue >::loadTuples().
|
inline |
Definition at line 1232 of file Molecule.h.
|
inline |
Definition at line 1657 of file Molecule.h.
References go_val::cutoff, go_array, and MAX_GO_CHAINS.
Referenced by build_go_arrays(), build_go_sigmas(), build_go_sigmas2(), get_go_force(), get_go_force2(), and get_go_force_new().
|
inline |
Definition at line 1666 of file Molecule.h.
References go_val::epsilon, go_array, and MAX_GO_CHAINS.
Referenced by get_go_force(), get_go_force2(), and get_go_force_new().
|
inline |
Definition at line 1660 of file Molecule.h.
References go_val::epsilonRep, go_array, and MAX_GO_CHAINS.
Referenced by get_go_force(), get_go_force2(), and get_go_force_new().
|
inline |
Definition at line 1669 of file Molecule.h.
References go_val::exp_a, go_array, and MAX_GO_CHAINS.
Referenced by build_go_sigmas(), build_go_sigmas2(), get_go_force(), get_go_force2(), and get_go_force_new().
|
inline |
Definition at line 1672 of file Molecule.h.
References go_val::exp_b, go_array, and MAX_GO_CHAINS.
Referenced by build_go_sigmas(), build_go_sigmas2(), get_go_force(), get_go_force2(), and get_go_force_new().
|
inline |
Definition at line 1675 of file Molecule.h.
References go_val::exp_rep, go_array, and MAX_GO_CHAINS.
Referenced by get_go_force(), get_go_force2(), and get_go_force_new().
BigReal Molecule::get_go_force | ( | BigReal | r, |
int | atom1, | ||
int | atom2, | ||
BigReal * | goNative, | ||
BigReal * | goNonnative | ||
) | const |
Definition at line 1261 of file GoMolecule.C.
References atomChainTypes, get_go_cutoff(), get_go_epsilon(), get_go_epsilonRep(), get_go_exp_a(), get_go_exp_b(), get_go_exp_rep(), get_go_sigmaRep(), goSigmaIndices, goSigmas, goWithinCutoff, and numGoAtoms.
BigReal Molecule::get_go_force2 | ( | BigReal | x, |
BigReal | y, | ||
BigReal | z, | ||
int | atom1, | ||
int | atom2, | ||
BigReal * | goNative, | ||
BigReal * | goNonnative | ||
) | const |
Definition at line 1457 of file GoMolecule.C.
References atomChainTypes, get_go_cutoff(), get_go_epsilon(), get_go_epsilonRep(), get_go_exp_a(), get_go_exp_b(), get_go_exp_rep(), get_go_sigmaRep(), go_restricted(), goIndxLJB, goResidIndices, goSigmaPairA, goSigmaPairB, pointerToGoBeg, and pointerToGoEnd.
BigReal Molecule::get_go_force_new | ( | BigReal | r, |
int | atom1, | ||
int | atom2, | ||
BigReal * | goNative, | ||
BigReal * | goNonnative | ||
) | const |
Definition at line 1335 of file GoMolecule.C.
References atomChainTypes, DebugM, get_go_cutoff(), get_go_epsilon(), get_go_epsilonRep(), get_go_exp_a(), get_go_exp_b(), get_go_exp_rep(), get_go_sigmaRep(), go_restricted(), goCoordinates, goResids, and goSigmaIndices.
|
inline |
Definition at line 1663 of file Molecule.h.
References go_array, MAX_GO_CHAINS, and go_val::sigmaRep.
Referenced by get_go_force(), get_go_force2(), and get_go_force_new().
|
inline |
Definition at line 1368 of file Molecule.h.
References numGridforceGrids.
Referenced by colvarproxy_namd::compute_volmap(), ComputeGridForce::doForce(), colvarproxy_namd::init_volmap_by_name(), Node::reloadGridforceGrid(), and Node::updateGridScale().
Definition at line 1362 of file Molecule.h.
Referenced by ComputeGridForce::do_calc().
BigReal Molecule::get_gro_force2 | ( | BigReal | x, |
BigReal | y, | ||
BigReal | z, | ||
int | atom1, | ||
int | atom2, | ||
BigReal * | pairLJEnergy, | ||
BigReal * | pairGaussEnergy | ||
) | const |
Definition at line 1174 of file GoMolecule.C.
References gA, giSigma1, giSigma2, gMu1, gMu2, gRepulsive, indxGaussB, indxLJB, pairC12, pairC6, pointerToGaussBeg, pointerToGaussEnd, pointerToLJBeg, and pointerToLJEnd.
int Molecule::get_groupSize | ( | int | ) |
|
inline |
Definition at line 1147 of file Molecule.h.
Referenced by dumpbench().
|
inline |
Definition at line 1226 of file Molecule.h.
Referenced by dumpbench().
|
inline |
Definition at line 1157 of file Molecule.h.
Referenced by ComputeLonepairsCUDA::updateAtoms().
|
inline |
Definition at line 1234 of file Molecule.h.
int Molecule::get_mother_atom | ( | int | ) | const |
|
inline |
Definition at line 1413 of file Molecule.h.
Referenced by Sequencer::addMovDragToPosition().
|
inline |
Definition at line 910 of file Molecule.h.
Referenced by ComputeQM::initialize().
|
inline |
Definition at line 865 of file Molecule.h.
Referenced by ComputeQMMgr::calcMOPAC(), ComputeQMMgr::calcORCA(), ComputeQMMgr::calcUSR(), ComputePme::doQMWork(), ComputeQM::initialize(), ComputeQMMgr::procQMRes(), HomePatch::qmSwapAtoms(), ComputeQMMgr::recvPartQM(), and ComputeQM::saveResults().
|
inline |
Definition at line 862 of file Molecule.h.
Referenced by ComputeQMMgr::calcMOPAC(), ComputeQMMgr::calcORCA(), ComputeQMMgr::calcUSR(), ComputePme::doQMWork(), ComputeQM::initialize(), HomePatch::qmSwapAtoms(), and ComputeQM::saveResults().
|
inline |
Definition at line 863 of file Molecule.h.
Referenced by ComputeQMMgr::calcMOPAC(), ComputeQMMgr::calcORCA(), ComputeQMMgr::calcUSR(), ComputePme::doQMWork(), ComputeQM::initialize(), HomePatch::qmSwapAtoms(), and ComputeQM::saveResults().
|
inline |
Definition at line 859 of file Molecule.h.
Referenced by ComputeQMMgr::calcMOPAC(), ComputeQMMgr::calcORCA(), ComputeQMMgr::calcUSR(), ComputePme::doQMWork(), ComputeQM::initialize(), HomePatch::qmSwapAtoms(), and ComputeQM::saveResults().
|
inline |
Definition at line 860 of file Molecule.h.
|
inline |
Definition at line 921 of file Molecule.h.
Referenced by ComputeQMMgr::recvPartQM().
|
inline |
Definition at line 919 of file Molecule.h.
Referenced by ComputeQM::initialize().
|
inline |
Definition at line 918 of file Molecule.h.
Referenced by ComputeQM::initialize().
|
inline |
Definition at line 874 of file Molecule.h.
Referenced by ComputeQMMgr::recvPntChrg().
|
inline |
Definition at line 879 of file Molecule.h.
Referenced by ComputeQMMgr::recvPntChrg().
|
inline |
Definition at line 866 of file Molecule.h.
Referenced by ComputeQMMgr::recvPntChrg().
|
inline |
Definition at line 877 of file Molecule.h.
Referenced by ComputeQMMgr::recvPntChrg().
|
inline |
Definition at line 870 of file Molecule.h.
Referenced by ComputeQMMgr::recvPartQM().
|
inline |
Definition at line 869 of file Molecule.h.
Referenced by ComputeQM::initialize(), and ComputeQMMgr::recvPartQM().
|
inline |
Definition at line 871 of file Molecule.h.
Referenced by ComputeQMMgr::recvPartQM().
|
inline |
Definition at line 875 of file Molecule.h.
Referenced by ComputeQMMgr::recvPntChrg().
|
inline |
Definition at line 868 of file Molecule.h.
Referenced by ComputeQMMgr::recvPntChrg().
|
inline |
Definition at line 901 of file Molecule.h.
Referenced by ComputeQMMgr::recvPartQM().
|
inline |
Definition at line 899 of file Molecule.h.
Referenced by ComputeQMMgr::recvPartQM().
|
inline |
Definition at line 900 of file Molecule.h.
Referenced by ComputeQMMgr::recvPartQM().
|
inline |
Definition at line 903 of file Molecule.h.
Referenced by ComputeQMMgr::recvPartQM().
|
inline |
Definition at line 905 of file Molecule.h.
|
inline |
Definition at line 904 of file Molecule.h.
Referenced by ComputeQMMgr::recvPartQM().
|
inline |
Definition at line 902 of file Molecule.h.
Referenced by ComputeQMMgr::recvPartQM().
|
inline |
Definition at line 898 of file Molecule.h.
Referenced by ComputeQMMgr::recvPartQM().
|
inline |
Definition at line 912 of file Molecule.h.
Referenced by ComputeQM::initialize().
|
inline |
Definition at line 911 of file Molecule.h.
Referenced by ComputeQM::initialize(), and ComputeQMMgr::recvPartQM().
|
inline |
Definition at line 913 of file Molecule.h.
Referenced by ComputeQM::initialize().
|
inline |
Definition at line 876 of file Molecule.h.
Referenced by ComputeQMMgr::recvPntChrg().
|
inline |
Definition at line 878 of file Molecule.h.
Referenced by ComputeQMMgr::recvPntChrg().
|
inline |
Definition at line 881 of file Molecule.h.
Referenced by ComputeQMMgr::recvPntChrg().
|
inline |
Definition at line 882 of file Molecule.h.
Referenced by ComputeQMMgr::recvPntChrg().
|
inline |
Definition at line 906 of file Molecule.h.
|
inline |
Definition at line 873 of file Molecule.h.
|
inline |
Definition at line 867 of file Molecule.h.
Referenced by ComputeQM::initialize(), ComputeQMMgr::recvPartQM(), and ComputeQM::saveResults().
|
inline |
Definition at line 915 of file Molecule.h.
Referenced by ComputeQMMgr::recvPartQM().
|
inline |
Definition at line 908 of file Molecule.h.
Referenced by ComputeQMMgr::recvPartQM().
|
inline |
Definition at line 917 of file Molecule.h.
Referenced by ComputeQM::initialize().
int Molecule::get_residue_size | ( | const char * | segid, |
int | resid | ||
) | const |
Definition at line 149 of file Molecule.C.
References NAMD_die().
Referenced by GlobalMasterEasy::getNumAtoms(), GlobalMasterFreeEnergy::getNumAtoms(), and prepare_qm().
Definition at line 1419 of file Molecule.h.
Referenced by Sequencer::addRotDragToPosition().
|
inline |
Definition at line 1448 of file Molecule.h.
Referenced by ComputeHomeTuples< TholeElem, Thole, TholeValue >::loadTuples(), and Sequencer::rescaleSoluteCharges().
|
inline |
Definition at line 1394 of file Molecule.h.
|
inline |
Definition at line 1406 of file Molecule.h.
Referenced by ComputeStir::doForce().
|
inline |
Definition at line 1184 of file Molecule.h.
|
inline |
|
inline |
|
inline |
Definition at line 1170 of file Molecule.h.
Referenced by buildCrosstermData().
|
inline |
Definition at line 1169 of file Molecule.h.
Referenced by buildDihedralData().
|
inline |
Definition at line 1183 of file Molecule.h.
|
inline |
Definition at line 1168 of file Molecule.h.
Referenced by buildImproperData().
|
inline |
Definition at line 1174 of file Molecule.h.
|
inline |
|
inline |
|
inline |
Definition at line 520 of file Molecule.h.
Referenced by buildAtomData(), WorkDistrib::createAtomLists(), and outputCompressedFile().
|
inline |
Definition at line 524 of file Molecule.h.
Referenced by buildAtomData().
|
inline |
Definition at line 1108 of file Molecule.h.
Referenced by NamdState::loadStructure(), and outputCompressedFile().
Referenced by Controller::getTotalPotentialEnergy(), and Controller::printEnergies().
|
inline |
Definition at line 1443 of file Molecule.h.
|
inline |
Definition at line 508 of file Molecule.h.
Referenced by HomePatch::setLcpoType().
|
inline |
Definition at line 1104 of file Molecule.h.
Referenced by NamdState::loadStructure(), and outputCompressedFile().
Referenced by Controller::calcPressure().
Bool Molecule::go_restricted | ( | int | chain1, |
int | chain2, | ||
int | rDiff | ||
) |
Definition at line 526 of file GoMolecule.C.
References FALSE, go_array, MAX_GO_CHAINS, MAX_RESTRICTIONS, and TRUE.
Referenced by build_go_arrays(), build_go_sigmas(), build_go_sigmas2(), get_go_force2(), and get_go_force_new().
void Molecule::goInit | ( | ) |
Definition at line 55 of file GoMolecule.C.
References atomChainTypes, energyNative, energyNonnative, goCoordinates, goPDB, goResids, goSigmaIndices, goSigmas, goWithinCutoff, and numGoAtoms.
void Molecule::initialize | ( | ) |
|
inline |
|
inline |
Definition at line 1272 of file Molecule.h.
References FALSE, and numConstraints.
Referenced by ComputeRestraints::doForce().
|
inline |
|
inline |
Definition at line 1544 of file Molecule.h.
References numExPressureAtoms.
Referenced by Sequencer::langevinPiston().
|
inline |
Definition at line 1504 of file Molecule.h.
References numFixedAtoms.
Referenced by WorkDistrib::createAtomLists().
|
inline |
Definition at line 1256 of file Molecule.h.
References FALSE, and numGridforceGrids.
Referenced by ComputeGridForce::checkGridForceRatio(), ComputeGridForce::createGridForcedIdxList(), and ComputeGridForce::do_calc().
|
inline |
Definition at line 1289 of file Molecule.h.
References FALSE, and numMovDrag.
Referenced by Sequencer::addMovDragToPosition().
|
inline |
Definition at line 1305 of file Molecule.h.
References FALSE, and numRotDrag.
Referenced by Sequencer::addRotDragToPosition().
|
inline |
Definition at line 1525 of file Molecule.h.
References FALSE, and numStirredAtoms.
Referenced by ComputeStir::doForce().
Bool Molecule::is_drude | ( | int | ) | const |
|
inline |
Bool Molecule::is_hydrogen | ( | int | ) |
Bool Molecule::is_hydrogenGroupParent | ( | int | ) |
Bool Molecule::is_lp | ( | int | ) |
Bool Molecule::is_oxygen | ( | int | ) |
Bool Molecule::is_water | ( | int | ) |
Referenced by outputCompressedFile(), wrap_coor_int(), and wrap_coor_int_dcd_selection().
|
inline |
Definition at line 1388 of file Molecule.h.
Referenced by WorkDistrib::createAtomLists().
|
inline |
Definition at line 553 of file Molecule.h.
References num_fixed_atoms(), numAtoms, numConstraints, numFepInitial, numFixedRigidBonds, numLonepairs, numRigidBonds, simParams, and TIP4.
Referenced by Controller::Controller(), NamdState::loadStructure(), and Controller::receivePressure().
|
inline |
Definition at line 527 of file Molecule.h.
References numFixedAtoms, and simParams.
Referenced by num_deg_freedom(), num_fixed_groups(), num_group_deg_freedom(), and Controller::receivePressure().
|
inline |
Definition at line 533 of file Molecule.h.
References num_fixed_atoms(), and numFixedGroups.
Referenced by num_group_deg_freedom(), and Controller::receivePressure().
|
inline |
Definition at line 540 of file Molecule.h.
References num_fixed_atoms(), num_fixed_groups(), numConstraints, numHydrogenGroups, and simParams.
Referenced by Controller::receivePressure().
void Molecule::parse_dcd_selection_params | ( | ConfigList * | configList | ) |
Referenced by NamdState::loadStructure().
void Molecule::prepare_qm | ( | const char * | pdbFileName, |
Parameters * | params, | ||
ConfigList * | cfgList | ||
) |
Prepares Live Solvent Selection
Data gathering from PDB to find QM atom and bond info
Multiplicity of each QM group
Charge of each QM group
Populate arrays that are used throughout the the calculations.
Overides Link Atom element with user selection.
Bond Schemes. Prepares for treatment of QM-MM bonds in ComputeQM.C
Live Solvent Selection
Custom Point Charge selection
Topology preparation
Definition at line 110 of file MoleculeQM.C.
References Parameters::assign_vdw_index(), qmSolvData::atmIDs, PDB::atom(), bond::atom1, bond::atom2, ResizeArray< Elem >::begin(), bond::bond_type, atom_constants::charge, StringList::data, DebugM, PDBAtom::element(), ResizeArray< Elem >::end(), endi(), SimParameters::extraBondsOn, SortedArray< Elem >::find(), ConfigList::find(), SimParameters::fixedAtomsOn, get_residue_size(), ObjectArena< Type >::getNewArray(), iERROR(), iINFO(), SortedArray< Elem >::insert(), iout, iWARN(), ResidueLookupElem::lookup(), atom_constants::mass, NAMD_blank_string(), NAMD_die(), NAMD_read_line(), StringList::next, PDB::num_atoms(), numAtoms, numBonds, numRealBonds, PDBAtom::occupancy(), SimParameters::PMEOn, SimParameters::qmBondColumnDefined, SimParameters::qmBondDist, SimParameters::qmBondGuess, SimParameters::qmBondOn, SimParameters::qmBondScheme, SimParameters::qmChrgFromPSF, SimParameters::qmColumn, SimParameters::qmCSMD, SimParameters::qmCustomPCSel, SimParameters::qmElecEmbed, SimParameters::qmFormat, QMFormatMOPAC, QMFormatORCA, SimParameters::qmLSSFreq, SimParameters::qmLSSMode, QMLSSMODECOM, QMLSSMODEDIST, SimParameters::qmLSSOn, SimParameters::qmLSSResname, SimParameters::qmMOPACAddConfigChrg, SimParameters::qmNoPC, SimParameters::qmPCSelFreq, QMSCHEMECS, QMSCHEMERCD, QMSCHEMEZ1, QMSCHEMEZ2, QMSCHEMEZ3, SimParameters::qmVDW, PDBAtom::residuename(), PDBAtom::residueseq(), PDBAtom::segmentname(), qmSolvData::size, ResizeArray< Elem >::size(), split(), SimParameters::stepsPerCycle, and PDBAtom::temperaturefactor().
Referenced by NamdState::loadStructure().
void Molecule::print_atoms | ( | Parameters * | params | ) |
Definition at line 5548 of file Molecule.C.
References DebugM, endi(), Parameters::get_num_vdw_params(), Parameters::get_vdw_params(), and simParams.
Referenced by NamdState::loadStructure().
void Molecule::print_bonds | ( | Parameters * | params | ) |
Definition at line 5594 of file Molecule.C.
References DebugM, endi(), and Parameters::get_bond_params().
Referenced by NamdState::loadStructure().
void Molecule::print_exclusions | ( | ) |
Definition at line 5631 of file Molecule.C.
References DebugM, and endi().
Referenced by NamdState::loadStructure().
void Molecule::print_go_params | ( | ) |
Definition at line 549 of file GoMolecule.C.
References DebugM, go_array, MAX_GO_CHAINS, and NumGoChains.
void Molecule::print_go_sigmas | ( | ) |
Definition at line 1135 of file GoMolecule.C.
References DebugM, goSigmaIndices, goSigmas, numAtoms, and numGoAtoms.
|
inline |
Definition at line 1400 of file Molecule.h.
void Molecule::read_alch_unpert_angles | ( | FILE * | fd | ) |
Definition at line 1824 of file Molecule.C.
References NAMD_die(), and NAMD_read_int().
void Molecule::read_alch_unpert_bonds | ( | FILE * | fd | ) |
Definition at line 1701 of file Molecule.C.
References bond::atom1, bond::atom2, NAMD_die(), and NAMD_read_int().
void Molecule::read_alch_unpert_dihedrals | ( | FILE * | fd | ) |
Definition at line 1972 of file Molecule.C.
References NAMD_die(), and NAMD_read_int().
void Molecule::read_go_file | ( | char * | fname | ) |
Definition at line 114 of file GoMolecule.C.
References go_val::cutoff, DebugM, endi(), go_val::epsilon, go_val::epsilonRep, go_val::exp_a, go_val::exp_b, go_val::exp_rep, FALSE, go_array, go_indices, iout, iWARN(), MAX_GO_CHAINS, MAX_RESTRICTIONS, NAMD_blank_string(), NAMD_die(), NAMD_find_first_word(), NAMD_read_line(), NumGoChains, go_val::restrictions, go_val::sigmaRep, and TRUE.
Referenced by build_go_params().
void Molecule::read_parm | ( | Ambertoppar * | ) |
void Molecule::read_parm | ( | AmberParm7Reader::Ambertoppar * | ) |
void Molecule::receive_GoMolecule | ( | MIStream * | msg | ) |
Definition at line 1745 of file GoMolecule.C.
References atomChainTypes, go_val::cutoff, go_val::epsilon, go_val::epsilonRep, go_val::exp_a, go_val::exp_b, go_val::exp_rep, MIStream::get(), go_array, go_indices, goCoordinates, SimParameters::goForcesOn, goIndxLJA, goIndxLJB, SimParameters::goMethod, goNumLJPair, goResidIndices, goResids, goSigmaIndices, goSigmaPairA, goSigmaPairB, goSigmas, goWithinCutoff, MAX_GO_CHAINS, MAX_RESTRICTIONS, NAMD_die(), numAtoms, numGoAtoms, NumGoChains, pointerToGoBeg, pointerToGoEnd, go_val::restrictions, and go_val::sigmaRep.
void Molecule::receive_Molecule | ( | MIStream * | msg | ) |
Definition at line 6028 of file Molecule.C.
References gromacsPair::atom1, gromacsPair::atom2, atomNamePool, atomSigPool, DebugM, MIStream::get(), Parameters::get_num_vdw_params(), gromacsPair::gromacsPair_type, numGaussPair, numLJPair, gromacsPair::pairC12, gromacsPair::pairC6, simParams, and GridforceGrid::unpack_grid().
Referenced by Node::resendMolecule().
void Molecule::reloadCharges | ( | float | charge[], |
int | n | ||
) |
Referenced by Node::reloadCharges().
|
inline |
Definition at line 1550 of file Molecule.h.
Referenced by WorkDistrib::createAtomLists(), and outputCompressedFile().
void Molecule::send_GoMolecule | ( | MOStream * | msg | ) |
Definition at line 1636 of file GoMolecule.C.
References atomChainTypes, go_val::cutoff, MOStream::end(), go_val::epsilon, go_val::epsilonRep, go_val::exp_a, go_val::exp_b, go_val::exp_rep, go_array, go_indices, goCoordinates, SimParameters::goForcesOn, goIndxLJA, goIndxLJB, SimParameters::goMethod, goNumLJPair, goResidIndices, goResids, goSigmaIndices, goSigmaPairA, goSigmaPairB, goSigmas, goWithinCutoff, MAX_GO_CHAINS, MAX_RESTRICTIONS, NAMD_die(), numAtoms, numGoAtoms, NumGoChains, pointerToGoBeg, pointerToGoEnd, MOStream::put(), go_val::restrictions, and go_val::sigmaRep.
void Molecule::send_Molecule | ( | MOStream * | msg | ) |
Definition at line 5662 of file Molecule.C.
References atomNamePool, atomSigPool, DebugM, MOStream::end(), endi(), Parameters::get_num_vdw_params(), numGaussPair, numLJPair, GridforceGrid::pack_grid(), MOStream::put(), and simParams.
Referenced by Node::resendMolecule().
|
inline |
Definition at line 1377 of file Molecule.h.
References numGridforceGrids.
Referenced by Node::reloadGridforceGrid().
|
inline |
Definition at line 857 of file Molecule.h.
Referenced by NamdState::loadStructure().
void Molecule::setBFactorData | ( | molfile_atom_t * | atomarray | ) |
Definition at line 3289 of file Molecule.C.
void Molecule::setOccupancyData | ( | molfile_atom_t * | atomarray | ) |
Definition at line 3282 of file Molecule.C.
|
inline |
Definition at line 726 of file Molecule.h.
References per_atom_flags::dcdSelection, and AtomCstInfo::flags.
|
friend |
Definition at line 239 of file Molecule.h.
|
friend |
Definition at line 243 of file Molecule.h.
|
friend |
Definition at line 238 of file Molecule.h.
|
friend |
Definition at line 245 of file Molecule.h.
|
friend |
Definition at line 240 of file Molecule.h.
|
friend |
Definition at line 237 of file Molecule.h.
|
friend |
Definition at line 247 of file Molecule.h.
|
friend |
Definition at line 241 of file Molecule.h.
|
friend |
Definition at line 244 of file Molecule.h.
|
friend |
Definition at line 242 of file Molecule.h.
|
friend |
Definition at line 249 of file Molecule.h.
Angle* Molecule::alch_unpert_angles |
Definition at line 606 of file Molecule.h.
Referenced by ComputeHomeTuples< TholeElem, Thole, TholeValue >::loadTuples().
Bond* Molecule::alch_unpert_bonds |
Definition at line 605 of file Molecule.h.
Referenced by ComputeHomeTuples< TholeElem, Thole, TholeValue >::loadTuples().
Dihedral* Molecule::alch_unpert_dihedrals |
Definition at line 607 of file Molecule.h.
Referenced by ComputeHomeTuples< TholeElem, Thole, TholeValue >::loadTuples().
int Molecule::alchDroppedAngles |
Definition at line 593 of file Molecule.h.
Referenced by NamdState::loadStructure().
int Molecule::alchDroppedDihedrals |
Definition at line 594 of file Molecule.h.
Referenced by NamdState::loadStructure().
int Molecule::alchDroppedImpropers |
Definition at line 595 of file Molecule.h.
Referenced by NamdState::loadStructure().
int32* Molecule::atomChainTypes |
Definition at line 680 of file Molecule.h.
Referenced by build_go_arrays(), build_go_sigmas(), build_go_sigmas2(), get_go_force(), get_go_force2(), get_go_force_new(), goInit(), receive_GoMolecule(), and send_GoMolecule().
Vector* Molecule::consForce |
Definition at line 649 of file Molecule.h.
Referenced by ComputeConsForce::doForce(), and ComputeMgr::recvComputeConsForceMsg().
int32* Molecule::consForceIndexes |
Definition at line 648 of file Molecule.h.
Referenced by ComputeConsForce::doForce(), and ComputeMgr::recvComputeConsForceMsg().
int32* Molecule::consTorqueIndexes |
Definition at line 651 of file Molecule.h.
Referenced by ComputeConsTorque::doForce(), get_constorque_params(), and is_atom_constorqued().
ConsTorqueParams* Molecule::consTorqueParams |
Definition at line 652 of file Molecule.h.
Referenced by get_constorque_params().
bool Molecule::dcdSelectionAtoms |
Definition at line 481 of file Molecule.h.
Referenced by is_atom_dcd_selection(), ParallelIOMgr::recvDcdParams(), and ParallelIOMgr::sendDcdParams().
std::map<std::string, int> Molecule::dcdSelectionKeyMap |
Definition at line 483 of file Molecule.h.
DCDParams Molecule::dcdSelectionParams[16] |
Definition at line 482 of file Molecule.h.
Referenced by SimParameters::close_dcdfile(), Output::coordinate(), Output::coordinateNeeded(), get_atom_index_from_dcd_selection(), get_dcd_selection_index_from_atom_id(), get_dcd_selection_size(), Sequencer::integrate_SOA(), NamdState::loadStructure(), ParallelIOMgr::readInfoForParOutDcdSelection(), ParallelIOMgr::recvDcdParams(), and ParallelIOMgr::sendDcdParams().
BigReal Molecule::energyNative |
Definition at line 721 of file Molecule.h.
Referenced by build_go_arrays(), and goInit().
BigReal Molecule::energyNonnative |
Definition at line 722 of file Molecule.h.
Referenced by build_go_arrays(), and goInit().
Real* Molecule::gA |
Definition at line 713 of file Molecule.h.
Referenced by get_gro_force2().
Real* Molecule::giSigma1 |
Definition at line 715 of file Molecule.h.
Referenced by get_gro_force2().
Real* Molecule::giSigma2 |
Definition at line 717 of file Molecule.h.
Referenced by get_gro_force2().
Real* Molecule::gMu1 |
Definition at line 714 of file Molecule.h.
Referenced by get_gro_force2().
Real* Molecule::gMu2 |
Definition at line 716 of file Molecule.h.
Referenced by get_gro_force2().
GoValue Molecule::go_array[MAX_GO_CHAINS *MAX_GO_CHAINS] |
Definition at line 1640 of file Molecule.h.
Referenced by get_go_cutoff(), get_go_epsilon(), get_go_epsilonRep(), get_go_exp_a(), get_go_exp_b(), get_go_exp_rep(), get_go_sigmaRep(), go_restricted(), print_go_params(), read_go_file(), receive_GoMolecule(), and send_GoMolecule().
int Molecule::go_indices[MAX_GO_CHAINS+1] |
Definition at line 1641 of file Molecule.h.
Referenced by read_go_file(), receive_GoMolecule(), and send_GoMolecule().
Real* Molecule::goCoordinates |
Definition at line 685 of file Molecule.h.
Referenced by build_go_arrays(), get_go_force_new(), goInit(), receive_GoMolecule(), and send_GoMolecule().
int* Molecule::goIndxLJA |
Definition at line 690 of file Molecule.h.
Referenced by build_go_sigmas2(), receive_GoMolecule(), and send_GoMolecule().
int* Molecule::goIndxLJB |
Definition at line 691 of file Molecule.h.
Referenced by build_go_sigmas2(), get_go_force2(), receive_GoMolecule(), and send_GoMolecule().
int Molecule::goNumLJPair |
Definition at line 689 of file Molecule.h.
Referenced by build_go_sigmas2(), receive_GoMolecule(), and send_GoMolecule().
PDB* Molecule::goPDB |
Definition at line 687 of file Molecule.h.
Referenced by build_go_arrays(), build_go_sigmas(), build_go_sigmas2(), and goInit().
int32* Molecule::goResidIndices |
Definition at line 682 of file Molecule.h.
Referenced by build_go_sigmas2(), get_go_force2(), receive_GoMolecule(), and send_GoMolecule().
int* Molecule::goResids |
Definition at line 686 of file Molecule.h.
Referenced by build_go_arrays(), get_go_force_new(), goInit(), receive_GoMolecule(), and send_GoMolecule().
int32* Molecule::goSigmaIndices |
Definition at line 681 of file Molecule.h.
Referenced by build_go_arrays(), build_go_sigmas(), build_go_sigmas2(), get_go_force(), get_go_force_new(), goInit(), print_go_sigmas(), receive_GoMolecule(), and send_GoMolecule().
double* Molecule::goSigmaPairA |
Definition at line 692 of file Molecule.h.
Referenced by build_go_sigmas2(), get_go_force2(), receive_GoMolecule(), and send_GoMolecule().
double* Molecule::goSigmaPairB |
Definition at line 693 of file Molecule.h.
Referenced by build_go_sigmas2(), get_go_force2(), receive_GoMolecule(), and send_GoMolecule().
Real* Molecule::goSigmas |
Definition at line 683 of file Molecule.h.
Referenced by build_go_sigmas(), get_go_force(), goInit(), print_go_sigmas(), receive_GoMolecule(), and send_GoMolecule().
bool* Molecule::goWithinCutoff |
Definition at line 684 of file Molecule.h.
Referenced by build_go_sigmas(), get_go_force(), goInit(), receive_GoMolecule(), and send_GoMolecule().
Real* Molecule::gRepulsive |
Definition at line 718 of file Molecule.h.
Referenced by get_gro_force2().
int* Molecule::gromacsPair_type |
Definition at line 706 of file Molecule.h.
HydrogenGroup Molecule::hydrogenGroup |
Definition at line 676 of file Molecule.h.
Referenced by WorkDistrib::createAtomLists(), and outputCompressedFile().
int* Molecule::indxGaussA |
Definition at line 711 of file Molecule.h.
int* Molecule::indxGaussB |
Definition at line 712 of file Molecule.h.
Referenced by get_gro_force2().
int* Molecule::indxLJA |
Definition at line 702 of file Molecule.h.
int* Molecule::indxLJB |
Definition at line 703 of file Molecule.h.
Referenced by get_gro_force2().
int Molecule::is_drude_psf |
Definition at line 490 of file Molecule.h.
int Molecule::is_lonepairs_psf |
Definition at line 491 of file Molecule.h.
int Molecule::isBFactorValid |
Definition at line 1562 of file Molecule.h.
int Molecule::isOccupancyValid |
Definition at line 1562 of file Molecule.h.
int Molecule::maxHydrogenGroupSize |
Definition at line 636 of file Molecule.h.
Referenced by NamdState::loadStructure(), and outputCompressedFile().
int Molecule::maxMigrationGroupSize |
Definition at line 638 of file Molecule.h.
Referenced by NamdState::loadStructure(), and outputCompressedFile().
int32* Molecule::moleculeAtom |
atom index for all molecules
Definition at line 622 of file Molecule.h.
int32* Molecule::moleculeStartIndex |
starting index of each molecule
Definition at line 621 of file Molecule.h.
int Molecule::num_alch_unpert_Angles |
Definition at line 603 of file Molecule.h.
Referenced by ComputeHomeTuples< TholeElem, Thole, TholeValue >::loadTuples().
int Molecule::num_alch_unpert_Bonds |
Definition at line 602 of file Molecule.h.
Referenced by ComputeHomeTuples< TholeElem, Thole, TholeValue >::loadTuples().
int Molecule::num_alch_unpert_Dihedrals |
Definition at line 604 of file Molecule.h.
Referenced by ComputeHomeTuples< TholeElem, Thole, TholeValue >::loadTuples().
int Molecule::numAcceptors |
Definition at line 599 of file Molecule.h.
int Molecule::numAngles |
Definition at line 590 of file Molecule.h.
Referenced by buildAngleData(), delete_qm_bonded(), dumpbench(), AngleElem::getMoleculePointers(), and NamdState::loadStructure().
int Molecule::numAnisos |
Number of anisotropic terms.
Definition at line 613 of file Molecule.h.
Referenced by AnisoElem::getMoleculePointers().
int Molecule::numAtoms |
Definition at line 586 of file Molecule.h.
Referenced by GlobalMasterEasy::addForce(), GlobalMasterFreeEnergy::addForce(), WorkDistrib::assignNodeToPatch(), build12Excls(), build13Excls(), build14Excls(), build_go_arrays(), build_go_sigmas(), build_go_sigmas2(), buildAtomData(), buildBondData(), buildExclusions(), colvarproxy_namd::calculate(), colvarproxy_namd::check_atom_id(), Controller::compareChecksums(), ComputeMgr::createComputes(), CudaPmeOneDevice::CudaPmeOneDevice(), dumpbench(), GlobalMasterEasy::getMass(), GlobalMasterFreeEnergy::getMass(), GlobalMasterSymmetry::GlobalMasterSymmetry(), GlobalMasterTMD::GlobalMasterTMD(), colvarproxy_namd::init_atom_group(), colvarproxy_namd::init_atoms_map(), integrateAllAtomSigs(), loadMolInfo(), NamdState::loadStructure(), num_deg_freedom(), outputCompressedFile(), WorkDistrib::patchMapInit(), prepare_qm(), print_go_sigmas(), receive_GoMolecule(), Controller::receivePressure(), ComputeMgr::recvComputeConsForceMsg(), ComputeMsmSerialMgr::recvCoord(), ComputeExtMgr::recvCoord(), ComputeLjPmeSerialMgr::recvCoord(), ComputeFmmSerialMgr::recvCoord(), ComputeGBISserMgr::recvCoord(), ComputeQMMgr::recvPartQM(), Node::reloadCharges(), GlobalMasterEasy::requestAtom(), GlobalMasterFreeEnergy::requestAtom(), Node::resendMolecule(), Node::resendMolecule2(), send_GoMolecule(), Node::startup(), Tcl_centerOfMass(), Tcl_centerOfNumber(), Tcl_loadCoords(), Tcl_radiusOfGyration(), colvarproxy_namd::update_atoms_map(), and wrap_coor_int().
int Molecule::numBonds |
Definition at line 589 of file Molecule.h.
Referenced by buildBondData(), delete_qm_bonded(), dumpbench(), BondElem::getMoleculePointers(), NamdState::loadStructure(), and prepare_qm().
int Molecule::numCalcAngles |
Definition at line 658 of file Molecule.h.
Referenced by Controller::compareChecksums(), and dumpbench().
int Molecule::numCalcAnisos |
Definition at line 667 of file Molecule.h.
Referenced by Controller::compareChecksums().
int Molecule::numCalcBonds |
Definition at line 657 of file Molecule.h.
Referenced by Controller::compareChecksums(), and dumpbench().
int Molecule::numCalcCrossterms |
Definition at line 661 of file Molecule.h.
Referenced by Controller::compareChecksums().
int Molecule::numCalcDihedrals |
Definition at line 659 of file Molecule.h.
Referenced by Controller::compareChecksums(), and dumpbench().
int64 Molecule::numCalcExclusions |
Definition at line 662 of file Molecule.h.
Referenced by Controller::compareChecksums(), and dumpbench().
int64 Molecule::numCalcFullExclusions |
Definition at line 663 of file Molecule.h.
Referenced by Controller::compareChecksums().
int Molecule::numCalcImpropers |
Definition at line 660 of file Molecule.h.
Referenced by Controller::compareChecksums(), and dumpbench().
int Molecule::numCalcLJPair |
Definition at line 699 of file Molecule.h.
int Molecule::numCalcOneFourNbTholes |
Definition at line 668 of file Molecule.h.
Referenced by Controller::compareChecksums().
int Molecule::numCalcTholes |
Definition at line 666 of file Molecule.h.
Referenced by Controller::compareChecksums().
int Molecule::numConsForce |
Definition at line 647 of file Molecule.h.
Referenced by NamdState::loadStructure().
int Molecule::numConsTorque |
Definition at line 631 of file Molecule.h.
Referenced by is_atom_constorqued().
int Molecule::numConstraints |
Definition at line 624 of file Molecule.h.
Referenced by is_atom_constrained(), NamdState::loadStructure(), num_deg_freedom(), num_group_deg_freedom(), and Controller::receivePressure().
int Molecule::numCrossterms |
Definition at line 597 of file Molecule.h.
Referenced by buildCrosstermData(), delete_qm_bonded(), CrosstermElem::getMoleculePointers(), and NamdState::loadStructure().
int Molecule::numDihedrals |
Definition at line 591 of file Molecule.h.
Referenced by buildDihedralData(), delete_qm_bonded(), dumpbench(), DihedralElem::getMoleculePointers(), and NamdState::loadStructure().
int Molecule::numDonors |
Definition at line 598 of file Molecule.h.
int Molecule::numDrudeAtoms |
Number of Drude particles.
Definition at line 611 of file Molecule.h.
Referenced by NamdState::loadStructure(), and Controller::receivePressure().
int Molecule::numExclusions |
Definition at line 600 of file Molecule.h.
Referenced by ExclElem::getMoleculePointers(), and NamdState::loadStructure().
int Molecule::numExPressureAtoms |
Definition at line 634 of file Molecule.h.
Referenced by is_atom_exPressure().
int Molecule::numFepFinal |
Definition at line 644 of file Molecule.h.
Referenced by NamdState::loadStructure().
int Molecule::numFepInitial |
Definition at line 643 of file Molecule.h.
Referenced by NamdState::loadStructure(), num_deg_freedom(), and Controller::receivePressure().
int Molecule::numFixedAtoms |
Definition at line 632 of file Molecule.h.
Referenced by is_atom_fixed(), is_group_fixed(), NamdState::loadStructure(), num_fixed_atoms(), and Controller::receivePressure().
int Molecule::numFixedGroups |
Definition at line 639 of file Molecule.h.
Referenced by NamdState::loadStructure(), num_fixed_groups(), and Controller::receivePressure().
int Molecule::numFixedRigidBonds |
Definition at line 641 of file Molecule.h.
Referenced by NamdState::loadStructure(), num_deg_freedom(), and Controller::receivePressure().
int Molecule::numGaussPair |
Definition at line 710 of file Molecule.h.
int Molecule::numGoAtoms |
Definition at line 679 of file Molecule.h.
Referenced by build_go_arrays(), build_go_sigmas(), build_go_sigmas2(), get_go_force(), goInit(), print_go_sigmas(), receive_GoMolecule(), and send_GoMolecule().
int Molecule::NumGoChains |
Definition at line 1642 of file Molecule.h.
Referenced by print_go_params(), read_go_file(), receive_GoMolecule(), and send_GoMolecule().
int Molecule::numGridforceGrids |
Definition at line 626 of file Molecule.h.
Referenced by colvarproxy_namd::check_volmap_by_id(), ComputeGridForce::checkGridForceRatio(), ComputeGridForce::createGridForcedIdxList(), ComputeGridForce::doForce(), get_gridfrc_grid(), is_atom_gridforced(), NamdState::loadStructure(), and set_gridfrc_grid().
int* Molecule::numGridforces |
Definition at line 627 of file Molecule.h.
int Molecule::numHydrogenGroups |
Definition at line 635 of file Molecule.h.
Referenced by NamdState::loadStructure(), num_group_deg_freedom(), outputCompressedFile(), and Controller::receivePressure().
int Molecule::numImpropers |
Definition at line 596 of file Molecule.h.
Referenced by buildImproperData(), delete_qm_bonded(), dumpbench(), ImproperElem::getMoleculePointers(), and NamdState::loadStructure().
int Molecule::numLargeMolecules |
Number of large molecules (compare to LARGEMOLTH)
Definition at line 620 of file Molecule.h.
int Molecule::numLJPair |
Definition at line 698 of file Molecule.h.
Referenced by build_go_sigmas2(), and GromacsPairElem::getMoleculePointers().
int Molecule::numLonepairs |
Number of lone pairs.
Definition at line 610 of file Molecule.h.
Referenced by NamdState::loadStructure(), num_deg_freedom(), and Controller::receivePressure().
int Molecule::numLphosts |
Number of lone pair host records in PSF.
Definition at line 614 of file Molecule.h.
int Molecule::numMigrationGroups |
Definition at line 637 of file Molecule.h.
Referenced by NamdState::loadStructure(), and outputCompressedFile().
int Molecule::numMolecules |
Number of 1-4 atom pairs with NBThole defined.
Number of molecules
Definition at line 619 of file Molecule.h.
Referenced by Controller::monteCarloPressure_accept().
int Molecule::numMovDrag |
Definition at line 629 of file Molecule.h.
Referenced by is_atom_movdragged().
int Molecule::numMultipleDihedrals |
Definition at line 672 of file Molecule.h.
Referenced by NamdState::loadStructure().
int Molecule::numMultipleImpropers |
Definition at line 674 of file Molecule.h.
Referenced by NamdState::loadStructure().
int Molecule::numOneFourNbTholes |
Definition at line 616 of file Molecule.h.
Referenced by OneFourNbTholeElem::getMoleculePointers().
int Molecule::numPair |
Definition at line 697 of file Molecule.h.
int Molecule::numRealBonds |
Definition at line 588 of file Molecule.h.
Referenced by buildBondData(), delete_qm_bonded(), and prepare_qm().
int Molecule::numRigidBonds |
Definition at line 640 of file Molecule.h.
Referenced by NamdState::loadStructure(), num_deg_freedom(), and Controller::receivePressure().
int Molecule::numRotDrag |
Definition at line 630 of file Molecule.h.
Referenced by is_atom_rotdragged().
int Molecule::numStirredAtoms |
Definition at line 633 of file Molecule.h.
Referenced by is_atom_stirred(), and NamdState::loadStructure().
int Molecule::numTholes |
Number of Thole terms.
Definition at line 612 of file Molecule.h.
Referenced by TholeElem::getMoleculePointers().
int64 Molecule::numTotalExclusions |
Definition at line 601 of file Molecule.h.
int Molecule::numZeroMassAtoms |
Number of atoms with zero mass.
Definition at line 615 of file Molecule.h.
Real* Molecule::pairC12 |
Definition at line 705 of file Molecule.h.
Referenced by get_gro_force2().
Real* Molecule::pairC6 |
Definition at line 704 of file Molecule.h.
Referenced by get_gro_force2().
int* Molecule::pointerToGaussBeg |
Definition at line 708 of file Molecule.h.
Referenced by get_gro_force2().
int* Molecule::pointerToGaussEnd |
Definition at line 709 of file Molecule.h.
Referenced by get_gro_force2().
int* Molecule::pointerToGoBeg |
Definition at line 694 of file Molecule.h.
Referenced by build_go_sigmas2(), get_go_force2(), receive_GoMolecule(), and send_GoMolecule().
int* Molecule::pointerToGoEnd |
Definition at line 695 of file Molecule.h.
Referenced by build_go_sigmas2(), get_go_force2(), receive_GoMolecule(), and send_GoMolecule().
int* Molecule::pointerToLJBeg |
Definition at line 700 of file Molecule.h.
Referenced by get_gro_force2().
int* Molecule::pointerToLJEnd |
Definition at line 701 of file Molecule.h.
Referenced by get_gro_force2().
Real Molecule::r_ohc |
Definition at line 496 of file Molecule.h.
Real Molecule::r_om |
Definition at line 495 of file Molecule.h.
int* Molecule::ss_index |
Definition at line 487 of file Molecule.h.
int Molecule::ss_num_vdw_params |
Definition at line 485 of file Molecule.h.
Referenced by ComputeLjPmeSerialMgr::getLJparameters(), and LJTable::LJTable().
int* Molecule::ss_vdw_type |
Definition at line 486 of file Molecule.h.
Referenced by ComputeLjPmeSerialMgr::getLJparameters().
int Molecule::suspiciousAlchBonds |
Definition at line 592 of file Molecule.h.
Referenced by NamdState::loadStructure().
BigReal Molecule::tail_corr_dUdl_1 |
Definition at line 501 of file Molecule.h.
BigReal Molecule::tail_corr_dUdl_2 |
Definition at line 501 of file Molecule.h.
BigReal Molecule::tail_corr_ener |
Definition at line 499 of file Molecule.h.
Referenced by Controller::rescaleaccelMD().
BigReal Molecule::tail_corr_virial |
Definition at line 500 of file Molecule.h.
BigReal Molecule::tail_corr_virial_1 |
Definition at line 502 of file Molecule.h.
BigReal Molecule::tail_corr_virial_2 |
Definition at line 502 of file Molecule.h.