32#define TOLCUTOFF 1.0E-2
52 char const*
const&
emap,
71 log.writeToStdout =
false;
72 string dir(directory);
73 char const separator =
'/';
74 if (dir.back() != separator) dir += separator;
79 bool collectStatistics =
false;
80 bool collectExtrapolationWarnings =
false;
82 bool stopOnExtrapolationWarnings =
false;
85 collectExtrapolationWarnings =
true;
88 collectExtrapolationWarnings,
90 stopOnExtrapolationWarnings);
94 log <<
"*** SETUP: LAMMPS INTERFACE *************"
95 "**************************************\n";
100 log <<
"Individual extrapolation warnings will be shown.\n";
104 log <<
"Individual extrapolation warnings will not be shown.\n";
109 log <<
strpr(
"Extrapolation warning summary will be shown every %d"
114 log <<
"Extrapolation warning summary will not be shown.\n";
119 log <<
strpr(
"The simulation will be stopped when %d extrapolation"
120 " warnings are exceeded.\n",
maxew);
124 log <<
"No extrapolation warning limit set.\n";
129 log <<
"Extrapolation warning counter is reset every time step.\n";
133 log <<
"Extrapolation warnings are accumulated over all time steps.\n";
136 log <<
"-----------------------------------------"
137 "--------------------------------------\n";
138 log <<
"CAUTION: If the LAMMPS unit system differs from the one used\n";
139 log <<
" during NN training, appropriate conversion factors\n";
140 log <<
" must be provided (see keywords cflength and cfenergy).\n";
146 log <<
"Checking consistency of cutoff radii (in LAMMPS units):\n";
147 log <<
strpr(
"LAMMPS Cutoff (via pair_coeff) : %11.3E\n", lammpsCutoff);
148 log <<
strpr(
"Maximum symmetry function cutoff: %11.3E\n", sfCutoff);
149 if (lammpsCutoff < sfCutoff)
151 throw runtime_error(
"ERROR: LAMMPS cutoff via pair_coeff keyword is"
152 " smaller than maximum symmetry function"
155 else if (fabs(sfCutoff - lammpsCutoff) / lammpsCutoff >
TOLCUTOFF)
157 log <<
"!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!\n";
158 log <<
"WARNING: Potential length units mismatch!\n";
159 log <<
"!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!\n";
163 log <<
"Cutoff radii are consistent.\n";
166 log <<
"-----------------------------------------"
167 "--------------------------------------\n";
168 log <<
"Element mapping string from LAMMPS to n2p2: \""
169 + this->emap +
"\"\n";
171 if (this->emap ==
"")
173 if (
elementMap.size() != (
size_t)lammpsNtypes)
175 throw runtime_error(
strpr(
"ERROR: No element mapping given and "
176 "number of LAMMPS atom types (%d) and "
177 "NNP elements (%zu) does not match.\n",
180 log <<
"Element mapping string empty, creating default mapping.\n";
181 for (
int i = 0; i < lammpsNtypes; ++i)
194 throw runtime_error(
strpr(
"ERROR: Element mapping is inconsistent,"
195 " NNP elements: %zu,"
196 " emap elements: %zu.\n",
200 for (
string s : emapSplit)
202 vector<string> typeString =
split(s,
':');
203 if (typeString.size() != 2)
205 throw runtime_error(
strpr(
"ERROR: Invalid element mapping "
206 "string: \"%s\".\n", s.c_str()));
208 int t = stoi(typeString.at(0));
209 if (t > lammpsNtypes)
211 throw runtime_error(
strpr(
"ERROR: LAMMPS type \"%d\" not "
212 "present, there are only %d types "
213 "defined.\n", t, lammpsNtypes));
221 log <<
"CAUTION: Please ensure that this mapping between LAMMPS\n";
222 log <<
" atom types and NNP elements is consistent:\n";
224 log <<
"---------------------------\n";
225 log <<
"LAMMPS type | NNP element\n";
226 log <<
"---------------------------\n";
227 for (
int i = 1; i <= lammpsNtypes; ++i)
232 log <<
strpr(
"%11d <-> %2s (%3zu)\n",
245 log <<
"---------------------------\n";
247 log <<
"NNP setup for LAMMPS completed.\n";
249 log <<
"*****************************************"
250 "**************************************\n";
268 int const*
const atomType)
278 structure.hasSymmetryFunctionDerivatives =
false;
283 indexMap.resize(numAtomsLocal, numeric_limits<size_t>::max());
284 for (
int i = 0; i < numAtomsLocal; i++)
308 for (
size_t i = 0; i <
structure.numAtoms; ++i)
327 for (
size_t i = 0; i <
structure.atoms.size(); i++)
338 for (
size_t i = 0; i <
structure.atoms.size(); i++)
355 structure.box[0][0] = boxhi[0] - boxlo[0];
361 structure.box[1][1] = boxhi[1] - boxlo[1];
367 structure.box[2][2] = boxhi[2] - boxlo[2];
371 if (
structure.box[0][1] > numeric_limits<double>::min() ||
372 structure.box[0][2] > numeric_limits<double>::min() ||
373 structure.box[1][0] > numeric_limits<double>::min() ||
374 structure.box[1][2] > numeric_limits<double>::min() ||
375 structure.box[2][0] > numeric_limits<double>::min() ||
376 structure.box[2][1] > numeric_limits<double>::min())
381 for(
size_t i = 0; i < 3; ++i)
403 for(
size_t i = 0; i <
structure.numAtoms; ++i)
406 a.neighbors.reserve(numneigh[i]);
420 indexMap.at(i) == numeric_limits<size_t>::max())
return;
449 a.hasNeighborList =
true;
452 structure.calculateMaxCutoffRadiusOverall(
465#ifdef N2P2_NO_SF_GROUPS
504#ifdef N2P2_NO_SF_GROUPS
539 structure.calculateMaxCutoffRadiusOverall(
573 double*
const& sigmaSqrtPi,
double *
const *
const& gammaSqrt2,
double& qRef)
const
575 for (
size_t i = 0; i <
structure.atoms.size(); ++i) {
577 size_t const ia = a.
index;
583 double const iSigma =
elements.at(i).getQsigma();
584 atomJ[i] =
elements.at(i).getHardness();
585 sigmaSqrtPi[i] = sqrt(M_PI) * iSigma;
588 double const jSigma =
elements.at(j).getQsigma();
589 gammaSqrt2[i][j] = sqrt(2.0 * (iSigma * iSigma + jSigma * jSigma));
597 Atom const* ai = NULL;
598 for (
size_t i = 0; i <
structure.atoms.size(); ++i)
601 size_t const ia = ai->
index;
602 dEtotdQ[ia] += ai->
dEdG.back();
607 double *
const &dChidx,
double *
const &dChidy,
double *
const &dChidz)
const
611 for (
size_t j = 0; j <
structure.numAtoms; ++j) {
613#ifndef NNP_FULL_SFD_MEMORY
614 vector <vector<size_t>>
const &tableFull
628 if (n.index == ai.
index) {
629#ifndef NNP_FULL_SFD_MEMORY
630 vector <size_t>
const &table = tableFull.at(n.element);
631 for (
size_t k = 0; k < n.dGdr.size(); ++k) {
632 dChi += aj.
dChidG.at(table.at(k)) * n.dGdr.at(k);
637 dChi += aj.
dChidG.at(k) * n.dGdr.at(k);
661 screenInfo[3] = 1.0 / (screenInfo[2] - screenInfo[1]);
681 double convForce = 1.0;
690 Atom const *a = NULL;
692 for (
size_t i = 0; i <
structure.atoms.size(); ++i) {
696#ifndef NNP_FULL_SFD_MEMORY
697 vector <vector<size_t>>
const &tableFull
701 for (vector<Atom::Neighbor>::const_iterator n = a->
neighbors.begin();
705 size_t const in = n->index;
708#ifndef NNP_FULL_SFD_MEMORY
709 vector <size_t>
const &table = tableFull.at(n->element);
710 for (
size_t s = 0; s < n->dGdr.size(); ++s)
712 double const dEdG = a->
dEdG[table.at(s)] * cfforce * convForce;
716 double const dEdG = a->
dEdG[s] * cfforce * convForce;
718 double const *
const dGdr = n->dGdr[s].r;
719 atomF[in][0] -= dEdG * dGdr[0];
720 atomF[in][1] -= dEdG * dGdr[1];
721 atomF[in][2] -= dEdG * dGdr[2];
726 size_t const ia = a->
index;
731 double const dEdG = a->
dEdG[s] * cfforce * convForce;
732 double const *
const dGdr = a->
dGdr[s].r;
733 atomF[ia][0] -= dEdG * dGdr[0];
734 atomF[ia][1] -= dEdG * dGdr[1];
735 atomF[ia][2] -= dEdG * dGdr[2];
745 double convForce = 1.0;
757 size_t const ia = a.
index;
759 selfForce *= cfforce * convForce;
764#ifndef N2P2_FULL_SFD_MEMORY
765 vector<vector<size_t> >
const& tableFull
773 #pragma omp parallel for
775 for (
size_t k = 0; k < numNeighbors; ++k)
780 size_t const in = n.
index;
782#ifndef N2P2_FULL_SFD_MEMORY
787 pairForce *= cfforce * convForce;
800 #pragma omp parallel for
803 for (
size_t i = 0; i < s.
numAtoms; ++i)
805 auto const& ai = s.
atoms[i];
808 for (
auto const& aj : s.
atoms)
810 size_t const j = aj.index;
812#ifndef N2P2_FULL_SFD_MEMORY
813 vector<vector<size_t> >
const& tableFull
814 =
elements.at(aj.element).getSymmetryFunctionTable();
815 Vec3D dChidr = aj.calculateDChidr(ai.index,
819 Vec3D dChidr = aj.calculateDChidr(ai.index,
823 Vec3D remainingForce = -lambdaTotal(j) * (ai.dAdrQ[j] + dChidr);
833 double*
const*
const& atomF)
const {
835 double convForce = 1.0;
844 Atom const *a = NULL;
846 for (
size_t i = 0; i <
structure.atoms.size(); ++i) {
852 size_t const ia = a->
index;
854 size_t const ta = a->
tag - 1;
856#ifndef NNP_FULL_SFD_MEMORY
857 vector <vector<size_t>>
const &tableFull
861 for (vector<Atom::Neighbor>::const_iterator n = a->
neighbors.begin();
865 size_t const in = n->index;
867 size_t const tn = n->tag - 1;
871#ifndef NNP_FULL_SFD_MEMORY
872 vector <size_t>
const &table = tableFull.at(n->element);
873 for (
size_t s = 0; s < n->dGdr.size(); ++s)
875 double const dChidG = a->
dChidG[table.at(s)]
876 * cfforce * convForce;
880 double const dChidG = a->
dChidG[s] * cfforce * convForce;
882 double const *
const dGdr = n->dGdr[s].r;
883 atomF[in][0] -= lambda[ta] * dChidG * dGdr[0];
884 atomF[in][1] -= lambda[ta] * dChidG * dGdr[1];
885 atomF[in][2] -= lambda[ta] * dChidG * dGdr[2];
892 double const dChidG = a->
dChidG[s] * cfforce * convForce;
893 double const *
const dGdr = a->
dGdr[s].r;
894 atomF[ia][0] -= lambda[ta] * dChidG * dGdr[0];
895 atomF[ia][1] -= lambda[ta] * dChidG * dGdr[1];
896 atomF[ia][2] -= lambda[ta] * dChidG * dGdr[2];
910 #pragma omp parallel for
912 for (
size_t i = 0; i < s.
numAtoms; ++i)
914 atomQ[i] = s.
atoms[i].charge;
927 MPI_Pack_size(1,
MPI_SIZE_T, MPI_COMM_WORLD, &ss);
928 MPI_Pack_size(1, MPI_DOUBLE, MPI_COMM_WORLD, &ds);
929 MPI_Pack_size(1, MPI_CHAR , MPI_COMM_WORLD, &cs);
931 for (vector<Element>::const_iterator it =
elements.begin();
934 map<size_t, SymFncStatistics::Container>
const& m
935 = it->statistics.data;
937 for (map<size_t, SymFncStatistics::Container>::const_iterator
938 it2 = m.begin(); it2 != m.end(); ++it2)
946 bs += (it2->second.element.length() + 1) * cs;
947 size_t countEW = it2->second.countEW;
961 for (vector<Element>::const_iterator it =
elements.begin();
964 map<size_t, SymFncStatistics::Container>
const& m =
967 MPI_Pack((
void *) &(n), 1,
MPI_SIZE_T, buf, bs, &
p, MPI_COMM_WORLD);
968 for (map<size_t, SymFncStatistics::Container>::const_iterator
969 it2 = m.begin(); it2 != m.end(); ++it2)
971 MPI_Pack((
void *) &(it2->first ), 1,
MPI_SIZE_T, buf, bs, &
p, MPI_COMM_WORLD);
972 size_t countEW = it2->second.countEW;
973 MPI_Pack((
void *) &(countEW ), 1,
MPI_SIZE_T, buf, bs, &
p, MPI_COMM_WORLD);
974 MPI_Pack((
void *) &(it2->second.type ), 1,
MPI_SIZE_T, buf, bs, &
p, MPI_COMM_WORLD);
975 MPI_Pack((
void *) &(it2->second.Gmin ), 1, MPI_DOUBLE, buf, bs, &
p, MPI_COMM_WORLD);
976 MPI_Pack((
void *) &(it2->second.Gmax ), 1, MPI_DOUBLE, buf, bs, &
p, MPI_COMM_WORLD);
978 size_t ts = it2->second.element.length() + 1;
979 MPI_Pack((
void *) &ts , 1,
MPI_SIZE_T, buf, bs, &
p, MPI_COMM_WORLD);
980 MPI_Pack((
void *) it2->second.element.c_str() , ts, MPI_CHAR , buf, bs, &
p, MPI_COMM_WORLD);
981 MPI_Pack((
void *) &(it2->second.indexStructureEW.front()), countEW,
MPI_SIZE_T, buf, bs, &
p, MPI_COMM_WORLD);
982 MPI_Pack((
void *) &(it2->second.indexAtomEW.front() ), countEW,
MPI_SIZE_T, buf, bs, &
p, MPI_COMM_WORLD);
983 MPI_Pack((
void *) &(it2->second.valueEW.front() ), countEW, MPI_DOUBLE, buf, bs, &
p, MPI_COMM_WORLD);
994 for (vector<Element>::iterator it =
elements.begin();
998 MPI_Unpack((
void *) buf, bs, &
p, &(n), 1,
MPI_SIZE_T, MPI_COMM_WORLD);
999 for (
size_t i = 0; i < n; ++i)
1002 MPI_Unpack((
void *) buf, bs, &
p, &(index), 1,
MPI_SIZE_T, MPI_COMM_WORLD);
1005 MPI_Unpack((
void *) buf, bs, &
p, &(countEW ), 1,
MPI_SIZE_T, MPI_COMM_WORLD);
1006 MPI_Unpack((
void *) buf, bs, &
p, &(
d.type ), 1,
MPI_SIZE_T, MPI_COMM_WORLD);
1007 MPI_Unpack((
void *) buf, bs, &
p, &(
d.Gmin ), 1, MPI_DOUBLE, MPI_COMM_WORLD);
1008 MPI_Unpack((
void *) buf, bs, &
p, &(
d.Gmax ), 1, MPI_DOUBLE, MPI_COMM_WORLD);
1011 MPI_Unpack((
void *) buf, bs, &
p, &ts , 1,
MPI_SIZE_T, MPI_COMM_WORLD);
1012 char* element =
new char[ts];
1013 MPI_Unpack((
void *) buf, bs, &
p, element , ts, MPI_CHAR , MPI_COMM_WORLD);
1014 d.element = element;
1017 d.indexStructureEW.resize(
d.countEW + countEW);
1018 MPI_Unpack((
void *) buf, bs, &
p, &(
d.indexStructureEW[
d.countEW]), countEW,
MPI_SIZE_T, MPI_COMM_WORLD);
1020 d.indexAtomEW.resize(
d.countEW + countEW);
1021 MPI_Unpack((
void *) buf, bs, &
p, &(
d.indexAtomEW[
d.countEW] ), countEW,
MPI_SIZE_T, MPI_COMM_WORLD);
1023 d.valueEW.resize(
d.countEW + countEW);
1024 MPI_Unpack((
void *) buf, bs, &
p, &(
d.valueEW[
d.countEW] ), countEW, MPI_DOUBLE, MPI_COMM_WORLD);
1026 d.countEW += countEW;
1035 for (vector<Element>::const_iterator it =
elements.begin();
1038 vector<string> vs = it->statistics.getExtrapolationWarningLines();
1039 for (vector<string>::const_iterator it2 = vs.begin();
1040 it2 != vs.end(); ++it2)
1051 for (vector<Element>::iterator it =
elements.begin();
1054 it->statistics.clear();
1064 structure.writeToFile(fileName,
false, append);
Contains element-specific data.
double getAtomicEnergyOffset() const
Get atomicEnergyOffset.
Structure structure
Structure containing local atoms.
long getEWBufferSize() const
Calculate buffer size for extrapolation warning communication.
bool initialized
Initialization state.
void process()
Calculate symmetry functions, atomic neural networks and sum of local energy contributions.
void extractEWBuffer(char const *const &buf, int bs)
Extract given buffer to symmetry function statistics class.
void addCharge(int index, double Q)
Read atomic charges from LAMMPS into n2p2.
std::map< int, bool > ignoreType
True if atoms of this LAMMPS type will be ignored.
void setLocalTags(int const *const atomTag)
Set atom tags (int version, -DLAMMPS_SMALLBIG).
void allocateNeighborlists(int const *const numneigh)
Allocate neighbor lists.
void setElecDone()
Set isElecDone true after running the first NN in 4G-HDNNPs.
std::map< int, std::size_t > mapTypeToElement
Map from LAMMPS type to n2p2 element index.
void addElectrostaticEnergy(double energy)
Adds electrostatic energy contribution to the total structure energy.
void add3DVecToArray(double *const &arr, Vec3D const &v) const
Add a Vec3D vector to a 3D array in place.
void processDevelop()
Calculate symmetry functions, atomic neural networks and sum of local energy contributions (developme...
void getQEqParams(double *const &atomChi, double *const &atomJ, double *const &sigmaSqrtPi, double *const *const &gammaSqrt2, double &qRef) const
Write QEq arrays from n2p2 to LAMMPS.
double getMaxCutoffRadiusOverall()
Get largest cutoff including structure specific cutoff and screening cutoff.
bool hasGlobalStructure
Whether n2p2 knows about the global structure or only a local part.
bool isElecDone
True if first NN is calculated.
void setLocalAtomPositions(double const *const *const atomPos)
Set absolute atom positions from LAMMPS (nnp/develop only).
double getEnergy() const
Return sum of local energy contributions.
void fillEWBuffer(char *const &buf, int bs) const
Fill provided buffer with extrapolation warning entries.
double getAtomicEnergy(int index) const
Return energy contribution of one atom.
void getForces(double *const *const &atomF) const
Calculate forces and add to LAMMPS atomic force arrays.
bool resetew
Corresponds to LAMMPS resetew keyword.
void writeExtrapolationWarnings()
Write extrapolation warnings to log.
void setBoxVectors(double const *boxlo, double const *boxhi, double const xy, double const xz, double const yz)
Set box vectors of structure stored in LAMMPS (nnp/develop only).
std::vector< size_t > indexMap
Map from LAMMPS index to n2p2 atom index.
bool getGlobalStructureStatus()
Check if n2p2 knows about global structure.
double cfenergy
Corresponds to LAMMPS cfenergy keyword.
void getScreeningInfo(double *const &rScreen) const
Read screening function information from n2p2 into LAMMPS.
void setLocalAtoms(int numAtomsLocal, int const *const atomType)
(Re)set structure to contain only local LAMMPS atoms.
bool showew
Corresponds to LAMMPS showew keyword.
void writeToFile(std::string const fileName, bool const append)
Write current structure to file in units used in training data.
void getCharges(double *const &atomQ) const
Transfer charges (in units of e) to LAMMPS atomic charge vector.
int showewsum
Corresponds to LAMMPS showewsum keyword.
void setGlobalStructureStatus(bool const status)
Specify whether n2p2 knows about global structure or only local structure.
void finalizeNeighborList()
Sorts neighbor list and creates cutoff map if necessary.
double getEwaldPrec() const
Get Ewald precision parameter.
void getForcesDevelop(double *const *const &atomF) const
Calculate forces and add to LAMMPS atomic force arrays (development version for "hdnnp/develop" pair ...
void clearExtrapolationWarnings()
Clear extrapolation warnings storage.
void getForcesChi(double const *const &lambda, double *const *const &atomF) const
Calculate chi-term for forces and add to LAMMPS atomic force arrays.
std::map< std::size_t, int > mapElementToType
Map from n2p2 element index to LAMMPS type.
void getdEdQ(double *const &dEtotdQ) const
Write the derivative of total energy with respect to atomic charges from n2p2 into LAMMPS.
double getMaxCutoffRadius() const
Get largest cutoff of symmetry functions.
void getdChidxyz(int tag, double *const &dChidx, double *const &dChidy, double *const &dChidz) const
Transfer spatial derivatives of atomic electronegativities.
int maxew
Corresponds to LAMMPS maxew keyword.
void addNeighbor(int i, int j, int64_t tag, int type, double dx, double dy, double dz, double d2)
Add one neighbor to atom (int64_t version, -DLAMMPS_BIGBIG).
double cflength
Corresponds to LAMMPS cflength keyword.
std::string emap
Corresponds to LAMMPS map keyword.
double physicalEnergy(Structure const &structure, bool ref=true) const
Undo normalization for a given energy of structure.
std::vector< std::vector< double > > cutoffs
Matrix storing all symmetry function cut-offs for all elements.
ElementMap elementMap
Global element map, populated by setupElementMap().
void addEnergyOffset(Structure &structure, bool ref=true)
Add atomic energy offsets to reference energy.
void initialize()
Write welcome message with version information.
double getEwaldPrecision() const
Getter for Mode::ewaldSetup.precision.
void setupGeneric(std::string const &nnpDir="", bool skipNormalize=false, bool initialHardness=false)
Combine multiple setup routines and provide a basic NNP setup.
@ HDNNP_2G
Short range NNP (2G-HDNNP).
@ HDNNP_Q
Short range NNP with charge NN, no electrostatics/Qeq (M.
@ HDNNP_4G
NNP with electrostatics and non-local charge transfer (4G-HDNNP).
virtual void setupNeuralNetworkWeights(std::map< std::string, std::string > fileNameFormats=std::map< std::string, std::string >())
Set up neural network weights from files with given name format.
ScreeningFunction screeningFunction
void calculateAtomicNeuralNetworks(Structure &structure, bool const derivatives, std::string id="")
Calculate a single atomic neural network for a given atom and nn type.
double physical(std::string const &property, double value) const
Undo normalization for a given property.
std::vector< Element > elements
void calculateEnergy(Structure &structure) const
Calculate potential energy for a given structure.
void calculateSymmetryFunctionGroups(Structure &structure, bool const derivatives)
Calculate all symmetry function groups for all atoms in given structure.
virtual void setupSymmetryFunctionScaling(std::string const &fileName="scaling.data")
Set up symmetry function scaling from file.
void calculateCharge(Structure &structure) const
Calculate total charge for a given structure.
void chargeEquilibration(Structure &structure, bool const derivativesElec)
Perform global charge equilibration method.
void calculateSymmetryFunctions(Structure &structure, bool const derivatives)
Calculate all symmetry functions for all atoms in given structure.
void setupSymmetryFunctionStatistics(bool collectStatistics, bool collectExtrapolationWarnings, bool writeExtrapolationWarnings, bool stopOnExtrapolationWarnings)
Set up symmetry function statistics collection.
void loadSettingsFile(std::string const &fileName="input.nn")
Open settings file and load all keywords into memory.
string strpr(const char *format,...)
String version of printf function.
string trim(string const &line, string const &whitespace)
Remove leading and trailing whitespaces from string.
vector< string > split(string const &input, char delimiter)
Split string at each delimiter.
string reduce(string const &line, string const &whitespace, string const &fill)
Replace multiple whitespaces with fill.
Struct to store information on neighbor atoms.
std::size_t index
Index of neighbor atom.
std::size_t element
Element index of neighbor atom.
double d
Distance to neighbor atom.
Vec3D dr
Distance vector to neighbor atom.
int64_t tag
Tag of neighbor atom.
Storage for a single atom.
std::vector< Neighbor > neighbors
Neighbor array (maximum number defined in macros.h.
std::size_t numSymmetryFunctions
Number of symmetry functions used to describe the atom environment.
Vec3D r
Cartesian coordinates.
std::vector< double > dEdG
Derivative of atomic energy with respect to symmetry functions.
Vec3D calculatePairForceShort(Neighbor const &neighbor, std::vector< std::vector< std::size_t > > const *const tableFull=nullptr) const
Calculate force resulting from gradient of this atom's (short-ranged) energy contribution with respec...
bool hasSymmetryFunctionDerivatives
If symmetry function derivatives are saved for this atom.
double charge
Atomic charge determined by neural network.
std::size_t index
Index number of this atom.
Vec3D calculateSelfForceShort() const
Calculate force resulting from gradient of this atom's (short-ranged) energy contribution with respec...
std::size_t getStoredMinNumNeighbors(double const cutoffRadius) const
Return needed number of neighbors for a given cutoff radius from neighborCutoffs map.
std::vector< Vec3D > dGdr
Derivative of symmetry functions with respect to this atom's coordinates.
double chi
Atomic electronegativity determined by neural network.
std::size_t indexStructure
Index number of structure this atom belongs to.
int64_t tag
Tag number of this atom.
std::size_t element
Element index of this atom.
bool hasSymmetryFunctions
If symmetry function values are saved for this atom.
double energy
Atomic energy determined by neural network.
std::vector< std::size_t > numNeighborsPerElement
Number of neighbors per element.
std::vector< double > dChidG
Derivative of electronegativity with respect to symmetry functions.
std::size_t numNeighbors
Total number of neighbors.
Storage for one atomic configuration.
Eigen::VectorXd const calculateForceLambdaTotal() const
Calculate lambda_total vector which is needed for the total force calculation in 4G NN.
std::size_t numAtoms
Total number of atoms present in this structure.
std::vector< Atom > atoms
Vector of all atoms in this structure.
Struct containing statistics gathered during symmetry function calculation.
Vector in 3 dimensional real space.