59 for (
size_t i = 0; i < 3; i++)
86 atoms.back().clearNeighborList();
90 atoms.back().numSymmetryFunctions = 0;
101 file.open(fileName.c_str());
104 throw runtime_error(
"ERROR: Could not open file: \"" + fileName
116 vector<string> lines;
117 vector<string> splitLine;
121 lines.push_back(line);
123 if (splitLine.at(0) !=
"begin")
125 throw runtime_error(
"ERROR: Unexpected file content, expected"
126 " \"begin\" keyword.\n");
129 while (getline(file, line))
131 lines.push_back(line);
133 if (splitLine.at(0) ==
"end")
break;
144 size_t iBoxVector = 0;
145 vector<string> splitLine;
149 if (splitLine.at(0) !=
"begin")
151 throw runtime_error(
"ERROR: Unexpected line content, expected"
152 " \"begin\" keyword.\n");
155 for (vector<string>::const_iterator line = lines.begin();
156 line != lines.end(); ++line)
159 if (splitLine.at(0) ==
"begin")
161 if (splitLine.size() > 1)
163 for (vector<string>::const_iterator word =
164 splitLine.begin() + 1; word != splitLine.end(); ++word)
170 throw runtime_error(
"ERROR: Unknown keyword in "
171 "structure specification, check "
172 "\"begin\" arguments.\n");
177 else if (splitLine.at(0) ==
"comment")
179 size_t position = line->find(
"comment");
180 string tmpLine = *line;
181 comment = tmpLine.erase(position, splitLine.at(0).length() + 1);
183 else if (splitLine.at(0) ==
"lattice")
187 throw runtime_error(
"ERROR: Too many box vectors.\n");
189 box[iBoxVector][0] = atof(splitLine.at(1).c_str());
190 box[iBoxVector][1] = atof(splitLine.at(2).c_str());
191 box[iBoxVector][2] = atof(splitLine.at(3).c_str());
196 if (
box[0][1] > numeric_limits<double>::min() ||
197 box[0][2] > numeric_limits<double>::min() ||
198 box[1][0] > numeric_limits<double>::min() ||
199 box[1][2] > numeric_limits<double>::min() ||
200 box[2][0] > numeric_limits<double>::min() ||
201 box[2][1] > numeric_limits<double>::min())
209 else if (splitLine.at(0) ==
"atom")
215 atoms.back().r[0] = atof(splitLine.at(1).c_str());
216 atoms.back().r[1] = atof(splitLine.at(2).c_str());
217 atoms.back().r[2] = atof(splitLine.at(3).c_str());
219 atoms.back().chargeRef = atof(splitLine.at(5).c_str());
220 atoms.back().fRef[0] = atof(splitLine.at(7).c_str());
221 atoms.back().fRef[1] = atof(splitLine.at(8).c_str());
222 atoms.back().fRef[2] = atof(splitLine.at(9).c_str());
227 else if (splitLine.at(0) ==
"energy")
231 else if (splitLine.at(0) ==
"charge")
235 else if (splitLine.at(0) ==
"end")
237 if (!(iBoxVector == 0 || iBoxVector == 3))
239 throw runtime_error(
"ERROR: Strange number of box vectors.\n");
242 abs(
chargeRef) > 10*std::numeric_limits<double>::epsilon())
244 throw runtime_error(
"ERROR: In structure with index "
246 +
"; if PBCs are applied, the\n"
247 "simulation cell has to be neutrally "
254 throw runtime_error(
"ERROR: Unexpected file content, "
255 "unknown keyword \"" + splitLine.at(0) +
276 double maxCutoffRadius)
298 cutoffRadius *= cutoffRadius;
301 #pragma omp parallel for
303 for (
size_t i = 0; i <
numAtoms; i++)
306 atoms[i].neighborsUnique.push_back(i);
307 atoms[i].numNeighborsUnique++;
308 for (
size_t j = 0; j <
numAtoms; j++)
310 for (
int bc0 = -
pbc[0]; bc0 <=
pbc[0]; bc0++)
312 for (
int bc1 = -
pbc[1]; bc1 <=
pbc[1]; bc1++)
314 for (
int bc2 = -
pbc[2]; bc2 <=
pbc[2]; bc2++)
316 if (!(i == j && bc0 == 0 && bc1 == 0 && bc2 == 0))
322 if (dr.
norm2() <= cutoffRadius)
331 back().element =
atoms[j].element;
333 back().d = dr.
norm();
336 atoms[i].numNeighborsPerElement[
338 atoms[i].numNeighbors++;
341 if (
atoms[i].neighborsUnique.back() != j &&
344 atoms[i].neighborsUnique.push_back(j);
345 atoms[i].numNeighborsUnique++;
353 atoms[i].hasNeighborList =
true;
359 cutoffRadius *= cutoffRadius;
362 #pragma omp parallel for
364 for (
size_t i = 0; i <
numAtoms; i++)
367 atoms[i].neighborsUnique.push_back(i);
368 atoms[i].numNeighborsUnique++;
369 for (
size_t j = 0; j <
numAtoms; j++)
374 if (dr.
norm2() <= cutoffRadius)
377 atoms[i].neighbors.back().index = j;
378 atoms[i].neighbors.back().tag = j;
379 atoms[i].neighbors.back().element =
atoms[j].element;
381 atoms[i].neighbors.back().dr = dr;
382 atoms[i].numNeighborsPerElement[
atoms[j].element]++;
383 atoms[i].numNeighbors++;
384 atoms[i].neighborsUnique.push_back(j);
385 atoms[i].numNeighborsUnique++;
389 atoms[i].hasNeighborList =
true;
402 std::vector<double>>& cutoffs)
411 #pragma omp parallel for
413 for (
size_t i = 0; i <
numAtoms; ++i)
415 sort(
atoms[i].neighbors.begin(),
atoms[i].neighbors.end());
417 atoms[i].NeighborListIsSorted =
true;
423 vector<double>> cutoffs)
426 throw runtime_error(
"NeighborCutoffs map needs a sorted neighbor list");
428 for (
auto& elementCutoffs : cutoffs )
436 if ( !is_sorted(elementCutoffs.begin(), elementCutoffs.end()) )
438 sort(elementCutoffs.begin(), elementCutoffs.end());
443 for(
auto& a :
atoms )
445 size_t const eIndex = a.element;
446 vector<double>
const& elementCutoffs = cutoffs.at(eIndex);
450 while( in < a.numNeighbors && ic < elementCutoffs.size() )
457 if( n.
d > elementCutoffs[ic] )
459 a.neighborCutoffs.emplace( elementCutoffs.at(ic), in );
462 else if ( in == a.numNeighbors - 1 )
464 a.neighborCutoffs.emplace( elementCutoffs.at(ic), a.numNeighbors );
474 size_t maxNumNeighbors = 0;
476 for(vector<Atom>::const_iterator it =
atoms.begin();
477 it !=
atoms.end(); ++it)
479 maxNumNeighbors = max(maxNumNeighbors, it->numNeighbors);
482 return maxNumNeighbors;
491 axb =
box[0].cross(
box[1]).normalize();
492 axc =
box[0].cross(
box[2]).normalize();
493 bxc =
box[1].cross(
box[2]).normalize();
495 double proja = fabs(
box[0] * bxc);
496 double projb = fabs(
box[1] * axc);
497 double projc = fabs(
box[2] * axb);
502 while (
pbc[0] * proja <= cutoffRadius)
506 while (
pbc[1] * projb <= cutoffRadius)
510 while (
pbc[2] * projc <= cutoffRadius)
520 double invdet =
box[0][0] *
box[1][1] *
box[2][2]
526 invdet = 1.0 / invdet;
553 axb =
box[0].cross(
box[1]).normalize();
554 axc =
box[0].cross(
box[2]).normalize();
555 bxc =
box[1].cross(
box[2]).normalize();
558 proj[0] = fabs(
box[0] * bxc);
559 proj[1] = fabs(
box[1] * axc);
560 proj[2] = fabs(
box[2] * axb);
562 double minProj = *min_element(proj, proj+3);
563 return (cutoffRadius < minProj / 2.0);
571 for (
size_t i=0; i<3; ++i)
573 dsNINT[i] = round(ds[i]);
591 VectorXd sigmaSqrtPi,
593 double const fourPiEps,
615 throw runtime_error(
"ERROR: Neighbor list needs to "
616 "be sorted for Ewald summation!\n");
626 double const rcutReal = ewaldSetup.
params.
rCut;
628 double const sqrt2eta = sqrt(2.0) * ewaldSetup.
params.
eta;
631 #pragma omp for schedule(dynamic)
633 for (
size_t i = 0; i <
numAtoms; ++i)
639 A(i, i) += hardness(ei)
640 + (1.0 / sigmaSqrtPi(ei) - 2 / (sqrt2eta * sqrt(M_PI)))
643 hardnessJ(i) = hardness(ei);
648 for (
size_t k = 0; k < numNeighbors; ++k)
654 double const rij = n.d;
655 size_t const ej = n.element;
657 double erfcSqrt2Eta = erfcBuf.
getf(i, k, 0, rij / sqrt2eta);
658 double erfcGammaSqrt2 =
659 erfcBuf.
getf(i, k, 1, rij / gammaSqrt2(ei, ej));
661 A(i, j) += (erfcSqrt2Eta - erfcGammaSqrt2) / (rij * fourPiEps);
664 for (
size_t j = i; j <
numAtoms; ++j)
672 A(i, j) += 2 * gv.coeff * cos(gv.k * dr) / fourPiEps;
682#pragma omp for schedule(dynamic)
684 for (
size_t i = 0; i <
numAtoms; ++i)
689 A(i, i) = hardness(ei) + 1.0 / (sigmaSqrtPi(ei) * fourPiEps);
690 hardnessJ(i) = hardness(ei);
692 for (
size_t j = i + 1; j <
numAtoms; ++j)
696 double const rij = (ai.
r - aj.
r).norm();
698 A(i, j) = erf(rij / gammaSqrt2(ei, ej)) / (rij * fourPiEps);
718 Q =
A.colPivHouseholderQr().solve(b);
720 #pragma omp for nowait
722 for (
size_t i = 0; i <
numAtoms; ++i)
724 atoms.at(i).charge = Q(i);
732 double error = (
A * Q - b).norm() / b.norm();
737 MatrixXd(hardnessJ.asDiagonal())) * Q.head(
numAtoms);
745 VectorXd sigmaSqrtPi,
747 double const fourPiEps)
750 double energyScreen = 0;
751 double const rcutScreen = fs.
getOuter();
756 double localEnergyScreen = 0;
761 #pragma omp for schedule(dynamic)
763 for (
size_t i = 0; i <
numAtoms; ++i)
767 double const Qi = ai.
charge;
769 localEnergyScreen += -Qi * Qi
770 / (2 * sigmaSqrtPi(ei) * fourPiEps);
772 energyScreen += -Qi * Qi
773 / (2 * sigmaSqrtPi(ei) * fourPiEps);
777 for (
size_t k = 0; k < numNeighbors; ++k)
780 size_t const j = n.tag;
782 double const rij = n.d;
783 size_t const ej = n.element;
785 double const Qj =
atoms.at(j).charge;
787 localEnergyScreen += Qi * Qj * erf(rij / gammaSqrt2(ei, ej))
788 * (fs.
f(rij) - 1) / (rij * fourPiEps);
790 energyScreen += Qi * Qj * erf(rij / gammaSqrt2(ei, ej))
791 * (fs.
f(rij) - 1) / (rij * fourPiEps);
800 #pragma omp for schedule(dynamic)
802 for (
size_t i = 0; i <
numAtoms; ++i)
806 double const Qi = ai.
charge;
808 localEnergyScreen += -Qi * Qi
809 / (2 * sigmaSqrtPi(ei) * fourPiEps);
811 energyScreen += -Qi * Qi
812 / (2 * sigmaSqrtPi(ei) * fourPiEps);
815 for (
size_t j = i + 1; j <
numAtoms; ++j)
818 double const Qj = aj.
charge;
819 double const rij = (ai.
r - aj.
r).norm();
820 if ( rij < rcutScreen )
823 localEnergyScreen += Qi * Qj *
A(i, j) * (fs.
f(rij) - 1);
825 energyScreen += Qi * Qj *
A(i, j) * (fs.
f(rij) - 1);
833 energyScreen += localEnergyScreen;
843 double const fourPiEps,
852 #pragma omp declare reduction(vec_Vec3D_plus : std::vector<Vec3D> : \
853 std::transform(omp_out.begin(), omp_out.end(), omp_in.begin(), omp_out.begin(), std::plus<Vec3D>())) \
854 initializer(omp_priv = decltype(omp_orig)(omp_orig.size()))
859 for (
size_t i = 0; i <
numAtoms; ++i)
876 double const sqrt2eta = sqrt(2.0) * ewaldSetup.
params.
eta;
881 #pragma omp for reduction(vec_Vec3D_plus : dAdrQDiag) schedule(dynamic)
883 for (
size_t i = 0; i <
numAtoms; ++i)
887 double const Qi = ai.
charge;
891 for (
size_t k = 0; k < numNeighbors; ++k)
896 if (j <= i)
continue;
898 double const rij = n.d;
901 double const Qj = aj.
charge;
903 double erfcSqrt2Eta = erfcBuf.
getf(i, k, 0, rij / sqrt2eta);
904 double erfcGammaSqrt2 =
905 erfcBuf.
getf(i, k, 1, rij / gammaSqrt2(ei, ej));
908 dAijdri = n.dr / pow(rij, 2)
909 * (2 / sqrt(M_PI) * (-exp(-pow(rij / sqrt2eta, 2))
910 / sqrt2eta + exp(-pow(rij / gammaSqrt2(ei, ej), 2))
911 / gammaSqrt2(ei, ej)) - 1 / rij
912 * (erfcSqrt2Eta - erfcGammaSqrt2));
913 dAijdri /= fourPiEps;
916 ai.
dAdrQ[i] += dAijdri * Qj;
917 ai.
dAdrQ[j] += dAijdri * Qi;
918 aj.
dAdrQ[i] -= dAijdri * Qj;
920 dAdrQDiag[j] -= dAijdri * Qi;
922 aj.
dAdrQ[j] -= dAijdri * Qi;
927 for (
size_t j = i + 1; j <
numAtoms; ++j)
930 double const Qj = aj.
charge;
937 dAijdri -= 2 * gv.coeff * sin(gv.k * dr) * gv.k;
939 dAijdri /= fourPiEps;
941 ai.
dAdrQ[i] += dAijdri * Qj;
942 ai.
dAdrQ[j] += dAijdri * Qi;
943 aj.
dAdrQ[i] -= dAijdri * Qj;
945 dAdrQDiag[j] -= dAijdri * Qi;
947 aj.
dAdrQ[j] -= dAijdri * Qi;
955 #pragma omp for reduction(vec_Vec3D_plus : dAdrQDiag) schedule(dynamic)
957 for (
size_t i = 0; i <
numAtoms; ++i)
961 double const Qi = ai.
charge;
963 for (
size_t j = i + 1; j <
numAtoms; ++j)
967 double const Qj = aj.
charge;
969 double rij = (ai.
r - aj.
r).norm();
971 dAijdri = (ai.
r - aj.
r) / pow(rij, 2)
972 * (2 / (sqrt(M_PI) * gammaSqrt2(ei, ej))
973 * exp(-pow(rij / gammaSqrt2(ei, ej), 2))
974 - erf(rij / gammaSqrt2(ei, ej)) / rij);
975 dAijdri /= fourPiEps;
978 ai.
dAdrQ[i] += dAijdri * Qj;
979 ai.
dAdrQ[j] = dAijdri * Qi;
980 aj.
dAdrQ[i] = -dAijdri * Qj;
982 dAdrQDiag[j] -= dAijdri * Qi;
984 aj.
dAdrQ[j] -= dAijdri * Qi;
991 for (
size_t i = 0; i <
numAtoms; ++i)
994 ai.
dAdrQ[i] += dAdrQDiag[i];
1005 for (
size_t i = 0; i <
numAtoms; ++i)
1011 dQdChi.push_back(
A.colPivHouseholderQr().solve(b).head(
numAtoms));
1025 for (
size_t j = 0; j <
numAtoms; ++j)
1030 dQdJ.push_back(
A.colPivHouseholderQr().solve(b).head(
numAtoms));
1036 vector<size_t>
const& compIndices,
1037 double const maxCutoffRadius,
1038 vector<Element>
const& elements)
1040 if (atomIndices.size() != compIndices.size())
1041 throw runtime_error(
"ERROR: In calculation of dQ/dr both atom index and"
1042 " component index must be specified.");
1043 for (
size_t i = 0; i < atomIndices.size(); ++i)
1046 if ( a.
dAdrQ.size() == 0 )
1047 throw runtime_error(
"ERROR: dAdrQ needs to be calculated before "
1048 "calculating dQdr");
1054 for (
size_t j = 0; j <
numAtoms; ++j)
1058#ifndef N2P2_FULL_SFD_MEMORY
1059 vector<vector<size_t> >
const *
const tableFull
1060 = &(elements.at(aj.
element).getSymmetryFunctionTable());
1062 vector<vector<size_t> >
const *
const tableFull =
nullptr;
1066 tableFull)[compIndices[i]];
1067 b(j) -= a.
dAdrQ.at(j)[compIndices[i]];
1069 VectorXd dQdr =
A.colPivHouseholderQr().solve(b).head(
numAtoms);
1070 for (
size_t j = 0; j <
numAtoms; ++j)
1072 a.
dQdr.at(j)[compIndices[i]] = dQdr(j);
1080 Eigen::VectorXd hardness,
1081 Eigen::MatrixXd gammaSqrt2,
1082 VectorXd sigmaSqrtPi,
1084 double const fourPiEps)
1089 ai.pEelecpr =
Vec3D{};
1094 for (
size_t i = 0; i <
numAtoms; ++i)
1098 double const Qi = ai.
charge;
1102 for (
size_t j = 0; j <
numAtoms; ++j)
1105 double const Qj = aj.
charge;
1112 ai.
dEelecdQ += Qi * (
A(i,i) - hardness(ei)
1113 - 1 / (sigmaSqrtPi(ei) * fourPiEps));
1123 if (j < i)
continue;
1124 double const rij = ajN.d;
1126 if (rij >= rcutScreen)
break;
1129 double const Qj =
atoms.at(j).charge;
1131 double erfRij = erf(rij / gammaSqrt2(ei,ej));
1132 double fsRij = fs.
f(rij);
1135 Vec3D Tij = Qi * Qj * ajN.dr / pow(rij,2)
1136 * (2 / (sqrt(M_PI) * gammaSqrt2(ei,ej))
1137 * exp(- pow(rij / gammaSqrt2(ei,ej),2))
1138 * (fsRij - 1) + erfRij * fs.
df(rij) - erfRij
1139 * (fsRij - 1) / rij);
1144 double Sij = erfRij * (fsRij - 1) / rij;
1152 for (
size_t j = i + 1; j <
numAtoms; ++j)
1155 double const rij = (ai.
r - aj.
r).norm();
1156 if (rij >= rcutScreen)
continue;
1159 double const Qj =
atoms.at(j).charge;
1161 double erfRij = erf(rij / gammaSqrt2(ei,ej));
1162 double fsRij = fs.
f(rij);
1165 Vec3D Tij = Qi * Qj * (ai.
r - aj.
r) / pow(rij,2)
1166 * (2 / (sqrt(M_PI) * gammaSqrt2(ei,ej))
1167 * exp(- pow(rij / gammaSqrt2(ei,ej),2))
1168 * (fsRij - 1) + erfRij * fs.
df(rij) - erfRij
1169 * (fsRij - 1) / rij);
1174 double Sij = erfRij * (fsRij - 1) / rij;
1187 for (
size_t i = 0; i <
numAtoms; ++i)
1193 VectorXd
const lambdaTotal =
A.colPivHouseholderQr().solve(-dEdQ);
1200 for (
size_t i = 0; i <
numAtoms; ++i)
1206 VectorXd
const lambdaElec =
A.colPivHouseholderQr().solve(-dEelecdQ);
1212 for (vector<Atom>::iterator it =
atoms.begin(); it !=
atoms.end(); ++it)
1226 if (f[0] > 1.0) f[0] -= (int)f[0];
1227 if (f[1] > 1.0) f[1] -= (int)f[1];
1228 if (f[2] > 1.0) f[2] -= (int)f[2];
1230 if (f[0] < 0.0) f[0] += 1.0 - (int)f[0];
1231 if (f[1] < 0.0) f[1] += 1.0 - (int)f[1];
1232 if (f[2] < 0.0) f[2] += 1.0 - (int)f[2];
1234 if (f[0] == 1.0) f[0] = 0.0;
1235 if (f[1] == 1.0) f[1] = 0.0;
1236 if (f[2] == 1.0) f[2] = 0.0;
1238 atom.
r = f[0] *
box[0]
1252 box[0] *= convLength;
1253 box[1] *= convLength;
1254 box[2] *= convLength;
1264 volume *= convLength * convLength * convLength;
1266 for (vector<Atom>::iterator it =
atoms.begin(); it !=
atoms.end(); ++it)
1268 it->toNormalizedUnits(convEnergy, convLength, convCharge);
1281 box[0] /= convLength;
1282 box[1] /= convLength;
1283 box[2] /= convLength;
1293 volume /= convLength * convLength * convLength;
1295 for (vector<Atom>::iterator it =
atoms.begin(); it !=
atoms.end(); ++it)
1297 it->toPhysicalUnits(convEnergy, convLength, convCharge);
1305 for (vector<Atom>::iterator it =
atoms.begin(); it !=
atoms.end(); ++it)
1307 it->free(all, maxCutoffRadius);
1333 for (
size_t i = 0; i < 3; ++i)
1336 for (
size_t j = 0; j < 3; ++j)
1354 for (
size_t i = 0; i <
numAtoms; i++)
1372 for (
auto& a :
atoms)
1374 vector<Vec3D>().swap(a.dAdrQ);
1377 vector<Vec3D>().swap(a.dQdr);
1383 map<string, double>& error,
1384 size_t& count)
const
1386 if (property ==
"energy")
1391 error.at(
"RMSE") += diff * diff;
1393 error.at(
"MAEpa") += diff /
numAtoms;
1394 error.at(
"MAE") += diff;
1396 else if (property ==
"force" || property ==
"charge")
1398 for (vector<Atom>::const_iterator it =
atoms.begin();
1399 it !=
atoms.end(); ++it)
1401 it->updateError(property, error, count);
1406 throw runtime_error(
"ERROR: Unknown property for error update.\n");
1414 return strpr(
"%10zu %16.8E %16.8E\n",
1423 for (vector<Atom>::const_iterator it =
atoms.begin();
1424 it !=
atoms.end(); ++it)
1426 vector<string> va = it->getForcesLines();
1427 v.insert(v.end(), va.begin(), va.end());
1436 for (vector<Atom>::const_iterator it =
atoms.begin();
1437 it !=
atoms.end(); ++it)
1439 v.push_back(it->getChargeLine());
1447 bool const append)
const
1453 file.open(fileName.c_str(), ofstream::app);
1457 file.open(fileName.c_str());
1459 if (!file.is_open())
1461 throw runtime_error(
"ERROR: Could not open file: \"" + fileName
1472 if (!file->is_open())
1474 runtime_error(
"ERROR: Cannot write to file, file is not open.\n");
1477 (*file) <<
"begin\n";
1481 for (
size_t i = 0; i < 3; ++i)
1483 (*file) <<
strpr(
"lattice %24.16E %24.16E %24.16E\n",
1487 for (vector<Atom>::const_iterator it =
atoms.begin();
1488 it !=
atoms.end(); ++it)
1492 (*file) <<
strpr(
"atom %24.16E %24.16E %24.16E %2s %24.16E %24.16E"
1493 " %24.16E %24.16E %24.16E\n",
1506 (*file) <<
strpr(
"atom %24.16E %24.16E %24.16E %2s %24.16E %24.16E"
1507 " %24.16E %24.16E %24.16E\n",
1521 else (*file) <<
strpr(
"energy %24.16E\n",
energy);
1523 else (*file) <<
strpr(
"charge %24.16E\n",
charge);
1524 (*file) <<
strpr(
"end\n");
1531 if (!file->is_open())
1533 runtime_error(
"ERROR: Could not write to file.\n");
1539 (*file) <<
"Lattice=\"";
1540 (*file) <<
strpr(
"%24.16E %24.16E %24.16E " ,
1542 (*file) <<
strpr(
"%24.16E %24.16E %24.16E " ,
1544 (*file) <<
strpr(
"%24.16E %24.16E %24.16E\"\n",
1551 for (vector<Atom>::const_iterator it =
atoms.begin();
1552 it !=
atoms.end(); ++it)
1554 (*file) <<
strpr(
"%-2s %24.16E %24.16E %24.16E\n",
1572 string const elements)
const
1574 if (!file->is_open())
1576 runtime_error(
"ERROR: Could not write to file.\n");
1579 vector<string> ve =
split(elements);
1580 vector<size_t> elementOrder;
1581 for (
size_t i = 0; i < ve.size(); ++i)
1583 elementOrder.push_back(
elementMap[ve.at(i)]);
1585 if (elementOrder.size() !=
elementMap.size())
1587 runtime_error(
"ERROR: Inconsistent element declaration.\n");
1592 for (
size_t i = 1; i < elementOrder.size(); ++i)
1600 (*file) <<
strpr(
"%24.16E %24.16E %24.16E\n",
1602 (*file) <<
strpr(
"%24.16E %24.16E %24.16E\n",
1604 (*file) <<
strpr(
"%24.16E %24.16E %24.16E\n",
1609 runtime_error(
"ERROR: Writing non-periodic structure to POSCAR file "
1610 "is not implemented.\n");
1618 (*file) <<
"Cartesian\n";
1619 for (
size_t i = 0; i < elementOrder.size(); ++i)
1621 for (vector<Atom>::const_iterator it =
atoms.begin();
1622 it !=
atoms.end(); ++it)
1624 if (it->element == elementOrder.at(i))
1626 (*file) <<
strpr(
"%24.16E %24.16E %24.16E\n",
1641 v.push_back(
strpr(
"********************************\n"));
1642 v.push_back(
strpr(
"STRUCTURE \n"));
1643 v.push_back(
strpr(
"********************************\n"));
1645 v.insert(v.end(), vm.begin(), vm.end());
1662 v.push_back(
strpr(
"comment : %s\n",
comment.c_str() ));
1663 v.push_back(
strpr(
"box[0] : %16.8E %16.8E %16.8E\n",
box[0][0],
box[0][1],
box[0][2]));
1664 v.push_back(
strpr(
"box[1] : %16.8E %16.8E %16.8E\n",
box[1][0],
box[1][1],
box[1][2]));
1665 v.push_back(
strpr(
"box[2] : %16.8E %16.8E %16.8E\n",
box[2][0],
box[2][1],
box[2][2]));
1669 v.push_back(
strpr(
"--------------------------------\n"));
1671 v.push_back(
strpr(
"--------------------------------\n"));
1676 v.push_back(
strpr(
"--------------------------------\n"));
1677 v.push_back(
strpr(
"--------------------------------\n"));
1678 v.push_back(
strpr(
"atoms [*] : %d\n",
atoms.size()));
1679 v.push_back(
strpr(
"--------------------------------\n"));
1680 for (
size_t i = 0; i <
atoms.size(); ++i)
1682 v.push_back(
strpr(
"%29d :\n", i));
1683 vector<string> va =
atoms[i].info();
1684 v.insert(v.end(), va.begin(), va.end());
1686 v.push_back(
strpr(
"--------------------------------\n"));
1687 v.push_back(
strpr(
"********************************\n"));
Setup data for Ewald summation.
void calculateParameters(double const newVolume, size_t const newNumAtoms)
Compute eta, rCut and kCut.
std::vector< Kvector > kvectors
Vector containing all k-vectors.
void setup(Vec3D box[3], EwaldSetup &ewaldSetup)
Set up reciprocal box vectors and eta.
A screening functions for use with electrostatics.
double getOuter() const
Getter for outer.
double df(double r) const
Derivative of screening function .
double f(double r) const
Screening function .
string strpr(const char *format,...)
String version of printf function.
bool vectorContains(std::vector< T > const &stdVec, T value)
Test if vector contains specified value.
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.
double d
Distance to neighbor atom.
Storage for a single atom.
std::vector< Neighbor > neighbors
Neighbor array (maximum number defined in macros.h.
Vec3D r
Cartesian coordinates.
std::vector< double > dEdG
Derivative of atomic energy with respect to symmetry functions.
Vec3D calculateDChidr(size_t const atomIndexOfR, double const maxCutoffRadius, std::vector< std::vector< size_t > > const *const tableFull=nullptr) const
Calculate dChi/dr of this atom's Chi with respect to the coordinates of the given atom.
double charge
Atomic charge determined by neural network.
std::size_t getStoredMinNumNeighbors(double const cutoffRadius) const
Return needed number of neighbors for a given cutoff radius from neighborCutoffs map.
double chi
Atomic electronegativity determined by neural network.
void clearNeighborList()
Clear neighbor list.
Vec3D pEelecpr
Partial derivative of electrostatic energy with respect to this atom's coordinates.
std::vector< Vec3D > dAdrQ
If dQdr has been calculated for respective components.
std::size_t element
Element index of this atom.
std::vector< Vec3D > dQdr
Derivative of charges with respect to this atom's coordinates.
double dEelecdQ
Derivative of electrostatic energy with respect to this atom's charge.
std::vector< std::size_t > numNeighborsPerElement
Number of neighbors per element.
Helper class to store previously calculated values of erfc() that are needed during the charge equili...
double getf(size_t const atomIndex, size_t const neighIndex, size_t const valIndex, double const x)
Either returns already stored value erfc(x) or calculates it if not yet stored.
void reset(std::vector< Atom > const &atoms, size_t const valuesPerPair)
Resizes and resets the storage array to fit the current structure.
double rCut
Cutoff in real space.
double eta
Width of the gaussian screening charges.
void freeAtoms(bool all, double const maxCutoffRadius=0.0)
Free symmetry function memory for all atoms, see free() in Atom class.
void calculateVolume()
Calculate volume from box vectors.
@ ST_TRAINING
Structure is part of the training set.
@ ST_UNKNOWN
Sample type not assigned yet.
@ ST_TEST
Structure is part of the test set.
Vec3D invbox[3]
Inverse simulation box vectors.
void toPhysicalUnits(double meanEnergy, double convEnergy, double convLength, double convCharge)
Switch to physical units, shift energy and change energy, length and charge unit.
Vec3D box[3]
Simulation box vectors.
bool isTriclinic
If the simulation box is triclinic.
std::size_t getMaxNumNeighbors() const
Find maximum number of neighbors.
void setupNeighborCutoffMap(std::vector< std::vector< double > > cutoffs)
Set up a neighbor cut-off map which gives the index (value) of the last needed neighbor corresponding...
void sortNeighborList()
Sort all neighbor lists of this structure with respect to the distance.
Eigen::VectorXd const calculateForceLambdaElec() const
Calculate lambda_elec vector which is needed for the electrostatic force calculation in 4G NN.
std::vector< std::size_t > numAtomsPerElement
Number of atoms of each element in this structure.
double lambda
Lagrange multiplier used for charge equilibration.
void calculateMaxCutoffRadiusOverall(EwaldSetup &ewaldSetup, double rcutScreen, double maxCutoffRadius)
Calculate maximal cut-off if cut-off of screening and real part Ewald summation are also considered.
bool canMinimumImageConventionBeApplied(double cutoffRadius)
Check if cut-off radius is small enough to apply minimum image convention.
void writeToFile(std::string const fileName="output.data", bool const ref=true, bool const append=false) const
Write configuration to file.
void calculateDQdChi(std::vector< Eigen::VectorXd > &dQdChi)
Calculates derivative of the charges with respect to electronegativities.
std::string comment
Structure comment.
bool isPeriodic
If periodic boundary conditions apply.
double maxCutoffRadiusOverall
Maximum cut-off radius with respect to symmetry functions, screening function and Ewald summation.
double charge
Charge determined by neural network potential.
double calculateElectrostaticEnergy(EwaldSetup &ewaldSetup, Eigen::VectorXd hardness, Eigen::MatrixXd gammaSqrt2, Eigen::VectorXd sigmaSqrtPi, ScreeningFunction const &fs, double const fourPiEps, ErfcBuf &erfcBuf)
Compute electrostatic energy with global charge equilibration.
bool NeighborListIsSorted
If the neighbor list has been sorted by distance.
ElementMap elementMap
Copy of element map provided as constructor argument.
void setElementMap(ElementMap const &elementMap)
Set element map of structure.
std::size_t index
Index number of this structure.
void remap()
Translate all atoms back into box if outside.
std::vector< std::string > getChargesLines() const
Get reference and NN charges for all atoms.
double chargeRef
Reference charge.
SampleType sampleType
Sample type (training or test set).
double energyShort
Short-range part of the potential energy predicted by NNP.
void calculateDQdJ(std::vector< Eigen::VectorXd > &dQdJ)
Calculates derivative of the charges with respect to atomic hardness.
bool hasAMatrix
If A matrix of this structure is currently stored.
void addAtom(Atom const &atom, std::string const &element)
Add a single atom to structure.
void calculateInverseBox()
Calculate inverse box.
void writeToFilePoscar(std::ofstream *const &file) const
Write configuration to POSCAR file.
void writeToFileXyz(std::ofstream *const &file) const
Write configuration to xyz file.
bool hasSymmetryFunctionDerivatives
If symmetry function derivatives are saved for each atom.
void calculateDQdr(std::vector< size_t > const &atomsIndices, std::vector< size_t > const &compIndices, double const maxCutoffRadius, std::vector< Element > const &elements)
Calculates derivative of the charges with respect to the atom's position.
Eigen::MatrixXd A
Global charge equilibration matrix A'.
void calculatePbcCopies(double cutoffRadius, int(&pbc)[3])
Calculate required PBC copies.
Eigen::VectorXd const calculateForceLambdaTotal() const
Calculate lambda_total vector which is needed for the total force calculation in 4G NN.
std::string getEnergyLine() const
Get reference and NN energy.
void clearElectrostatics(bool clearDQdr=false)
Clear A-matrix, dAdrQ and optionally dQdr.
double energyElec
Electrostatics part of the potential energy predicted by NNP.
double energy
Potential energy determined by neural network.
void readFromFile(std::string const fileName="input.data")
Read configuration from file.
double energyRef
Reference potential energy.
int pbc[3]
Number of PBC images necessary in each direction for max cut-off.
void toNormalizedUnits(double meanEnergy, double convEnergy, double convLength, double convCharge)
Normalize structure, shift energy and change energy, length and charge unit.
void reset()
Reset everything but elementMap.
std::vector< std::string > getForcesLines() const
Get reference and NN forces for all atoms.
Structure()
Constructor, initializes to zero.
double volume
Simulation box volume.
void calculateElectrostaticEnergyDerivatives(Eigen::VectorXd hardness, Eigen::MatrixXd gammaSqrt2, Eigen::VectorXd sigmaSqrtPi, ScreeningFunction const &fs, double const fourPiEps)
Calculates partial derivatives of electrostatic Energy with respect to atom's coordinates and charges...
Vec3D applyMinimumImageConvention(Vec3D const &dr)
Calculate distance between two atoms in the minimum image convention.
void calculateNeighborList(double cutoffRadius, bool sortByDistance=false)
Calculate neighbor list for all atoms.
std::size_t numAtoms
Total number of atoms present in this structure.
std::size_t numElements
Global number of elements (all structures).
void updateError(std::string const &property, std::map< std::string, double > &error, std::size_t &count) const
Update property error metrics with this structure.
void calculateDAdrQ(EwaldSetup &ewaldSetup, Eigen::MatrixXd gammaSqrt2, double const fourPiEps, ErfcBuf &erfcBuf)
Calculates derivative of A-matrix with respect to the atoms positions and contract it with Q.
std::vector< Atom > atoms
Vector of all atoms in this structure.
std::size_t numElementsPresent
Number of elements present in this structure.
void readFromLines(std::vector< std::string > const &lines)
Read configuration from lines.
double calculateScreeningEnergy(Eigen::MatrixXd gammaSqrt2, Eigen::VectorXd sigmaSqrtPi, ScreeningFunction const &fs, double const fourPiEps)
Calculate screening energy which needs to be added (!) to the electrostatic energy in order to remove...
bool hasNeighborList
If the neighbor list has been calculated.
void clearNeighborList()
Clear neighbor list of all atoms.
std::vector< std::string > info() const
Get structure information as a vector of strings.
bool hasCharges
If all charges of this structure have been calculated (and stay the same, e.g.
bool hasSymmetryFunctions
If symmetry function values are saved for each atom.
Vector in 3 dimensional real space.
double norm2() const
Calculate square of norm of vector.
double norm() const
Calculate norm of vector.