n2p2 - A neural network potential package
Loading...
Searching...
No Matches
Structure.cpp
Go to the documentation of this file.
1// n2p2 - A neural network potential package
2// Copyright (C) 2018 Andreas Singraber (University of Vienna)
3//
4// This program is free software: you can redistribute it and/or modify
5// it under the terms of the GNU General Public License as published by
6// the Free Software Foundation, either version 3 of the License, or
7// (at your option) any later version.
8//
9// This program is distributed in the hope that it will be useful,
10// but WITHOUT ANY WARRANTY; without even the implied warranty of
11// MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the
12// GNU General Public License for more details.
13//
14// You should have received a copy of the GNU General Public License
15// along with this program. If not, see <https://www.gnu.org/licenses/>.
16
17#include "Kspace.h"
18#include "Structure.h"
19#include "Vec3D.h"
20#include "utility.h"
21#include <Eigen/Dense> // MatrixXd, VectorXd
22#include <algorithm> // std::max
23#include <cmath> // fabs, erf
24#include <cstdlib> // atof
25#include <limits> // std::numeric_limits
26#include <stdexcept> // std::runtime_error
27#include <string> // std::getline
28#include <iostream>
29
30using namespace std;
31using namespace nnp;
32using namespace Eigen;
33
34
36 isPeriodic (false ),
37 isTriclinic (false ),
38 hasNeighborList (false ),
39 NeighborListIsSorted (false ),
40 hasSymmetryFunctions (false ),
42 index (0 ),
43 numAtoms (0 ),
44 numElements (0 ),
46 energy (0.0 ),
47 energyRef (0.0 ),
48 energyShort (0.0 ),
49 energyElec (0.0 ),
50 hasCharges (false ),
51 charge (0.0 ),
52 chargeRef (0.0 ),
53 volume (0.0 ),
56 comment ("" ),
57 hasAMatrix (false )
58{
59 for (size_t i = 0; i < 3; i++)
60 {
61 pbc[i] = 0;
62 box[i][0] = 0.0;
63 box[i][1] = 0.0;
64 box[i][2] = 0.0;
65 invbox[i][0] = 0.0;
66 invbox[i][1] = 0.0;
67 invbox[i][2] = 0.0;
68 }
69}
70
72{
73 this->elementMap = elementMap;
74 numElements = elementMap.size();
76
77 return;
78}
79
80void Structure::addAtom(Atom const& atom, string const& element)
81{
82 atoms.push_back(Atom());
83 atoms.back() = atom;
84 // The number of elements may have changed.
85 atoms.back().numNeighborsPerElement.resize(elementMap.size(), 0);
86 atoms.back().clearNeighborList();
87 atoms.back().index = numAtoms;
88 atoms.back().indexStructure = index;
89 atoms.back().element = elementMap[element];
90 atoms.back().numSymmetryFunctions = 0;
91 numAtoms++;
93
94 return;
95}
96
97void Structure::readFromFile(string const fileName)
98{
99 ifstream file;
100
101 file.open(fileName.c_str());
102 if (!file.is_open())
103 {
104 throw runtime_error("ERROR: Could not open file: \"" + fileName
105 + "\".\n");
106 }
107 readFromFile(file);
108 file.close();
109
110 return;
111}
112
113void Structure::readFromFile(ifstream& file)
114{
115 string line;
116 vector<string> lines;
117 vector<string> splitLine;
118
119 // read first line, should be keyword "begin".
120 getline(file, line);
121 lines.push_back(line);
122 splitLine = split(reduce(line));
123 if (splitLine.at(0) != "begin")
124 {
125 throw runtime_error("ERROR: Unexpected file content, expected"
126 " \"begin\" keyword.\n");
127 }
128
129 while (getline(file, line))
130 {
131 lines.push_back(line);
132 splitLine = split(reduce(line));
133 if (splitLine.at(0) == "end") break;
134 }
135
136 readFromLines(lines);
137
138 return;
139}
140
141
142void Structure::readFromLines(vector<string> const& lines)
143{
144 size_t iBoxVector = 0;
145 vector<string> splitLine;
146
147 // read first line, should be keyword "begin".
148 splitLine = split(reduce(lines.at(0)));
149 if (splitLine.at(0) != "begin")
150 {
151 throw runtime_error("ERROR: Unexpected line content, expected"
152 " \"begin\" keyword.\n");
153 }
154
155 for (vector<string>::const_iterator line = lines.begin();
156 line != lines.end(); ++line)
157 {
158 splitLine = split(reduce(*line));
159 if (splitLine.at(0) == "begin")
160 {
161 if (splitLine.size() > 1)
162 {
163 for (vector<string>::const_iterator word =
164 splitLine.begin() + 1; word != splitLine.end(); ++word)
165 {
166 if (*word == "set=train") sampleType = ST_TRAINING;
167 else if (*word == "set=test") sampleType = ST_TEST;
168 else
169 {
170 throw runtime_error("ERROR: Unknown keyword in "
171 "structure specification, check "
172 "\"begin\" arguments.\n");
173 }
174 }
175 }
176 }
177 else if (splitLine.at(0) == "comment")
178 {
179 size_t position = line->find("comment");
180 string tmpLine = *line;
181 comment = tmpLine.erase(position, splitLine.at(0).length() + 1);
182 }
183 else if (splitLine.at(0) == "lattice")
184 {
185 if (iBoxVector > 2)
186 {
187 throw runtime_error("ERROR: Too many box vectors.\n");
188 }
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());
192 iBoxVector++;
193 if (iBoxVector == 3)
194 {
195 isPeriodic = true;
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())
202 {
203 isTriclinic = true;
204 }
207 }
208 }
209 else if (splitLine.at(0) == "atom")
210 {
211 atoms.push_back(Atom());
212 atoms.back().index = numAtoms;
213 atoms.back().indexStructure = index;
214 atoms.back().tag = numAtoms; // Implicit conversion!
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());
218 atoms.back().element = elementMap[splitLine.at(4)];
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());
223 atoms.back().numNeighborsPerElement.resize(numElements, 0);
224 numAtoms++;
225 numAtomsPerElement[elementMap[splitLine.at(4)]]++;
226 }
227 else if (splitLine.at(0) == "energy")
228 {
229 energyRef = atof(splitLine[1].c_str());
230 }
231 else if (splitLine.at(0) == "charge")
232 {
233 chargeRef = atof(splitLine[1].c_str());
234 }
235 else if (splitLine.at(0) == "end")
236 {
237 if (!(iBoxVector == 0 || iBoxVector == 3))
238 {
239 throw runtime_error("ERROR: Strange number of box vectors.\n");
240 }
241 if (isPeriodic &&
242 abs(chargeRef) > 10*std::numeric_limits<double>::epsilon())
243 {
244 throw runtime_error("ERROR: In structure with index "
245 + to_string(index)
246 + "; if PBCs are applied, the\n"
247 "simulation cell has to be neutrally "
248 "charged.\n");
249 }
250 break;
251 }
252 else
253 {
254 throw runtime_error("ERROR: Unexpected file content, "
255 "unknown keyword \"" + splitLine.at(0) +
256 "\".\n");
257 }
258 }
259
260 for (size_t i = 0; i < numElements; i++)
261 {
262 if (numAtomsPerElement[i] > 0)
263 {
265 }
266 }
267
268 if (isPeriodic) remap();
269
270 return;
271}
272
274 EwaldSetup& ewaldSetup,
275 double rcutScreen,
276 double maxCutoffRadius)
277{
278 maxCutoffRadiusOverall = max(rcutScreen, maxCutoffRadius);
279 if (isPeriodic)
280 {
283 ewaldSetup.params.rCut);
284 }
285}
286
288 double cutoffRadius,
289 bool sortByDistance)
290{
291 cutoffRadius = max( cutoffRadius, maxCutoffRadiusOverall );
292 //cout << "CUTOFF: " << cutoffRadius << "\n";
293
294 if (isPeriodic)
295 {
296 calculatePbcCopies(cutoffRadius, pbc);
297 // Use square of cutoffRadius (faster).
298 cutoffRadius *= cutoffRadius;
299
300#ifdef _OPENMP
301 #pragma omp parallel for
302#endif
303 for (size_t i = 0; i < numAtoms; i++)
304 {
305 // Count atom i as unique neighbor.
306 atoms[i].neighborsUnique.push_back(i);
307 atoms[i].numNeighborsUnique++;
308 for (size_t j = 0; j < numAtoms; j++)
309 {
310 for (int bc0 = -pbc[0]; bc0 <= pbc[0]; bc0++)
311 {
312 for (int bc1 = -pbc[1]; bc1 <= pbc[1]; bc1++)
313 {
314 for (int bc2 = -pbc[2]; bc2 <= pbc[2]; bc2++)
315 {
316 if (!(i == j && bc0 == 0 && bc1 == 0 && bc2 == 0))
317 {
318 Vec3D dr = atoms[i].r - atoms[j].r
319 + bc0 * box[0]
320 + bc1 * box[1]
321 + bc2 * box[2];
322 if (dr.norm2() <= cutoffRadius)
323 {
324 atoms[i].neighbors.
325 push_back(Atom::Neighbor());
326 atoms[i].neighbors.
327 back().index = j;
328 atoms[i].neighbors.
329 back().tag = j; // Implicit conversion!
330 atoms[i].neighbors.
331 back().element = atoms[j].element;
332 atoms[i].neighbors.
333 back().d = dr.norm();
334 atoms[i].neighbors.
335 back().dr = dr;
336 atoms[i].numNeighborsPerElement[
337 atoms[j].element]++;
338 atoms[i].numNeighbors++;
339 // Count atom j only once as unique
340 // neighbor.
341 if (atoms[i].neighborsUnique.back() != j &&
342 i != j)
343 {
344 atoms[i].neighborsUnique.push_back(j);
345 atoms[i].numNeighborsUnique++;
346 }
347 }
348 }
349 }
350 }
351 }
352 }
353 atoms[i].hasNeighborList = true;
354 }
355 }
356 else
357 {
358 // Use square of cutoffRadius (faster).
359 cutoffRadius *= cutoffRadius;
360
361#ifdef _OPENMP
362 #pragma omp parallel for
363#endif
364 for (size_t i = 0; i < numAtoms; i++)
365 {
366 // Count atom i as unique neighbor.
367 atoms[i].neighborsUnique.push_back(i);
368 atoms[i].numNeighborsUnique++;
369 for (size_t j = 0; j < numAtoms; j++)
370 {
371 if (i != j)
372 {
373 Vec3D dr = atoms[i].r - atoms[j].r;
374 if (dr.norm2() <= cutoffRadius)
375 {
376 atoms[i].neighbors.push_back(Atom::Neighbor());
377 atoms[i].neighbors.back().index = j;
378 atoms[i].neighbors.back().tag = j; // Impl. conv.!
379 atoms[i].neighbors.back().element = atoms[j].element;
380 atoms[i].neighbors.back().d = dr.norm();
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++;
386 }
387 }
388 }
389 atoms[i].hasNeighborList = true;
390 }
391 }
392
393 hasNeighborList = true;
394
395 if (sortByDistance) sortNeighborList();
396
397 return;
398}
399
400void Structure::calculateNeighborList(double cutoffRadius,
401 std::vector<
402 std::vector<double>>& cutoffs)
403{
404 calculateNeighborList(cutoffRadius, true);
405 setupNeighborCutoffMap(cutoffs);
406}
407
409{
410#ifdef _OPENMP
411 #pragma omp parallel for
412#endif
413 for (size_t i = 0; i < numAtoms; ++i)
414 {
415 sort(atoms[i].neighbors.begin(), atoms[i].neighbors.end());
416 //TODO: maybe sort neighborsUnique too?
417 atoms[i].NeighborListIsSorted = true;
418 }
420}
421
423 vector<double>> cutoffs)
424{
426 throw runtime_error("NeighborCutoffs map needs a sorted neighbor list");
427
428 for ( auto& elementCutoffs : cutoffs )
429 {
430 if ( maxCutoffRadiusOverall > 0 &&
431 !vectorContains(elementCutoffs, maxCutoffRadiusOverall))
432 {
433 elementCutoffs.push_back(maxCutoffRadiusOverall);
434 }
435
436 if ( !is_sorted(elementCutoffs.begin(), elementCutoffs.end()) )
437 {
438 sort(elementCutoffs.begin(), elementCutoffs.end());
439 }
440 }
441
442 // Loop over all atoms in this structure and create its neighborCutoffs map
443 for( auto& a : atoms )
444 {
445 size_t const eIndex = a.element;
446 vector<double> const& elementCutoffs = cutoffs.at(eIndex);
447 size_t in = 0;
448 size_t ic = 0;
449
450 while( in < a.numNeighbors && ic < elementCutoffs.size() )
451 {
452 Atom::Neighbor const& n = a.neighbors[in];
453 // If neighbor distance is higher than current "desired cutoff"
454 // then add neighbor cutoff.
455 // Attention: a step in the neighbor list could jump over multiple
456 // params -> don't increment neighbor index
457 if( n.d > elementCutoffs[ic] )
458 {
459 a.neighborCutoffs.emplace( elementCutoffs.at(ic), in );
460 ++ic;
461 }
462 else if ( in == a.numNeighbors - 1 )
463 {
464 a.neighborCutoffs.emplace( elementCutoffs.at(ic), a.numNeighbors );
465 ++ic;
466 }
467 else ++in;
468 }
469 }
470}
471
473{
474 size_t maxNumNeighbors = 0;
475
476 for(vector<Atom>::const_iterator it = atoms.begin();
477 it != atoms.end(); ++it)
478 {
479 maxNumNeighbors = max(maxNumNeighbors, it->numNeighbors);
480 }
481
482 return maxNumNeighbors;
483}
484
485void Structure::calculatePbcCopies(double cutoffRadius, int (&pbc)[3])
486{
487 Vec3D axb;
488 Vec3D axc;
489 Vec3D bxc;
490
491 axb = box[0].cross(box[1]).normalize();
492 axc = box[0].cross(box[2]).normalize();
493 bxc = box[1].cross(box[2]).normalize();
494
495 double proja = fabs(box[0] * bxc);
496 double projb = fabs(box[1] * axc);
497 double projc = fabs(box[2] * axb);
498
499 pbc[0] = 0;
500 pbc[1] = 0;
501 pbc[2] = 0;
502 while (pbc[0] * proja <= cutoffRadius)
503 {
504 pbc[0]++;
505 }
506 while (pbc[1] * projb <= cutoffRadius)
507 {
508 pbc[1]++;
509 }
510 while (pbc[2] * projc <= cutoffRadius)
511 {
512 pbc[2]++;
513 }
514
515 return;
516}
517
519{
520 double invdet = box[0][0] * box[1][1] * box[2][2]
521 + box[1][0] * box[2][1] * box[0][2]
522 + box[2][0] * box[0][1] * box[1][2]
523 - box[2][0] * box[1][1] * box[0][2]
524 - box[0][0] * box[2][1] * box[1][2]
525 - box[1][0] * box[0][1] * box[2][2];
526 invdet = 1.0 / invdet;
527
528 invbox[0][0] = box[1][1] * box[2][2] - box[2][1] * box[1][2];
529 invbox[0][1] = box[2][1] * box[0][2] - box[0][1] * box[2][2];
530 invbox[0][2] = box[0][1] * box[1][2] - box[1][1] * box[0][2];
531 invbox[0] *= invdet;
532
533 invbox[1][0] = box[2][0] * box[1][2] - box[1][0] * box[2][2];
534 invbox[1][1] = box[0][0] * box[2][2] - box[2][0] * box[0][2];
535 invbox[1][2] = box[1][0] * box[0][2] - box[0][0] * box[1][2];
536 invbox[1] *= invdet;
537
538 invbox[2][0] = box[1][0] * box[2][1] - box[2][0] * box[1][1];
539 invbox[2][1] = box[2][0] * box[0][1] - box[0][0] * box[2][1];
540 invbox[2][2] = box[0][0] * box[1][1] - box[1][0] * box[0][1];
541 invbox[2] *= invdet;
542
543 return;
544}
545
546// TODO: Not needed anymore, should we keep it?
548{
549 Vec3D axb;
550 Vec3D axc;
551 Vec3D bxc;
552
553 axb = box[0].cross(box[1]).normalize();
554 axc = box[0].cross(box[2]).normalize();
555 bxc = box[1].cross(box[2]).normalize();
556
557 double proj[3];
558 proj[0] = fabs(box[0] * bxc);
559 proj[1] = fabs(box[1] * axc);
560 proj[2] = fabs(box[2] * axb);
561
562 double minProj = *min_element(proj, proj+3);
563 return (cutoffRadius < minProj / 2.0);
564}
565
567{
568 Vec3D ds = invbox * dr;
569 Vec3D dsNINT;
570
571 for (size_t i=0; i<3; ++i)
572 {
573 dsNINT[i] = round(ds[i]);
574 }
575 Vec3D drMin = box * (ds - dsNINT);
576
577 return drMin;
578}
579
581{
582 volume = fabs(box[0] * (box[1].cross(box[2])));
583
584 return;
585}
586
588 EwaldSetup& ewaldSetup,
589 VectorXd hardness,
590 MatrixXd gammaSqrt2,
591 VectorXd sigmaSqrtPi,
592 ScreeningFunction const& fs,
593 double const fourPiEps,
594 ErfcBuf& erfcBuf)
595{
596 A.resize(numAtoms + 1, numAtoms + 1);
597 A.setZero();
598 VectorXd b(numAtoms + 1);
599 VectorXd hardnessJ(numAtoms);
600 VectorXd Q;
601 erfcBuf.reset(atoms, 2);
602
603#ifdef _OPENMP
604#pragma omp parallel
605 {
606#endif
607 if (isPeriodic)
608 {
609#ifdef _OPENMP
610#pragma omp single
611 {
612#endif
614 {
615 throw runtime_error("ERROR: Neighbor list needs to "
616 "be sorted for Ewald summation!\n");
617 }
618
619 // Should always happen already before neighborlist construction.
620 //ewaldSetup.calculateParameters(volume, numAtoms);
621#ifdef _OPENMP
622 }
623#endif
624 KspaceGrid grid;
625 grid.setup(box, ewaldSetup);
626 double const rcutReal = ewaldSetup.params.rCut;
627 //fprintf(stderr, "CAUTION: rcutReal = %f\n", rcutReal);
628 double const sqrt2eta = sqrt(2.0) * ewaldSetup.params.eta;
629
630#ifdef _OPENMP
631 #pragma omp for schedule(dynamic)
632#endif
633 for (size_t i = 0; i < numAtoms; ++i)
634 {
635 Atom const &ai = atoms.at(i);
636 size_t const ei = ai.element;
637
638 // diagonal including self interaction
639 A(i, i) += hardness(ei)
640 + (1.0 / sigmaSqrtPi(ei) - 2 / (sqrt2eta * sqrt(M_PI)))
641 / fourPiEps;
642
643 hardnessJ(i) = hardness(ei);
644 b(i) = -ai.chi;
645
646 // real part
647 size_t const numNeighbors = ai.getStoredMinNumNeighbors(rcutReal);
648 for (size_t k = 0; k < numNeighbors; ++k)
649 {
650 auto const &n = ai.neighbors[k];
651 size_t j = n.tag;
652 if (j < i) continue;
653
654 double const rij = n.d;
655 size_t const ej = n.element;
656
657 double erfcSqrt2Eta = erfcBuf.getf(i, k, 0, rij / sqrt2eta);
658 double erfcGammaSqrt2 =
659 erfcBuf.getf(i, k, 1, rij / gammaSqrt2(ei, ej));
660
661 A(i, j) += (erfcSqrt2Eta - erfcGammaSqrt2) / (rij * fourPiEps);
662 }
663 // reciprocal part
664 for (size_t j = i; j < numAtoms; ++j)
665 {
666 Atom const &aj = atoms.at(j);
667 for (auto const &gv: grid.kvectors)
668 {
669 // Multiply by 2 because our grid is only a half-sphere
670 // Vec3D const dr = applyMinimumImageConvention(ai.r - aj.r);
671 Vec3D const dr = ai.r - aj.r;
672 A(i, j) += 2 * gv.coeff * cos(gv.k * dr) / fourPiEps;
673 //A(i, j) += 2 * gv.coeff * cos(gv.k * (ai.r - aj.r));
674 }
675 A(j, i) = A(i, j);
676 }
677 }
678 }
679 else
680 {
681#ifdef _OPENMP
682#pragma omp for schedule(dynamic)
683#endif
684 for (size_t i = 0; i < numAtoms; ++i)
685 {
686 Atom const &ai = atoms.at(i);
687 size_t const ei = ai.element;
688
689 A(i, i) = hardness(ei) + 1.0 / (sigmaSqrtPi(ei) * fourPiEps);
690 hardnessJ(i) = hardness(ei);
691 b(i) = -ai.chi;
692 for (size_t j = i + 1; j < numAtoms; ++j)
693 {
694 Atom const &aj = atoms.at(j);
695 size_t const ej = aj.element;
696 double const rij = (ai.r - aj.r).norm();
697
698 A(i, j) = erf(rij / gammaSqrt2(ei, ej)) / (rij * fourPiEps);
699 A(j, i) = A(i, j);
700
701 }
702 }
703 }
704#ifdef _OPENMP
705#pragma omp single
706 {
707#endif
708 A.col(numAtoms).setOnes();
709 A.row(numAtoms).setOnes();
710 A(numAtoms, numAtoms) = 0.0;
711 hasAMatrix = true;
712 b(numAtoms) = chargeRef;
713#ifdef _OPENMP
714 }
715#endif
716 //TODO: sometimes only recalculation of A matrix is needed, because
717 // Qs are stored.
718 Q = A.colPivHouseholderQr().solve(b);
719#ifdef _OPENMP
720 #pragma omp for nowait
721#endif
722 for (size_t i = 0; i < numAtoms; ++i)
723 {
724 atoms.at(i).charge = Q(i);
725 }
726#ifdef _OPENMP
727 } // end of parallel region
728#endif
729
730 lambda = Q(numAtoms);
731 hasCharges = true;
732 double error = (A * Q - b).norm() / b.norm();
733
734 // We need matrix E not A, which only differ by the hardness terms along the diagonal
735 energyElec = 0.5 * Q.head(numAtoms).transpose()
736 * (A.topLeftCorner(numAtoms, numAtoms) -
737 MatrixXd(hardnessJ.asDiagonal())) * Q.head(numAtoms);
738 energyElec += calculateScreeningEnergy(gammaSqrt2, sigmaSqrtPi, fs, fourPiEps);
739
740 return error;
741}
742
744 MatrixXd gammaSqrt2,
745 VectorXd sigmaSqrtPi,
746 ScreeningFunction const& fs,
747 double const fourPiEps)
748
749{
750 double energyScreen = 0;
751 double const rcutScreen = fs.getOuter();
752
753#ifdef _OPENMP
754 #pragma omp parallel
755 {
756 double localEnergyScreen = 0;
757#endif
758 if (isPeriodic)
759 {
760#ifdef _OPENMP
761 #pragma omp for schedule(dynamic)
762#endif
763 for (size_t i = 0; i < numAtoms; ++i)
764 {
765 Atom const& ai = atoms.at(i);
766 size_t const ei = ai.element;
767 double const Qi = ai.charge;
768#ifdef _OPENMP
769 localEnergyScreen += -Qi * Qi
770 / (2 * sigmaSqrtPi(ei) * fourPiEps);
771#else
772 energyScreen += -Qi * Qi
773 / (2 * sigmaSqrtPi(ei) * fourPiEps);
774#endif
775
776 size_t const numNeighbors = ai.getStoredMinNumNeighbors(rcutScreen);
777 for (size_t k = 0; k < numNeighbors; ++k)
778 {
779 auto const& n = ai.neighbors[k];
780 size_t const j = n.tag;
781 if (j < i) continue;
782 double const rij = n.d;
783 size_t const ej = n.element;
784 //TODO: Maybe add charge to neighbor class?
785 double const Qj = atoms.at(j).charge;
786#ifdef _OPENMP
787 localEnergyScreen += Qi * Qj * erf(rij / gammaSqrt2(ei, ej))
788 * (fs.f(rij) - 1) / (rij * fourPiEps);
789#else
790 energyScreen += Qi * Qj * erf(rij / gammaSqrt2(ei, ej))
791 * (fs.f(rij) - 1) / (rij * fourPiEps);
792#endif
793
794 }
795 }
796 }
797 else
798 {
799#ifdef _OPENMP
800 #pragma omp for schedule(dynamic)
801#endif
802 for (size_t i = 0; i < numAtoms; ++i)
803 {
804 Atom const& ai = atoms.at(i);
805 size_t const ei = ai.element;
806 double const Qi = ai.charge;
807#ifdef _OPENMP
808 localEnergyScreen += -Qi * Qi
809 / (2 * sigmaSqrtPi(ei) * fourPiEps);
810#else
811 energyScreen += -Qi * Qi
812 / (2 * sigmaSqrtPi(ei) * fourPiEps);
813#endif
814
815 for (size_t j = i + 1; j < numAtoms; ++j)
816 {
817 Atom const& aj = atoms.at(j);
818 double const Qj = aj.charge;
819 double const rij = (ai.r - aj.r).norm();
820 if ( rij < rcutScreen )
821 {
822#ifdef _OPENMP
823 localEnergyScreen += Qi * Qj * A(i, j) * (fs.f(rij) - 1);
824#else
825 energyScreen += Qi * Qj * A(i, j) * (fs.f(rij) - 1);
826#endif
827 }
828 }
829 }
830 }
831#ifdef _OPENMP
832 #pragma omp atomic
833 energyScreen += localEnergyScreen;
834 }
835#endif
836 //cout << "energyScreen = " << energyScreen << endl;
837 return energyScreen;
838}
839
840
842 MatrixXd gammaSqrt2,
843 double const fourPiEps,
844 ErfcBuf& erfcBuf)
845{
846
847#ifdef _OPENMP
848 vector<Vec3D> dAdrQDiag(numAtoms);
849 #pragma omp parallel
850 {
851
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()))
855 #pragma omp for
856#endif
857 // TODO: This initialization loop could probably be avoid, maybe use
858 // default constructor?
859 for (size_t i = 0; i < numAtoms; ++i)
860 {
861 Atom &ai = atoms.at(i);
862 // dAdrQ(numAtoms+1,:) entries are zero
863 ai.dAdrQ.resize(numAtoms + 1);
864 }
865
866 if (isPeriodic)
867 {
868 // TODO: We need same Kspace grid as in calculateScreeningEnergy, should
869 // we cache it for reuse? Note that we can't calculate dAdrQ already in
870 // the loops of calculateElectrostaticEnergy because at this point we don't
871 // have the charges.
872
873 KspaceGrid grid;
874 grid.setup(box, ewaldSetup);
875 double rcutReal = ewaldSetup.params.rCut;
876 double const sqrt2eta = sqrt(2.0) * ewaldSetup.params.eta;
877
878#ifdef _OPENMP
879 // This way of parallelization slightly changes the result because of
880 // numerical errors.
881 #pragma omp for reduction(vec_Vec3D_plus : dAdrQDiag) schedule(dynamic)
882#endif
883 for (size_t i = 0; i < numAtoms; ++i)
884 {
885 Atom &ai = atoms.at(i);
886 size_t const ei = ai.element;
887 double const Qi = ai.charge;
888
889 // real part
890 size_t const numNeighbors = ai.getStoredMinNumNeighbors(rcutReal);
891 for (size_t k = 0; k < numNeighbors; ++k)
892 {
893 auto const &n = ai.neighbors[k];
894 size_t j = n.tag;
895 //if (j < i) continue;
896 if (j <= i) continue;
897
898 double const rij = n.d;
899 Atom &aj = atoms.at(j);
900 size_t const ej = aj.element;
901 double const Qj = aj.charge;
902
903 double erfcSqrt2Eta = erfcBuf.getf(i, k, 0, rij / sqrt2eta);
904 double erfcGammaSqrt2 =
905 erfcBuf.getf(i, k, 1, rij / gammaSqrt2(ei, ej));
906
907 Vec3D dAijdri;
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;
914 // Make use of symmetry: dA_{ij}/dr_i = dA_{ji}/dr_i
915 // = -dA_{ji}/dr_j = -dA_{ij}/dr_j
916 ai.dAdrQ[i] += dAijdri * Qj;
917 ai.dAdrQ[j] += dAijdri * Qi;
918 aj.dAdrQ[i] -= dAijdri * Qj;
919#ifdef _OPENMP
920 dAdrQDiag[j] -= dAijdri * Qi;
921#else
922 aj.dAdrQ[j] -= dAijdri * Qi;
923#endif
924 }
925
926 // reciprocal part
927 for (size_t j = i + 1; j < numAtoms; ++j)
928 {
929 Atom &aj = atoms.at(j);
930 double const Qj = aj.charge;
931 Vec3D dAijdri;
932 for (auto const &gv: grid.kvectors)
933 {
934 // Multiply by 2 because our grid is only a half-sphere
935 //Vec3D const dr = applyMinimumImageConvention(ai.r - aj.r);
936 Vec3D const dr = ai.r - aj.r;
937 dAijdri -= 2 * gv.coeff * sin(gv.k * dr) * gv.k;
938 }
939 dAijdri /= fourPiEps;
940
941 ai.dAdrQ[i] += dAijdri * Qj;
942 ai.dAdrQ[j] += dAijdri * Qi;
943 aj.dAdrQ[i] -= dAijdri * Qj;
944#ifdef _OPENMP
945 dAdrQDiag[j] -= dAijdri * Qi;
946#else
947 aj.dAdrQ[j] -= dAijdri * Qi;
948#endif
949 }
950 }
951
952 } else
953 {
954#ifdef _OPENMP
955 #pragma omp for reduction(vec_Vec3D_plus : dAdrQDiag) schedule(dynamic)
956#endif
957 for (size_t i = 0; i < numAtoms; ++i)
958 {
959 Atom &ai = atoms.at(i);
960 size_t const ei = ai.element;
961 double const Qi = ai.charge;
962
963 for (size_t j = i + 1; j < numAtoms; ++j)
964 {
965 Atom &aj = atoms.at(j);
966 size_t const ej = aj.element;
967 double const Qj = aj.charge;
968
969 double rij = (ai.r - aj.r).norm();
970 Vec3D dAijdri;
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;
976 // Make use of symmetry: dA_{ij}/dr_i = dA_{ji}/dr_i
977 // = -dA_{ji}/dr_j = -dA_{ij}/dr_j
978 ai.dAdrQ[i] += dAijdri * Qj;
979 ai.dAdrQ[j] = dAijdri * Qi;
980 aj.dAdrQ[i] = -dAijdri * Qj;
981#ifdef _OPENMP
982 dAdrQDiag[j] -= dAijdri * Qi;
983#else
984 aj.dAdrQ[j] -= dAijdri * Qi;
985#endif
986 }
987 }
988 }
989#ifdef _OPENMP
990 #pragma omp for
991 for (size_t i = 0; i < numAtoms; ++i)
992 {
993 Atom& ai = atoms[i];
994 ai.dAdrQ[i] += dAdrQDiag[i];
995 }
996 }
997#endif
998 return;
999}
1000
1001void Structure::calculateDQdChi(vector<Eigen::VectorXd> &dQdChi)
1002{
1003 dQdChi.clear();
1004 dQdChi.reserve(numAtoms);
1005 for (size_t i = 0; i < numAtoms; ++i)
1006 {
1007 // Including Lagrange multiplier equation.
1008 VectorXd b(numAtoms+1);
1009 b.setZero();
1010 b(i) = -1.;
1011 dQdChi.push_back(A.colPivHouseholderQr().solve(b).head(numAtoms));
1012 }
1013 return;
1014}
1015
1016void Structure::calculateDQdJ(vector<Eigen::VectorXd> &dQdJ)
1017{
1018 dQdJ.clear();
1019 dQdJ.reserve(numElements);
1020 for (size_t i = 0; i < numElements; ++i)
1021 {
1022 // Including Lagrange multiplier equation.
1023 VectorXd b(numAtoms+1);
1024 b.setZero();
1025 for (size_t j = 0; j < numAtoms; ++j)
1026 {
1027 Atom const &aj = atoms.at(j);
1028 if (i == aj.element) b(j) = -aj.charge;
1029 }
1030 dQdJ.push_back(A.colPivHouseholderQr().solve(b).head(numAtoms));
1031 }
1032 return;
1033}
1034
1035void Structure::calculateDQdr( vector<size_t> const& atomIndices,
1036 vector<size_t> const& compIndices,
1037 double const maxCutoffRadius,
1038 vector<Element> const& elements)
1039{
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)
1044 {
1045 Atom& a = atoms.at(atomIndices[i]);
1046 if ( a.dAdrQ.size() == 0 )
1047 throw runtime_error("ERROR: dAdrQ needs to be calculated before "
1048 "calculating dQdr");
1049 a.dQdr.resize(numAtoms);
1050
1051 // b stores (-dChidr - dAdrQ), last element for charge conservation.
1052 VectorXd b(numAtoms + 1);
1053 b.setZero();
1054 for (size_t j = 0; j < numAtoms; ++j)
1055 {
1056 Atom const& aj = atoms.at(j);
1057
1058#ifndef N2P2_FULL_SFD_MEMORY
1059 vector<vector<size_t> > const *const tableFull
1060 = &(elements.at(aj.element).getSymmetryFunctionTable());
1061#else
1062 vector<vector<size_t> > const *const tableFull = nullptr;
1063#endif
1064 b(j) -= aj.calculateDChidr(atomIndices[i],
1065 maxCutoffRadius,
1066 tableFull)[compIndices[i]];
1067 b(j) -= a.dAdrQ.at(j)[compIndices[i]];
1068 }
1069 VectorXd dQdr = A.colPivHouseholderQr().solve(b).head(numAtoms);
1070 for (size_t j = 0; j < numAtoms; ++j)
1071 {
1072 a.dQdr.at(j)[compIndices[i]] = dQdr(j);
1073 }
1074 }
1075 return;
1076}
1077
1078
1080 Eigen::VectorXd hardness,
1081 Eigen::MatrixXd gammaSqrt2,
1082 VectorXd sigmaSqrtPi,
1083 ScreeningFunction const& fs,
1084 double const fourPiEps)
1085{
1086 // Reset in case structure is used again (e.g. during training)
1087 for (Atom &ai : atoms)
1088 {
1089 ai.pEelecpr = Vec3D{};
1090 ai.dEelecdQ = 0.0;
1091 }
1092
1093 double rcutScreen = fs.getOuter();
1094 for (size_t i = 0; i < numAtoms; ++i)
1095 {
1096 Atom& ai = atoms.at(i);
1097 size_t const ei = ai.element;
1098 double const Qi = ai.charge;
1099
1100 // TODO: This loop could be reduced by making use of symmetry, j>=i or
1101 // so
1102 for (size_t j = 0; j < numAtoms; ++j)
1103 {
1104 Atom& aj = atoms.at(j);
1105 double const Qj = aj.charge;
1106
1107 ai.pEelecpr += 0.5 * Qj * ai.dAdrQ[j];
1108 // Diagonal terms contain self-interaction --> screened
1109 if (i != j) ai.dEelecdQ += Qj * A(i,j);
1110 else if (isPeriodic)
1111 {
1112 ai.dEelecdQ += Qi * (A(i,i) - hardness(ei)
1113 - 1 / (sigmaSqrtPi(ei) * fourPiEps));
1114 }
1115 }
1116
1117 if (isPeriodic)
1118 {
1119 for (auto const& ajN : ai.neighbors)
1120 {
1121 size_t j = ajN.tag;
1122 Atom& aj = atoms.at(j);
1123 if (j < i) continue;
1124 double const rij = ajN.d;
1125
1126 if (rij >= rcutScreen) break;
1127
1128 size_t const ej = aj.element;
1129 double const Qj = atoms.at(j).charge;
1130
1131 double erfRij = erf(rij / gammaSqrt2(ei,ej));
1132 double fsRij = fs.f(rij);
1133
1134 // corrections due to screening
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);
1140 Tij /= fourPiEps;
1141 ai.pEelecpr += Tij;
1142 aj.pEelecpr -= Tij;
1143
1144 double Sij = erfRij * (fsRij - 1) / rij;
1145 Sij /= fourPiEps;
1146 ai.dEelecdQ += Qj * Sij;
1147 aj.dEelecdQ += Qi * Sij;
1148 }
1149 }
1150 else
1151 {
1152 for (size_t j = i + 1; j < numAtoms; ++j)
1153 {
1154 Atom& aj = atoms.at(j);
1155 double const rij = (ai.r - aj.r).norm();
1156 if (rij >= rcutScreen) continue;
1157
1158 size_t const ej = aj.element;
1159 double const Qj = atoms.at(j).charge;
1160
1161 double erfRij = erf(rij / gammaSqrt2(ei,ej));
1162 double fsRij = fs.f(rij);
1163
1164 // corrections due to screening
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);
1170 Tij /= fourPiEps;
1171 ai.pEelecpr += Tij;
1172 aj.pEelecpr -= Tij;
1173
1174 double Sij = erfRij * (fsRij - 1) / rij;
1175 Sij /= fourPiEps;
1176 ai.dEelecdQ += Qj * Sij;
1177 aj.dEelecdQ += Qi * Sij;
1178 }
1179 }
1180 }
1181 return;
1182}
1183
1185{
1186 VectorXd dEdQ(numAtoms+1);
1187 for (size_t i = 0; i < numAtoms; ++i)
1188 {
1189 Atom const& ai = atoms.at(i);
1190 dEdQ(i) = ai.dEelecdQ + ai.dEdG.back();
1191 }
1192 dEdQ(numAtoms) = 0;
1193 VectorXd const lambdaTotal = A.colPivHouseholderQr().solve(-dEdQ);
1194 return lambdaTotal;
1195}
1196
1198{
1199 VectorXd dEelecdQ(numAtoms+1);
1200 for (size_t i = 0; i < numAtoms; ++i)
1201 {
1202 Atom const& ai = atoms.at(i);
1203 dEelecdQ(i) = ai.dEelecdQ;
1204 }
1205 dEelecdQ(numAtoms) = 0;
1206 VectorXd const lambdaElec = A.colPivHouseholderQr().solve(-dEelecdQ);
1207 return lambdaElec;
1208}
1209
1211{
1212 for (vector<Atom>::iterator it = atoms.begin(); it != atoms.end(); ++it)
1213 {
1214 remap((*it));
1215 }
1216 return;
1217}
1218
1220{
1221 Vec3D f = atom.r[0] * invbox[0]
1222 + atom.r[1] * invbox[1]
1223 + atom.r[2] * invbox[2];
1224
1225 // Quick and dirty... there may be a more elegant way!
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];
1229
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];
1233
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;
1237
1238 atom.r = f[0] * box[0]
1239 + f[1] * box[1]
1240 + f[2] * box[2];
1241
1242 return;
1243}
1244
1245void Structure::toNormalizedUnits(double meanEnergy,
1246 double convEnergy,
1247 double convLength,
1248 double convCharge)
1249{
1250 if (isPeriodic)
1251 {
1252 box[0] *= convLength;
1253 box[1] *= convLength;
1254 box[2] *= convLength;
1255 invbox[0] /= convLength;
1256 invbox[1] /= convLength;
1257 invbox[2] /= convLength;
1258 }
1259
1260 energyRef = (energyRef - numAtoms * meanEnergy) * convEnergy;
1261 energy = (energy - numAtoms * meanEnergy) * convEnergy;
1262 chargeRef *= convCharge;
1263 charge *= convCharge;
1264 volume *= convLength * convLength * convLength;
1265
1266 for (vector<Atom>::iterator it = atoms.begin(); it != atoms.end(); ++it)
1267 {
1268 it->toNormalizedUnits(convEnergy, convLength, convCharge);
1269 }
1270
1271 return;
1272}
1273
1274void Structure::toPhysicalUnits(double meanEnergy,
1275 double convEnergy,
1276 double convLength,
1277 double convCharge)
1278{
1279 if (isPeriodic)
1280 {
1281 box[0] /= convLength;
1282 box[1] /= convLength;
1283 box[2] /= convLength;
1284 invbox[0] *= convLength;
1285 invbox[1] *= convLength;
1286 invbox[2] *= convLength;
1287 }
1288
1289 energyRef = energyRef / convEnergy + numAtoms * meanEnergy;
1290 energy = energy / convEnergy + numAtoms * meanEnergy;
1291 chargeRef /= convCharge;
1292 charge /= convCharge;
1293 volume /= convLength * convLength * convLength;
1294
1295 for (vector<Atom>::iterator it = atoms.begin(); it != atoms.end(); ++it)
1296 {
1297 it->toPhysicalUnits(convEnergy, convLength, convCharge);
1298 }
1299
1300 return;
1301}
1302
1303void Structure::freeAtoms(bool all, double const maxCutoffRadius)
1304{
1305 for (vector<Atom>::iterator it = atoms.begin(); it != atoms.end(); ++it)
1306 {
1307 it->free(all, maxCutoffRadius);
1308 }
1309 if (all) hasSymmetryFunctions = false;
1311
1312 return;
1313}
1314
1316{
1317 isPeriodic = false ;
1318 isTriclinic = false ;
1319 hasNeighborList = false ;
1320 hasSymmetryFunctions = false ;
1322 index = 0 ;
1323 numAtoms = 0 ;
1324 numElementsPresent = 0 ;
1325 energy = 0.0 ;
1326 energyRef = 0.0 ;
1327 charge = 0.0 ;
1328 chargeRef = 0.0 ;
1329 volume = 0.0 ;
1331 comment = "" ;
1332
1333 for (size_t i = 0; i < 3; ++i)
1334 {
1335 pbc[i] = 0;
1336 for (size_t j = 0; j < 3; ++j)
1337 {
1338 box[i][j] = 0.0;
1339 invbox[i][j] = 0.0;
1340 }
1341 }
1342
1343 numElements = elementMap.size();
1344 numAtomsPerElement.clear();
1346 atoms.clear();
1347 vector<Atom>(atoms).swap(atoms);
1348
1349 return;
1350}
1351
1353{
1354 for (size_t i = 0; i < numAtoms; i++)
1355 {
1356 Atom& a = atoms.at(i);
1357 // This may have changed if atoms are added via addAtoms().
1360 }
1361 hasNeighborList = false;
1362 hasSymmetryFunctions = false;
1364
1365 return;
1366}
1367
1369{
1370 A.resize(0,0);
1371 hasAMatrix = false;
1372 for (auto& a : atoms)
1373 {
1374 vector<Vec3D>().swap(a.dAdrQ);
1375 if (clearDQdr)
1376 {
1377 vector<Vec3D>().swap(a.dQdr);
1378 }
1379 }
1380}
1381
1382void Structure::updateError(string const& property,
1383 map<string, double>& error,
1384 size_t& count) const
1385{
1386 if (property == "energy")
1387 {
1388 count++;
1389 double diff = energyRef - energy;
1390 error.at("RMSEpa") += diff * diff / (numAtoms * numAtoms);
1391 error.at("RMSE") += diff * diff;
1392 diff = fabs(diff);
1393 error.at("MAEpa") += diff / numAtoms;
1394 error.at("MAE") += diff;
1395 }
1396 else if (property == "force" || property == "charge")
1397 {
1398 for (vector<Atom>::const_iterator it = atoms.begin();
1399 it != atoms.end(); ++it)
1400 {
1401 it->updateError(property, error, count);
1402 }
1403 }
1404 else
1405 {
1406 throw runtime_error("ERROR: Unknown property for error update.\n");
1407 }
1408
1409 return;
1410}
1411
1413{
1414 return strpr("%10zu %16.8E %16.8E\n",
1415 index,
1417 energy / numAtoms);
1418}
1419
1420vector<string> Structure::getForcesLines() const
1421{
1422 vector<string> v;
1423 for (vector<Atom>::const_iterator it = atoms.begin();
1424 it != atoms.end(); ++it)
1425 {
1426 vector<string> va = it->getForcesLines();
1427 v.insert(v.end(), va.begin(), va.end());
1428 }
1429
1430 return v;
1431}
1432
1433vector<string> Structure::getChargesLines() const
1434{
1435 vector<string> v;
1436 for (vector<Atom>::const_iterator it = atoms.begin();
1437 it != atoms.end(); ++it)
1438 {
1439 v.push_back(it->getChargeLine());
1440 }
1441
1442 return v;
1443}
1444
1445void Structure::writeToFile(string const fileName,
1446 bool const ref,
1447 bool const append) const
1448{
1449 ofstream file;
1450
1451 if (append)
1452 {
1453 file.open(fileName.c_str(), ofstream::app);
1454 }
1455 else
1456 {
1457 file.open(fileName.c_str());
1458 }
1459 if (!file.is_open())
1460 {
1461 throw runtime_error("ERROR: Could not open file: \"" + fileName
1462 + "\".\n");
1463 }
1464 writeToFile(&file, ref );
1465 file.close();
1466
1467 return;
1468}
1469
1470void Structure::writeToFile(ofstream* const& file, bool const ref) const
1471{
1472 if (!file->is_open())
1473 {
1474 runtime_error("ERROR: Cannot write to file, file is not open.\n");
1475 }
1476
1477 (*file) << "begin\n";
1478 (*file) << strpr("comment %s\n", comment.c_str());
1479 if (isPeriodic)
1480 {
1481 for (size_t i = 0; i < 3; ++i)
1482 {
1483 (*file) << strpr("lattice %24.16E %24.16E %24.16E\n",
1484 box[i][0], box[i][1], box[i][2]);
1485 }
1486 }
1487 for (vector<Atom>::const_iterator it = atoms.begin();
1488 it != atoms.end(); ++it)
1489 {
1490 if (ref)
1491 {
1492 (*file) << strpr("atom %24.16E %24.16E %24.16E %2s %24.16E %24.16E"
1493 " %24.16E %24.16E %24.16E\n",
1494 it->r[0],
1495 it->r[1],
1496 it->r[2],
1497 elementMap[it->element].c_str(),
1498 it->chargeRef,
1499 0.0,
1500 it->fRef[0],
1501 it->fRef[1],
1502 it->fRef[2]);
1503 }
1504 else
1505 {
1506 (*file) << strpr("atom %24.16E %24.16E %24.16E %2s %24.16E %24.16E"
1507 " %24.16E %24.16E %24.16E\n",
1508 it->r[0],
1509 it->r[1],
1510 it->r[2],
1511 elementMap[it->element].c_str(),
1512 it->charge,
1513 0.0,
1514 it->f[0],
1515 it->f[1],
1516 it->f[2]);
1517
1518 }
1519 }
1520 if (ref) (*file) << strpr("energy %24.16E\n", energyRef);
1521 else (*file) << strpr("energy %24.16E\n", energy);
1522 if (ref) (*file) << strpr("charge %24.16E\n", chargeRef);
1523 else (*file) << strpr("charge %24.16E\n", charge);
1524 (*file) << strpr("end\n");
1525
1526 return;
1527}
1528
1529void Structure::writeToFileXyz(ofstream* const& file) const
1530{
1531 if (!file->is_open())
1532 {
1533 runtime_error("ERROR: Could not write to file.\n");
1534 }
1535
1536 (*file) << strpr("%d\n", numAtoms);
1537 if (isPeriodic)
1538 {
1539 (*file) << "Lattice=\"";
1540 (*file) << strpr("%24.16E %24.16E %24.16E " ,
1541 box[0][0], box[0][1], box[0][2]);
1542 (*file) << strpr("%24.16E %24.16E %24.16E " ,
1543 box[1][0], box[1][1], box[1][2]);
1544 (*file) << strpr("%24.16E %24.16E %24.16E\"\n",
1545 box[2][0], box[2][1], box[2][2]);
1546 }
1547 else
1548 {
1549 (*file) << "\n";
1550 }
1551 for (vector<Atom>::const_iterator it = atoms.begin();
1552 it != atoms.end(); ++it)
1553 {
1554 (*file) << strpr("%-2s %24.16E %24.16E %24.16E\n",
1555 elementMap[it->element].c_str(),
1556 it->r[0],
1557 it->r[1],
1558 it->r[2]);
1559 }
1560
1561 return;
1562}
1563
1564void Structure::writeToFilePoscar(ofstream* const& file) const
1565{
1566 writeToFilePoscar(file, elementMap.getElementsString());
1567
1568 return;
1569}
1570
1571void Structure::writeToFilePoscar(ofstream* const& file,
1572 string const elements) const
1573{
1574 if (!file->is_open())
1575 {
1576 runtime_error("ERROR: Could not write to file.\n");
1577 }
1578
1579 vector<string> ve = split(elements);
1580 vector<size_t> elementOrder;
1581 for (size_t i = 0; i < ve.size(); ++i)
1582 {
1583 elementOrder.push_back(elementMap[ve.at(i)]);
1584 }
1585 if (elementOrder.size() != elementMap.size())
1586 {
1587 runtime_error("ERROR: Inconsistent element declaration.\n");
1588 }
1589
1590 (*file) << strpr("%s, ", comment.c_str());
1591 (*file) << strpr("ATOM=%s", elementMap[elementOrder.at(0)].c_str());
1592 for (size_t i = 1; i < elementOrder.size(); ++i)
1593 {
1594 (*file) << strpr(" %s", elementMap[elementOrder.at(i)].c_str());
1595 }
1596 (*file) << "\n";
1597 (*file) << "1.0\n";
1598 if (isPeriodic)
1599 {
1600 (*file) << strpr("%24.16E %24.16E %24.16E\n",
1601 box[0][0], box[0][1], box[0][2]);
1602 (*file) << strpr("%24.16E %24.16E %24.16E\n",
1603 box[1][0], box[1][1], box[1][2]);
1604 (*file) << strpr("%24.16E %24.16E %24.16E\n",
1605 box[2][0], box[2][1], box[2][2]);
1606 }
1607 else
1608 {
1609 runtime_error("ERROR: Writing non-periodic structure to POSCAR file "
1610 "is not implemented.\n");
1611 }
1612 (*file) << strpr("%d", numAtomsPerElement.at(elementOrder.at(0)));
1613 for (size_t i = 1; i < numAtomsPerElement.size(); ++i)
1614 {
1615 (*file) << strpr(" %d", numAtomsPerElement.at(elementOrder.at(i)));
1616 }
1617 (*file) << "\n";
1618 (*file) << "Cartesian\n";
1619 for (size_t i = 0; i < elementOrder.size(); ++i)
1620 {
1621 for (vector<Atom>::const_iterator it = atoms.begin();
1622 it != atoms.end(); ++it)
1623 {
1624 if (it->element == elementOrder.at(i))
1625 {
1626 (*file) << strpr("%24.16E %24.16E %24.16E\n",
1627 it->r[0],
1628 it->r[1],
1629 it->r[2]);
1630 }
1631 }
1632 }
1633
1634 return;
1635}
1636
1637vector<string> Structure::info() const
1638{
1639 vector<string> v;
1640
1641 v.push_back(strpr("********************************\n"));
1642 v.push_back(strpr("STRUCTURE \n"));
1643 v.push_back(strpr("********************************\n"));
1644 vector<string> vm = elementMap.info();
1645 v.insert(v.end(), vm.begin(), vm.end());
1646 v.push_back(strpr("index : %d\n", index));
1647 v.push_back(strpr("isPeriodic : %d\n", isPeriodic ));
1648 v.push_back(strpr("isTriclinic : %d\n", isTriclinic ));
1649 v.push_back(strpr("hasNeighborList : %d\n", hasNeighborList ));
1650 v.push_back(strpr("hasSymmetryFunctions : %d\n", hasSymmetryFunctions));
1651 v.push_back(strpr("hasSymmetryFunctionDerivatives : %d\n", hasSymmetryFunctionDerivatives));
1652 v.push_back(strpr("numAtoms : %d\n", numAtoms ));
1653 v.push_back(strpr("numElements : %d\n", numElements ));
1654 v.push_back(strpr("numElementsPresent : %d\n", numElementsPresent));
1655 v.push_back(strpr("pbc : %d %d %d\n", pbc[0], pbc[1], pbc[2]));
1656 v.push_back(strpr("energy : %16.8E\n", energy ));
1657 v.push_back(strpr("energyRef : %16.8E\n", energyRef ));
1658 v.push_back(strpr("charge : %16.8E\n", charge ));
1659 v.push_back(strpr("chargeRef : %16.8E\n", chargeRef ));
1660 v.push_back(strpr("volume : %16.8E\n", volume ));
1661 v.push_back(strpr("sampleType : %d\n", (int)sampleType));
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]));
1666 v.push_back(strpr("invbox[0] : %16.8E %16.8E %16.8E\n", invbox[0][0], invbox[0][1], invbox[0][2]));
1667 v.push_back(strpr("invbox[1] : %16.8E %16.8E %16.8E\n", invbox[1][0], invbox[1][1], invbox[1][2]));
1668 v.push_back(strpr("invbox[2] : %16.8E %16.8E %16.8E\n", invbox[2][0], invbox[2][1], invbox[2][2]));
1669 v.push_back(strpr("--------------------------------\n"));
1670 v.push_back(strpr("numAtomsPerElement [*] : %d\n", numAtomsPerElement.size()));
1671 v.push_back(strpr("--------------------------------\n"));
1672 for (size_t i = 0; i < numAtomsPerElement.size(); ++i)
1673 {
1674 v.push_back(strpr("%29d : %d\n", i, numAtomsPerElement.at(i)));
1675 }
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)
1681 {
1682 v.push_back(strpr("%29d :\n", i));
1683 vector<string> va = atoms[i].info();
1684 v.insert(v.end(), va.begin(), va.end());
1685 }
1686 v.push_back(strpr("--------------------------------\n"));
1687 v.push_back(strpr("********************************\n"));
1688
1689 return v;
1690}
Contains element map.
Definition ElementMap.h:30
Setup data for Ewald summation.
Definition EwaldSetup.h:37
EwaldParameters params
Definition EwaldSetup.h:39
void calculateParameters(double const newVolume, size_t const newNumAtoms)
Compute eta, rCut and kCut.
std::vector< Kvector > kvectors
Vector containing all k-vectors.
Definition Kspace.h:70
void setup(Vec3D box[3], EwaldSetup &ewaldSetup)
Set up reciprocal box vectors and eta.
Definition Kspace.cpp:45
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 .
Definition Atom.h:29
string strpr(const char *format,...)
String version of printf function.
Definition utility.cpp:90
bool vectorContains(std::vector< T > const &stdVec, T value)
Test if vector contains specified value.
Definition utility.h:166
vector< string > split(string const &input, char delimiter)
Split string at each delimiter.
Definition utility.cpp:33
string reduce(string const &line, string const &whitespace, string const &fill)
Replace multiple whitespaces with fill.
Definition utility.cpp:60
Struct to store information on neighbor atoms.
Definition Atom.h:36
double d
Distance to neighbor atom.
Definition Atom.h:44
Storage for a single atom.
Definition Atom.h:33
std::vector< Neighbor > neighbors
Neighbor array (maximum number defined in macros.h.
Definition Atom.h:170
Vec3D r
Cartesian coordinates.
Definition Atom.h:125
std::vector< double > dEdG
Derivative of atomic energy with respect to symmetry functions.
Definition Atom.h:149
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.
Definition Atom.cpp:403
double charge
Atomic charge determined by neural network.
Definition Atom.h:121
std::size_t getStoredMinNumNeighbors(double const cutoffRadius) const
Return needed number of neighbors for a given cutoff radius from neighborCutoffs map.
Definition Atom.cpp:329
double chi
Atomic electronegativity determined by neural network.
Definition Atom.h:119
void clearNeighborList()
Clear neighbor list.
Definition Atom.cpp:285
Vec3D pEelecpr
Partial derivative of electrostatic energy with respect to this atom's coordinates.
Definition Atom.h:134
std::vector< Vec3D > dAdrQ
If dQdr has been calculated for respective components.
Definition Atom.h:168
std::size_t element
Element index of this atom.
Definition Atom.h:107
std::vector< Vec3D > dQdr
Derivative of charges with respect to this atom's coordinates.
Definition Atom.h:163
double dEelecdQ
Derivative of electrostatic energy with respect to this atom's charge.
Definition Atom.h:117
std::vector< std::size_t > numNeighborsPerElement
Number of neighbors per element.
Definition Atom.h:138
Helper class to store previously calculated values of erfc() that are needed during the charge equili...
Definition ErfcBuf.h:17
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.
Definition ErfcBuf.cpp:21
void reset(std::vector< Atom > const &atoms, size_t const valuesPerPair)
Resizes and resets the storage array to fit the current structure.
Definition ErfcBuf.cpp:10
double rCut
Cutoff in real space.
Definition IEwaldTrunc.h:42
double eta
Width of the gaussian screening charges.
Definition IEwaldTrunc.h:40
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.
Definition Structure.h:49
@ ST_UNKNOWN
Sample type not assigned yet.
Definition Structure.h:46
@ ST_TEST
Structure is part of the test set.
Definition Structure.h:55
Vec3D invbox[3]
Inverse simulation box vectors.
Definition Structure.h:114
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.
Definition Structure.h:112
bool isTriclinic
If the simulation box is triclinic.
Definition Structure.h:63
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.
Definition Structure.h:120
double lambda
Lagrange multiplier used for charge equilibration.
Definition Structure.h:106
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.
Definition Structure.h:110
bool isPeriodic
If periodic boundary conditions apply.
Definition Structure.h:61
double maxCutoffRadiusOverall
Maximum cut-off radius with respect to symmetry functions, screening function and Ewald summation.
Definition Structure.h:103
double charge
Charge determined by neural network potential.
Definition Structure.h:96
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.
Definition Structure.h:67
ElementMap elementMap
Copy of element map provided as constructor argument.
Definition Structure.h:59
void setElementMap(ElementMap const &elementMap)
Set element map of structure.
Definition Structure.cpp:71
std::size_t index
Index number of this structure.
Definition Structure.h:73
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.
Definition Structure.h:98
SampleType sampleType
Sample type (training or test set).
Definition Structure.h:108
double energyShort
Short-range part of the potential energy predicted by NNP.
Definition Structure.h:88
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.
Definition Structure.h:118
void addAtom(Atom const &atom, std::string const &element)
Add a single atom to structure.
Definition Structure.cpp:80
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.
Definition Structure.h:71
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'.
Definition Structure.h:116
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.
Definition Structure.h:91
double energy
Potential energy determined by neural network.
Definition Structure.h:83
void readFromFile(std::string const fileName="input.data")
Read configuration from file.
Definition Structure.cpp:97
double energyRef
Reference potential energy.
Definition Structure.h:85
int pbc[3]
Number of PBC images necessary in each direction for max cut-off.
Definition Structure.h:81
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.
Definition Structure.cpp:35
double volume
Simulation box volume.
Definition Structure.h:100
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.
Definition Structure.h:75
std::size_t numElements
Global number of elements (all structures).
Definition Structure.h:77
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.
Definition Structure.h:122
std::size_t numElementsPresent
Number of elements present in this structure.
Definition Structure.h:79
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.
Definition Structure.h:65
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.
Definition Structure.h:94
bool hasSymmetryFunctions
If symmetry function values are saved for each atom.
Definition Structure.h:69
Vector in 3 dimensional real space.
Definition Vec3D.h:30
double norm2() const
Calculate square of norm of vector.
Definition Vec3D.h:299
double norm() const
Calculate norm of vector.
Definition Vec3D.h:294