n2p2 - A neural network potential package
Loading...
Searching...
No Matches
LAMMPS_NS::PairHDNNP4G Class Reference

#include <pair_hdnnp_4g.h>

Inheritance diagram for LAMMPS_NS::PairHDNNP4G:
Collaboration diagram for LAMMPS_NS::PairHDNNP4G:

Public Member Functions

 PairHDNNP4G (class LAMMPS *)
 
virtual ~PairHDNNP4G ()
 
virtual void compute (int, int)
 
virtual void settings (int, char **)
 
virtual void coeff (int, char **)
 
virtual void init_style ()
 
virtual double init_one (int, int)
 
void init_list (int, class NeighList *)
 
virtual void write_restart (FILE *)
 
virtual void read_restart (FILE *)
 
virtual void write_restart_settings (FILE *)
 
virtual void read_restart_settings (FILE *)
 

Protected Member Functions

virtual void allocate ()
 
void transferNeighborList ()
 
void isPeriodic ()
 
void transferCharges ()
 
void handleExtrapolationWarnings ()
 
void deallocateQEq ()
 
double forceLambda_f (const gsl_vector *)
 
void forceLambda_df (const gsl_vector *, gsl_vector *)
 
void forceLambda_fdf (const gsl_vector *, double *, gsl_vector *)
 
void calculateForceLambda ()
 
void calculateElecDerivatives (double *, double **)
 
void calculateElecForce (double **)
 
void calculate_kspace_terms ()
 
double screening_f (double)
 
double screening_df (double)
 

Static Protected Member Functions

static double forceLambda_f_wrap (const gsl_vector *, void *)
 
static void forceLambda_df_wrap (const gsl_vector *, void *, gsl_vector *)
 
static void forceLambda_fdf_wrap (const gsl_vector *, void *, double *, gsl_vector *)
 

Protected Attributes

class KSpaceHDNNPkspacehdnnp
 
int me
 
int nprocs
 
bool periodic
 
bool showew
 
bool resetew
 
int showewsum
 
int maxew
 
long numExtrapolationWarningsTotal
 
long numExtrapolationWarningsSummary
 
double cflength
 
double cfenergy
 
double maxCutoffRadius
 
char * directory
 
char * emap
 
class NeighList * list
 
nnp::InterfaceLammps interface
 
double * chi
 
double * hardness
 
double * sigmaSqrtPi
 
double ** gammaSqrt2
 
double * dEdQ
 
double * forceLambda
 
double grad_tol
 
double min_tol
 
double step
 
int maxit
 
int minim_init_style
 
const gsl_multimin_fdfminimizer_type * T
 
gsl_multimin_fdfminimizer * s
 
gsl_multimin_function_fdf forceLambda_minimizer
 
double E_elec
 
double kcoeff_sum
 
int nmax
 
int * type_all
 
int * type_loc
 
double * dEdLambda_loc
 
double * dEdLambda_all
 
double * qall_loc
 
double * qall
 
double * xx
 
double * xy
 
double * xz
 
double * xx_loc
 
double * xy_loc
 
double * xz_loc
 
double * forceLambda_loc
 
double * forceLambda_all
 
double ** erfc_val
 
double ** kcos
 
double ** ksinx
 
double ** ksiny
 
double ** ksinz
 
double * screening_info
 

Friends

class FixHDNNP
 
class KSpaceHDNNP
 

Detailed Description

Definition at line 37 of file pair_hdnnp_4g.h.

Constructor & Destructor Documentation

◆ PairHDNNP4G()

PairHDNNP4G::PairHDNNP4G ( class LAMMPS * lmp)

Definition at line 54 of file pair_hdnnp_4g.cpp.

54 : Pair(lmp),
55 kspacehdnnp (nullptr),
56 periodic (false ),
57 showew (false ),
58 resetew (false ),
59 showewsum (0 ),
60 maxew (0 ),
63 cflength (0.0 ),
64 cfenergy (0.0 ),
65 maxCutoffRadius (0.0 ),
66 directory (nullptr),
67 emap (nullptr),
68 list (nullptr),
69 chi (nullptr),
70 hardness (nullptr),
71 sigmaSqrtPi (nullptr),
72 gammaSqrt2 (nullptr),
73 dEdQ (nullptr),
74 forceLambda (nullptr),
75 grad_tol (0.0 ),
76 min_tol (0.0 ),
77 step (0.0 ),
78 maxit (0 ),
80 T (nullptr),
81 s (nullptr),
82 E_elec (0.0 ),
83 kcoeff_sum (0.0 ),
84 type_all (nullptr),
85 type_loc (nullptr),
86 dEdLambda_loc (nullptr),
87 dEdLambda_all (nullptr),
88 qall_loc (nullptr),
89 qall (nullptr),
90 xx (nullptr),
91 xy (nullptr),
92 xz (nullptr),
93 xx_loc (nullptr),
94 xy_loc (nullptr),
95 xz_loc (nullptr),
96 forceLambda_loc (nullptr),
97 forceLambda_all (nullptr),
98 erfc_val (nullptr),
99 kcos (nullptr),
100 ksinx (nullptr),
101 ksiny (nullptr),
102 ksinz (nullptr),
103 screening_info (nullptr)
104{
105
106 MPI_Comm_rank(world,&me);
107 MPI_Comm_size(world,&nprocs);
108}
gsl_multimin_fdfminimizer * s
const gsl_multimin_fdfminimizer_type * T
class KSpaceHDNNP * kspacehdnnp
class NeighList * list

References cfenergy, cflength, chi, dEdLambda_all, dEdLambda_loc, dEdQ, directory, E_elec, emap, erfc_val, forceLambda, forceLambda_all, forceLambda_loc, gammaSqrt2, grad_tol, hardness, kcoeff_sum, kcos, ksinx, ksiny, ksinz, kspacehdnnp, list, maxCutoffRadius, maxew, maxit, me, min_tol, minim_init_style, nprocs, numExtrapolationWarningsSummary, numExtrapolationWarningsTotal, periodic, qall, qall_loc, resetew, s, screening_info, showew, showewsum, sigmaSqrtPi, step, T, type_all, type_loc, xx, xx_loc, xy, xy_loc, xz, and xz_loc.

Referenced by forceLambda_df_wrap(), forceLambda_f_wrap(), and forceLambda_fdf_wrap().

Here is the caller graph for this function:

◆ ~PairHDNNP4G()

PairHDNNP4G::~PairHDNNP4G ( )
virtual

Definition at line 114 of file pair_hdnnp_4g.cpp.

115{
116}

Member Function Documentation

◆ compute()

void PairHDNNP4G::compute ( int eflag,
int vflag )
virtual

Definition at line 118 of file pair_hdnnp_4g.cpp.

119{
120 if(eflag || vflag) ev_setup(eflag,vflag);
121 else evflag = vflag_fdotr = eflag_global = eflag_atom = 0;
122
123 if (interface.getNnpType() == InterfaceLammps::NNPType::HDNNP_2G)
124 {
125 // Set number of local atoms and add element.
126 interface.setLocalAtoms(atom->nlocal,atom->type);
127
128 // Set tags of local atoms.
129 interface.setLocalTags(atom->tag);
130
131 // Transfer local neighbor list to NNP interface.
133
134 // Compute symmetry functions, atomic neural networks and add up energy.
135 interface.process();
136
137 // Do all stuff related to extrapolation warnings.
138 if(showew == true || showewsum > 0 || maxew >= 0) {
140 }
141
142 // get short-range forces of local and ghost atoms.
143 interface.getForces(atom->f);
144
145 }
146 else if (interface.getNnpType() == InterfaceLammps::NNPType::HDNNP_4G)
147 {
148 // Transfer charges into n2p2 before running second set of NNs
150
151 // Add electrostatic energy contribution to the total energy before conversion TODO:check
152 interface.addElectrostaticEnergy(E_elec);
153
154 // Run second set of NNs for the short range contributions
155 interface.process();
156
157 // Get short-range forces of local and ghost atoms.
158 interface.getForces(atom->f);
159
160 // Initialize global arrays
161 for (int i =0; i < atom->natoms; i++){
162 qall[i] = 0.0;
163 qall_loc[i] = 0.0;
164 dEdLambda_all[i] = 0.0;
165 dEdLambda_loc[i] = 0.0;
166 forceLambda[i] = 0.0;
167 dEdQ[i] = 0.0;
168 forceLambda_loc[i] = 0.0;
169 forceLambda_all[i] = 0.0;
170 xx_loc[i] = 0.0;
171 xy_loc[i] = 0.0;
172 xz_loc[i] = 0.0;
173 xx[i] = 0.0;
174 xy[i] = 0.0;
175 xz[i] = 0.0;
176 type_loc[i] = 0;
177 type_all[i] = 0;
178 }
179
180 // Create global sparse arrays here
181 for (int i = 0; i < atom->nlocal; i++){
182 qall_loc[atom->tag[i]-1] = atom->q[i]; // global charge vector on each proc
183 xx_loc[atom->tag[i]-1] = atom->x[i][0];
184 xy_loc[atom->tag[i]-1] = atom->x[i][1];
185 xz_loc[atom->tag[i]-1] = atom->x[i][2];
186 type_loc[atom->tag[i]-1] = atom->type[i];
187 }
188
189 // Communicate atomic charges and positions
190 MPI_Allreduce(qall_loc,qall,atom->natoms,MPI_DOUBLE,MPI_SUM,world);
191 MPI_Allreduce(type_loc,type_all,atom->natoms,MPI_INT,MPI_SUM,world);
192 MPI_Allreduce(xx_loc,xx,atom->natoms,MPI_DOUBLE,MPI_SUM,world);
193 MPI_Allreduce(xy_loc,xy,atom->natoms,MPI_DOUBLE,MPI_SUM,world);
194 MPI_Allreduce(xz_loc,xz,atom->natoms,MPI_DOUBLE,MPI_SUM,world);
195
196 //TODO: it did not work when they were in the constructor as they are in FixHDNNP, check
197 if (periodic){
198 kspacehdnnp = nullptr;
199 kspacehdnnp = (KSpaceHDNNP *) force->kspace_match("^hdnnp",0);
200 }
201
202 // Calculates and stores k-space terms for speedup
204
205 // Calculate dEelecdQ and add pEelecpr contribution to the total force vector
206 calculateElecDerivatives(dEdQ,atom->f); // TODO: calculate fElec separately ?
207
208 // Read dEdG array from n2p2
209 interface.getdEdQ(dEdQ);
210
211 // Calculate lambda vector that is necessary for optimized force calculation
212 calculateForceLambda(); // TODO: lambdaElec & f_elec ?
213
214 // Communicate forceLambda
215 for (int i = 0; i < atom->nlocal; i++){
216 forceLambda_loc[atom->tag[i]-1] = forceLambda[i];
217 }
218 for (int i = 0; i < atom->natoms; i++){
219 forceLambda_all[i] = 0.0;
220 }
221 MPI_Allreduce(forceLambda_loc,forceLambda_all,atom->natoms,MPI_DOUBLE,MPI_SUM,world);
222
223 // Add electrostatic contributions and calculate final force vector
224 calculateElecForce(atom->f);
225
226 // TODO check
227 memory->destroy(erfc_val);
228
229 // Do all stuff related to extrapolation warnings.
230 if(showew == true || showewsum > 0 || maxew >= 0) {
232 }
233 }
234 // Add energy contribution to total energy.
235 if (eflag_global)
236 ev_tally(0,0,atom->nlocal,1,interface.getEnergy(),0.0,0.0,0.0,0.0,0.0);
237
238 // Add atomic energy if requested (CAUTION: no physical meaning!).
239 if (eflag_atom)
240 for (int i = 0; i < atom->nlocal; ++i)
241 eatom[i] = interface.getAtomicEnergy(i);
242
243 // If virial needed calculate via F dot r.
244 if (vflag_fdotr) virial_fdotr_compute();
245}
nnp::InterfaceLammps interface
void calculateElecDerivatives(double *, double **)
void calculateElecForce(double **)

References calculate_kspace_terms(), calculateElecDerivatives(), calculateElecForce(), calculateForceLambda(), dEdLambda_all, dEdLambda_loc, dEdQ, E_elec, erfc_val, forceLambda, forceLambda_all, forceLambda_loc, handleExtrapolationWarnings(), nnp::Mode::HDNNP_2G, nnp::Mode::HDNNP_4G, interface, KSpaceHDNNP, kspacehdnnp, maxew, periodic, qall, qall_loc, showew, showewsum, transferCharges(), transferNeighborList(), type_all, type_loc, xx, xx_loc, xy, xy_loc, xz, and xz_loc.

Here is the call graph for this function:

◆ settings()

void PairHDNNP4G::settings ( int narg,
char ** arg )
virtual

Definition at line 251 of file pair_hdnnp_4g.cpp.

252{
253 int iarg = 0;
254
255 if (narg == 0) error->all(FLERR,"Illegal pair_style command");
256
257 // default settings
258 int len = strlen("nnp/") + 1;
259 directory = new char[len];
260 strcpy(directory,"nnp/");
261 showew = true;
262 showewsum = 0;
263 maxew = 0;
264 resetew = false;
265 cflength = 1.0;
266 cfenergy = 1.0;
267 len = strlen("") + 1;
268 emap = new char[len];
269 strcpy(emap,"");
272
273 while(iarg < narg) {
274 // set NNP directory
275 if (strcmp(arg[iarg],"dir") == 0) {
276 if (iarg+2 > narg)
277 error->all(FLERR,"Illegal pair_style command");
278 delete[] directory;
279 len = strlen(arg[iarg+1]) + 2;
280 directory = new char[len];
281 sprintf(directory, "%s/", arg[iarg+1]);
282 iarg += 2;
283 // element mapping
284 } else if (strcmp(arg[iarg],"emap") == 0) {
285 if (iarg+2 > narg)
286 error->all(FLERR,"Illegal pair_style command");
287 delete[] emap;
288 len = strlen(arg[iarg+1]) + 1;
289 emap = new char[len];
290 sprintf(emap, "%s", arg[iarg+1]);
291 iarg += 2;
292 // show extrapolation warnings
293 } else if (strcmp(arg[iarg],"showew") == 0) {
294 if (iarg+2 > narg)
295 error->all(FLERR,"Illegal pair_style command");
296 if (strcmp(arg[iarg+1],"yes") == 0)
297 showew = true;
298 else if (strcmp(arg[iarg+1],"no") == 0)
299 showew = false;
300 else
301 error->all(FLERR,"Illegal pair_style command");
302 iarg += 2;
303 // show extrapolation warning summary
304 } else if (strcmp(arg[iarg],"showewsum") == 0) {
305 if (iarg+2 > narg)
306 error->all(FLERR,"Illegal pair_style command");
307 showewsum = utils::inumeric(FLERR,arg[iarg+1],false,lmp);
308 iarg += 2;
309 // maximum allowed extrapolation warnings
310 } else if (strcmp(arg[iarg],"maxew") == 0) {
311 if (iarg+2 > narg)
312 error->all(FLERR,"Illegal pair_style command");
313 maxew = utils::inumeric(FLERR,arg[iarg+1],false,lmp);
314 iarg += 2;
315 // reset extrapolation warning counter
316 } else if (strcmp(arg[iarg],"resetew") == 0) {
317 if (iarg+2 > narg)
318 error->all(FLERR,"Illegal pair_style command");
319 if (strcmp(arg[iarg+1],"yes") == 0)
320 resetew = true;
321 else if (strcmp(arg[iarg+1],"no") == 0)
322 resetew = false;
323 else
324 error->all(FLERR,"Illegal pair_style command");
325 iarg += 2;
326 // length unit conversion factor
327 } else if (strcmp(arg[iarg],"cflength") == 0) {
328 if (iarg+2 > narg)
329 error->all(FLERR,"Illegal pair_style command");
330 cflength = utils::numeric(FLERR,arg[iarg+1],false,lmp);
331 iarg += 2;
332 // energy unit conversion factor
333 } else if (strcmp(arg[iarg],"cfenergy") == 0) {
334 if (iarg+2 > narg)
335 error->all(FLERR,"Illegal pair_style command");
336 cfenergy = utils::numeric(FLERR,arg[iarg+1],false,lmp);
337 iarg += 2;
338 } else error->all(FLERR,"Illegal pair_style command");
339 }
340}

References cfenergy, cflength, directory, emap, maxew, numExtrapolationWarningsSummary, numExtrapolationWarningsTotal, resetew, showew, and showewsum.

◆ coeff()

void PairHDNNP4G::coeff ( int narg,
char ** arg )
virtual

Definition at line 346 of file pair_hdnnp_4g.cpp.

347{
348 if (!allocated) allocate();
349
350 if (narg != 3) error->all(FLERR,"Incorrect args for pair coefficients");
351
352 int ilo,ihi,jlo,jhi;
353
354 utils::bounds(FLERR,arg[0],1,atom->ntypes,ilo,ihi,error);
355 utils::bounds(FLERR,arg[1],1,atom->ntypes,jlo,jhi,error);
356
357 maxCutoffRadius = utils::numeric(FLERR,arg[2],false,lmp); // this the cutoff specified via pair_coeff in the input
358
359 // TODO: Check how this flag is set.
360 int count = 0;
361 for(int i=ilo; i<=ihi; i++) {
362 for(int j=MAX(jlo,i); j<=jhi; j++) {
363 setflag[i][j] = 1;
364 count++;
365 }
366 }
367
368 if (count == 0) error->all(FLERR,"Incorrect args for pair coefficients");
369}

References allocate(), and maxCutoffRadius.

Here is the call graph for this function:

◆ init_style()

void PairHDNNP4G::init_style ( )
virtual

TODO: add nnpType

Definition at line 375 of file pair_hdnnp_4g.cpp.

376{
377 //int irequest = neighbor->request((void *) this);
378 //neighbor->requests[irequest]->pair = 1;
379 //neighbor->requests[irequest]->half = 0;
380 //neighbor->requests[irequest]->full = 1;
381 neighbor->add_request(this, NeighConst::REQ_FULL);
382
383 // Return immediately if NNP setup is already completed.
384 if (interface.isInitialized()) return;
385
386 // Activate screen and logfile output only for rank 0.
387 if (comm->me == 0) {
388 if (lmp->screen != NULL)
389 interface.log.registerCFilePointer(&(lmp->screen));
390 if (lmp->logfile != NULL)
391 interface.log.registerCFilePointer(&(lmp->logfile));
392 }
393
395 // Initialize interface on all processors.
396 interface.initialize(directory,
397 emap,
398 showew,
399 resetew,
400 showewsum,
401 maxew,
402 cflength,
403 cfenergy,
405 atom->ntypes,
406 comm->me);
407 // LAMMPS cutoff radius (given via pair_coeff) should not be smaller than
408 // maximum symmetry function cutoff radius.
409 if (maxCutoffRadius < interface.getMaxCutoffRadius())
410 error->all(FLERR,"Inconsistent cutoff radius");
411
412 if (interface.getNnpType() == InterfaceLammps::NNPType::HDNNP_4G)
413 {
414 isPeriodic(); // check for periodicity here
415 }
416}

References cfenergy, cflength, directory, emap, nnp::Mode::HDNNP_4G, interface, isPeriodic(), maxCutoffRadius, maxew, resetew, showew, and showewsum.

Here is the call graph for this function:

◆ init_one()

double PairHDNNP4G::init_one ( int i,
int j )
virtual

Definition at line 431 of file pair_hdnnp_4g.cpp.

432{
433 // TODO: Check how this actually works for different cutoffs.
434 return maxCutoffRadius;
435}

References maxCutoffRadius.

◆ init_list()

void PairHDNNP4G::init_list ( int ,
class NeighList * ptr )

Definition at line 422 of file pair_hdnnp_4g.cpp.

423{
424 list = ptr;
425}

References list.

◆ write_restart()

void PairHDNNP4G::write_restart ( FILE * fp)
virtual

Definition at line 441 of file pair_hdnnp_4g.cpp.

442{
443 return;
444}

◆ read_restart()

void PairHDNNP4G::read_restart ( FILE * fp)
virtual

Definition at line 450 of file pair_hdnnp_4g.cpp.

451{
452 return;
453}

◆ write_restart_settings()

void PairHDNNP4G::write_restart_settings ( FILE * fp)
virtual

Definition at line 459 of file pair_hdnnp_4g.cpp.

460{
461 return;
462}

◆ read_restart_settings()

void PairHDNNP4G::read_restart_settings ( FILE * fp)
virtual

Definition at line 468 of file pair_hdnnp_4g.cpp.

469{
470 return;
471}

◆ allocate()

void PairHDNNP4G::allocate ( )
protectedvirtual

Definition at line 477 of file pair_hdnnp_4g.cpp.

478{
479 allocated = 1;
480 int n = atom->ntypes;
481 int natoms = atom->natoms;
482 int nlocal = atom->nlocal;
483
484
485
486 memory->create(setflag,n+1,n+1,"pair:setflag");
487 for (int i = 1; i <= n; i++)
488 for (int j = i; j <= n; j++)
489 setflag[i][j] = 0;
490
491 memory->create(cutsq,n+1,n+1,"pair:cutsq");
492
493 // TODO: add an if and initialize only for 4G
494 // Allocate and initialize 4G-related arrays
495 dEdQ = nullptr;
496 forceLambda = nullptr;
497 memory->create(dEdQ,natoms+1,"pair:dEdQ");
498 memory->create(forceLambda,natoms+1,"pair:forceLambda");
499 memory->create(dEdLambda_loc,natoms,"pair_nnp:dEdLambda_loc");
500 memory->create(dEdLambda_all,natoms,"pair_nnp:dEdLambda_all");
501 memory->create(qall_loc,natoms,"pair_nnp:qall_loc");
502 memory->create(qall,natoms,"pair_nnp:qall");
503 memory->create(type_loc,natoms,"pair_nnp:type_loc");
504 memory->create(type_all,natoms,"pair_nnp:type_all");
505 memory->create(xx,natoms,"pair_nnp:xx");
506 memory->create(xy,natoms,"pair_nnp:xy");
507 memory->create(xz,natoms,"pair_nnp:xz");
508 memory->create(xx_loc,natoms,"pair_nnp:xx_loc");
509 memory->create(xy_loc,natoms,"pair_nnp:xy_loc");
510 memory->create(xz_loc,natoms,"pair_nnp:xz_loc");
511 memory->create(forceLambda_loc,natoms,"pair_nnp:forceLambda_loc");
512 memory->create(forceLambda_all,natoms,"pair_nnp:forceLambda_all");
513
514 /*memory->create(kcos,nlocal,natoms,"pair_nnp:kcos");
515 memory->create(ksinx,nlocal,natoms,"pair_nnp:ksinx");
516 memory->create(ksiny,nlocal,natoms,"pair_nnp:ksiny");
517 memory->create(ksinz,nlocal,natoms,"pair_nnp:ksinz");*/
518
519 for (int i = 0; i < natoms+1; i++)
520 {
521 forceLambda[i] = 0.0;
522 dEdQ[i] = 0.0;
523 }
524
525 /*for (int i = 0; i < nlocal; i++)
526 {
527 for (int j = 0; j < natoms; j++)
528 {
529 kcos[i][j] = 0.0;
530 ksinx[i][j] = 0.0;
531 ksiny[i][j] = 0.0;
532 ksinz[i][j] = 0.0;
533 }
534 }*/
535
536}

References dEdLambda_all, dEdLambda_loc, dEdQ, forceLambda, forceLambda_all, forceLambda_loc, qall, qall_loc, type_all, type_loc, xx, xx_loc, xy, xy_loc, xz, and xz_loc.

Referenced by coeff().

Here is the caller graph for this function:

◆ transferNeighborList()

void PairHDNNP4G::transferNeighborList ( )
protected

Definition at line 539 of file pair_hdnnp_4g.cpp.

540{
541 // Transfer neighbor list to NNP.
542 double rc2 = maxCutoffRadius * maxCutoffRadius;
543 for (int ii = 0; ii < list->inum; ++ii) {
544 int i = list->ilist[ii];
545 for (int jj = 0; jj < list->numneigh[i]; ++jj) {
546 int j = list->firstneigh[i][jj];
547 j &= NEIGHMASK;
548 double dx = atom->x[i][0] - atom->x[j][0];
549 double dy = atom->x[i][1] - atom->x[j][1];
550 double dz = atom->x[i][2] - atom->x[j][2];
551 double d2 = dx * dx + dy * dy + dz * dz;
552 if (d2 <= rc2) {
553 interface.addNeighbor(i,j,atom->tag[j],atom->type[j],dx,dy,dz,d2);
554 }
555 }
556 }
557}

References interface, list, and maxCutoffRadius.

Referenced by compute().

Here is the caller graph for this function:

◆ isPeriodic()

void PairHDNNP4G::isPeriodic ( )
protected

Definition at line 1341 of file pair_hdnnp_4g.cpp.

1342{
1343 if (domain->nonperiodic == 0) periodic = true;
1344 else periodic = false;
1345}

References periodic.

Referenced by init_style().

Here is the caller graph for this function:

◆ transferCharges()

void PairHDNNP4G::transferCharges ( )
protected

Definition at line 651 of file pair_hdnnp_4g.cpp.

652{
653 for (int i = 0; i < atom->nlocal; ++i) {
654 interface.addCharge(i,atom->q[i]);
655 }
656}

References interface.

Referenced by compute().

Here is the caller graph for this function:

◆ handleExtrapolationWarnings()

void PairHDNNP4G::handleExtrapolationWarnings ( )
protected

Definition at line 559 of file pair_hdnnp_4g.cpp.

560{
561 // Get number of extrapolation warnings for local atoms.
562 // TODO: Is the conversion from std::size_t to long ok?
563 long numCurrentEW = (long)interface.getNumExtrapolationWarnings();
564
565 // Update (or set, resetew == true) total warnings counter.
566 if (resetew) numExtrapolationWarningsTotal = numCurrentEW;
567 else numExtrapolationWarningsTotal += numCurrentEW;
568
569 // Update warnings summary counter.
570 if(showewsum > 0) {
571 numExtrapolationWarningsSummary += numCurrentEW;
572 }
573
574 // If requested write extrapolation warnings.
575 // Requires communication of all symmetry functions statistics entries to
576 // rank 0.
577 if(showew > 0) {
578 // First collect an overview of extrapolation warnings per process.
579 long* numEWPerProc = NULL;
580 if(comm->me == 0) numEWPerProc = new long[comm->nprocs];
581 MPI_Gather(&numCurrentEW, 1, MPI_LONG, numEWPerProc, 1, MPI_LONG, 0, world);
582
583 if(comm->me == 0) {
584 for(int i=1;i<comm->nprocs;i++) {
585 if(numEWPerProc[i] > 0) {
586 long bs = 0;
587 MPI_Status ms;
588 // Get buffer size.
589 MPI_Recv(&bs, 1, MPI_LONG, i, 0, world, &ms);
590 char* buf = new char[bs];
591 // Receive buffer.
592 MPI_Recv(buf, bs, MPI_BYTE, i, 0, world, &ms);
593 interface.extractEWBuffer(buf, bs);
594 delete[] buf;
595 }
596 }
597 interface.writeExtrapolationWarnings();
598 }
599 else if(numCurrentEW > 0) {
600 // Get desired buffer length for all extrapolation warning entries.
601 long bs = interface.getEWBufferSize();
602 // Allocate and fill buffer.
603 char* buf = new char[bs];
604 interface.fillEWBuffer(buf, bs);
605 // Send buffer size and buffer.
606 MPI_Send(&bs, 1, MPI_LONG, 0, 0, world);
607 MPI_Send(buf, bs, MPI_BYTE, 0, 0, world);
608 delete[] buf;
609 }
610
611 if(comm->me == 0) delete[] numEWPerProc;
612 }
613
614 // If requested gather number of warnings to display summary.
615 if(showewsum > 0 && update->ntimestep % showewsum == 0) {
616 long globalEW = 0;
617 // Communicate the sum over all processors to proc 0.
619 &globalEW, 1, MPI_LONG, MPI_SUM, 0, world);
620 // Write to screen or logfile.
621 if(comm->me == 0) {
622 if(screen) {
623 fprintf(screen,
624 "### NNP EW SUMMARY ### TS: %10ld EW %10ld EWPERSTEP %10.3e\n",
625 update->ntimestep,
626 globalEW,
627 double(globalEW) / showewsum);
628 }
629 if(logfile) {
630 fprintf(logfile,
631 "### NNP EW SUMMARY ### TS: %10ld EW %10ld EWPERSTEP %10.3e\n",
632 update->ntimestep,
633 globalEW,
634 double(globalEW) / showewsum);
635 }
636 }
637 // Reset summary counter.
639 }
640
641 // Stop if maximum number of extrapolation warnings is exceeded.
643 error->one(FLERR,"Too many extrapolation warnings");
644 }
645
646 // Reset internal extrapolation warnings counters.
647 interface.clearExtrapolationWarnings();
648}

References interface, maxew, numExtrapolationWarningsSummary, numExtrapolationWarningsTotal, resetew, showew, and showewsum.

Referenced by compute().

Here is the caller graph for this function:

◆ deallocateQEq()

void LAMMPS_NS::PairHDNNP4G::deallocateQEq ( )
protected

◆ forceLambda_f()

double PairHDNNP4G::forceLambda_f ( const gsl_vector * v)
protected

Definition at line 659 of file pair_hdnnp_4g.cpp.

660{
661 int i,j,jmap;
662 int *type = atom->type;
663 int nlocal = atom->nlocal;
664 int *tag = atom->tag;
665 int nall = atom->natoms;
666
667 double **x = atom->x;
668 double E_real, E_recip, E_self;
669 double E_lambda,E_lambda_loc;
670 double iiterm,ijterm;
671
672 double eta;
673
674 if (periodic) eta = 1 / kspacehdnnp->g_ewald; // LAMMPS truncation
675
676 E_lambda = 0.0;
677 E_lambda_loc = 0.0;
678 if (periodic)
679 {
680 double sqrt2eta = (sqrt(2.0) * eta);
681 E_recip = 0.0;
682 E_real = 0.0;
683 E_self = 0.0;
684 for (i = 0; i < nlocal; i++) // over local atoms
685 {
686 double const lambda_i = gsl_vector_get(v, tag[i]-1);
687 double lambda_i2 = lambda_i * lambda_i;
688
689 // Self interactionsterm
690 E_self += lambda_i2 * (1 / (2.0 * sigmaSqrtPi[type[i]-1]) - 1 / (sqrt(2.0 * M_PI) * eta));
691 E_lambda_loc += dEdQ[i] * lambda_i + 0.5 * hardness[type[i]-1] * lambda_i2;
692
693 // Real space
694 // TODO: we loop over the full neighbor list, could this be optimized ?
695 for (int jj = 0; jj < list->numneigh[i]; ++jj) {
696 j = list->firstneigh[i][jj];
697 j &= NEIGHMASK;
698 double const lambda_j = gsl_vector_get(v, tag[j]-1);
699 //jmap = atom->map(tag[j]);
700 //double const dx = x[i][0] - x[j][0];
701 //double const dy = x[i][1] - x[j][1];
702 //double const dz = x[i][2] - x[j][2];
703 //double const rij = sqrt(SQR(dx) + SQR(dy) + SQR(dz)) * cflength;
704 //double erfcRij = (erfc(rij / sqrt2eta) - erfc(rij / gammaSqrt2[type[i]-1][type[jmap]-1])) / rij;
705 //double real = 0.5 * lambda_i * lambda_j * erfcRij;
706 double real = 0.5 * lambda_i * lambda_j * erfc_val[i][jj];
707 E_real += real;
708 }
709 }
710 // Reciprocal space
711 for (int k = 0; k < kspacehdnnp->kcount; k++) // over k-space
712 {
713 double sf_real_loc = 0.0;
714 double sf_im_loc = 0.0;
715 kspacehdnnp->sf_real[k] = 0.0;
716 kspacehdnnp->sf_im[k] = 0.0;
717 for (i = 0; i < nlocal; i++) //TODO: check
718 {
719 double const lambda_i = gsl_vector_get(v,tag[i]-1);
720 sf_real_loc += lambda_i * kspacehdnnp->sfexp_rl[k][i];
721 sf_im_loc += lambda_i * kspacehdnnp->sfexp_im[k][i];
722 }
723 MPI_Allreduce(&(sf_real_loc),&(kspacehdnnp->sf_real[k]),1,MPI_DOUBLE,MPI_SUM,world);
724 MPI_Allreduce(&(sf_im_loc),&(kspacehdnnp->sf_im[k]),1,MPI_DOUBLE,MPI_SUM,world);
725 E_recip += kspacehdnnp->kcoeff[k] * (pow(kspacehdnnp->sf_real[k],2) + pow(kspacehdnnp->sf_im[k],2));
726 }
727 E_lambda_loc += E_real + E_self;
728 }else
729 {
730 // first loop over local atoms
731 for (i = 0; i < nlocal; i++) {
732 double const lambda_i = gsl_vector_get(v,i);
733 // add i terms here
734 iiterm = lambda_i * lambda_i / (2.0 * sigmaSqrtPi[type[i]-1]);
735 E_lambda += iiterm + dEdQ[i]*lambda_i + 0.5*hardness[type[i]-1]*lambda_i*lambda_i;
736 // second loop over 'all' atoms
737 for (j = i + 1; j < nall; j++) {
738 double const lambda_j = gsl_vector_get(v, j);
739 double const dx = x[j][0] - x[i][0];
740 double const dy = x[j][1] - x[i][1];
741 double const dz = x[j][2] - x[i][2];
742 double const rij = sqrt(SQR(dx) + SQR(dy) + SQR(dz)) * cflength;
743 ijterm = lambda_i * lambda_j * (erf(rij / gammaSqrt2[type[i]-1][type[j]-1]) / rij);
744 E_lambda += ijterm;
745 }
746 }
747 }
748
749 MPI_Allreduce(&E_lambda_loc,&E_lambda,1,MPI_DOUBLE,MPI_SUM,world); // MPI_SUM of local QEQ contributions
750 E_lambda += E_recip; // adding already all-reduced reciprocal part
751
752 return E_lambda;
753}
#define SQR(x)
Definition fix_hdnnp.cpp:44

References cflength, dEdQ, erfc_val, gammaSqrt2, hardness, kspacehdnnp, list, periodic, sigmaSqrtPi, and SQR.

Referenced by forceLambda_f_wrap(), and forceLambda_fdf().

Here is the caller graph for this function:

◆ forceLambda_df()

void PairHDNNP4G::forceLambda_df ( const gsl_vector * v,
gsl_vector * dEdLambda )
protected

Definition at line 762 of file pair_hdnnp_4g.cpp.

763{
764 int i,j,jmap;
765 int nlocal = atom->nlocal;
766 int nall = atom->natoms;
767 int *tag = atom->tag;
768 int *type = atom->type;
769
770 double **x = atom->x;
771 double val;
772 double grad;
773 double grad_sum,grad_sum_loc,grad_i;
774 double local_sum;
775
776 double eta;
777
778 if (periodic) eta = 1 / kspacehdnnp->g_ewald; // LAMMPS truncation
779
780 grad_sum = 0.0;
781 grad_sum_loc = 0.0;
782 if (periodic)
783 {
784 double sqrt2eta = (sqrt(2.0) * eta);
785 for (i = 0; i < nlocal; i++) // over local atoms
786 {
787 double const lambda_i = gsl_vector_get(v,tag[i]-1);
788
789 // Reciprocal space
790 double ksum = 0.0;
791 for (int k = 0; k < kspacehdnnp->kcount; k++) // over k-space
792 {
793 ksum += 2.0 * kspacehdnnp->kcoeff[k] *
794 (kspacehdnnp->sf_real[k] * kspacehdnnp->sfexp_rl[k][i] +
795 kspacehdnnp->sf_im[k] * kspacehdnnp->sfexp_im[k][i]);
796 }
797
798 // Real space
799 double jsum = 0.0;
800 for (int jj = 0; jj < list->numneigh[i]; ++jj) {
801 j = list->firstneigh[i][jj];
802 j &= NEIGHMASK;
803 double const lambda_j = gsl_vector_get(v, tag[j]-1);
804 //jmap = atom->map(tag[j]);
805 //double const dx = x[i][0] - x[j][0];
806 //double const dy = x[i][1] - x[j][1];
807 //double const dz = x[i][2] - x[j][2];
808 //double const rij = sqrt(SQR(dx) + SQR(dy) + SQR(dz)) * cflength;
809 //double erfcRij = (erfc(rij / sqrt2eta) - erfc(rij / gammaSqrt2[type[i]-1][type[jmap]-1]));
810 //jsum += lambda_j * erfcRij / rij;
811 jsum += lambda_j * erfc_val[i][jj];
812 }
813 grad = jsum + ksum + dEdQ[i] + hardness[type[i]-1]*lambda_i +
814 lambda_i * (1/(sigmaSqrtPi[type[i]-1])- 2/(eta * sqrt(2.0 * M_PI)));
815 grad_sum_loc += grad;
816 dEdLambda_loc[tag[i]-1] = grad; // fill gradient array based on tags instead of local IDs
817 }
818 }else
819 {
820 // first loop over local atoms
821 for (i = 0; i < nlocal; i++) { // TODO: indices
822 double const lambda_i = gsl_vector_get(v,i);
823 local_sum = 0.0;
824 // second loop over 'all' atoms
825 for (j = 0; j < nall; j++) {
826 if (j != i) {
827 double const lambda_j = gsl_vector_get(v, j);
828 double const dx = x[j][0] - x[i][0];
829 double const dy = x[j][1] - x[i][1];
830 double const dz = x[j][2] - x[i][2];
831 double const rij = sqrt(SQR(dx) + SQR(dy) + SQR(dz)) * cflength;
832 local_sum += lambda_j * erf(rij / gammaSqrt2[type[i]-1][type[j]-1]) / rij;
833 }
834 }
835 val = dEdQ[i] + hardness[type[i]-1]*lambda_i +
836 lambda_i/(sigmaSqrtPi[type[i]-1]) + local_sum;
837 grad_sum = grad_sum + val;
838 gsl_vector_set(dEdLambda,i,val);
839 }
840 }
841
842 MPI_Allreduce(dEdLambda_loc,dEdLambda_all,atom->natoms,MPI_DOUBLE,MPI_SUM,world);
843 MPI_Allreduce(&grad_sum_loc,&grad_sum,1,MPI_DOUBLE,MPI_SUM,world);
844
845 // Gradient projection //TODO: communication ?
846 for (i = 0; i < nall; i++){
847 grad_i = dEdLambda_all[i];
848 gsl_vector_set(dEdLambda,i,grad_i - (grad_sum)/nall);
849 }
850
851}

References cflength, dEdLambda_all, dEdLambda_loc, dEdQ, erfc_val, gammaSqrt2, hardness, kspacehdnnp, list, periodic, sigmaSqrtPi, and SQR.

Referenced by forceLambda_df_wrap(), and forceLambda_fdf().

Here is the caller graph for this function:

◆ forceLambda_fdf()

void PairHDNNP4G::forceLambda_fdf ( const gsl_vector * v,
double * f,
gsl_vector * df )
protected

Definition at line 860 of file pair_hdnnp_4g.cpp.

861{
862 *f = forceLambda_f(v);
863 forceLambda_df(v, df);
864}
void forceLambda_df(const gsl_vector *, gsl_vector *)
double forceLambda_f(const gsl_vector *)

References forceLambda_df(), and forceLambda_f().

Referenced by forceLambda_fdf_wrap().

Here is the call graph for this function:
Here is the caller graph for this function:

◆ forceLambda_f_wrap()

double PairHDNNP4G::forceLambda_f_wrap ( const gsl_vector * v,
void * params )
staticprotected

Definition at line 756 of file pair_hdnnp_4g.cpp.

757{
758 return static_cast<PairHDNNP4G*>(params)->forceLambda_f(v);
759}
PairHDNNP4G(class LAMMPS *)

References forceLambda_f(), and PairHDNNP4G().

Referenced by calculateForceLambda().

Here is the call graph for this function:
Here is the caller graph for this function:

◆ forceLambda_df_wrap()

void PairHDNNP4G::forceLambda_df_wrap ( const gsl_vector * v,
void * params,
gsl_vector * df )
staticprotected

Definition at line 854 of file pair_hdnnp_4g.cpp.

855{
856 static_cast<PairHDNNP4G*>(params)->forceLambda_df(v, df);
857}

References forceLambda_df(), and PairHDNNP4G().

Referenced by calculateForceLambda().

Here is the call graph for this function:
Here is the caller graph for this function:

◆ forceLambda_fdf_wrap()

void PairHDNNP4G::forceLambda_fdf_wrap ( const gsl_vector * v,
void * params,
double * f,
gsl_vector * df )
staticprotected

Definition at line 867 of file pair_hdnnp_4g.cpp.

868{
869 static_cast<PairHDNNP4G*>(params)->forceLambda_fdf(v, f, df);
870}
void forceLambda_fdf(const gsl_vector *, double *, gsl_vector *)

References forceLambda_fdf(), and PairHDNNP4G().

Referenced by calculateForceLambda().

Here is the call graph for this function:
Here is the caller graph for this function:

◆ calculateForceLambda()

void PairHDNNP4G::calculateForceLambda ( )
protected

Definition at line 873 of file pair_hdnnp_4g.cpp.

874{
875 size_t iter = 0;
876 int i,j;
877 int nsize,status;
878 int nlocal;
879
880 double psum_it;
881 double gradsum;
882 double lambda_i;
883
884 nsize = atom->natoms; // total number of atoms
885 nlocal = atom->nlocal; // total number of atoms
886
887 gsl_vector *x; // charge vector in our case
888
889 forceLambda_minimizer.n = nsize;
893 forceLambda_minimizer.params = this;
894
895 for (int i =0; i < atom->natoms; i++) {
896 dEdLambda_all[i] = 0.0;
897 dEdLambda_loc[i] = 0.0;
898 forceLambda_loc[i] = 0.0;
899 forceLambda_all[i] = 0.0;
900 }
901
902 // Communicate forceLambda
903 for (int i = 0; i < atom->nlocal; i++){
904 forceLambda_loc[atom->tag[i]-1] = forceLambda[i];
905 }
906 MPI_Allreduce(forceLambda_loc,forceLambda_all,atom->natoms,MPI_DOUBLE,MPI_SUM,world);
907
908
909 // TODO : check
910 x = gsl_vector_alloc(nsize);
911 for (i = 0; i < nsize; i++) {
912 gsl_vector_set(x,i,forceLambda_all[i]);
913 }
914
915 T = gsl_multimin_fdfminimizer_vector_bfgs2;
916 s = gsl_multimin_fdfminimizer_alloc(T, nsize);
917
918 gsl_multimin_fdfminimizer_set(s, &forceLambda_minimizer, x, step, min_tol); // TODO would tol = 0 be expensive ??
919 do
920 {
921 iter++;
922 psum_it = 0.0;
923 status = gsl_multimin_fdfminimizer_iterate(s);
924
925 // Projection
926 for(i = 0; i < nsize; i++) {
927 psum_it = psum_it + gsl_vector_get(s->x, i);
928 }
929 for(i = 0; i < nsize; i++) {
930 lambda_i = gsl_vector_get(s->x,i);
931 gsl_vector_set(s->x,i, lambda_i - psum_it/nsize); // projection
932 }
933
934 status = gsl_multimin_test_gradient(s->gradient, grad_tol);
935
936 //if (status == GSL_SUCCESS) printf ("Minimum forceLambda is found at iteration: %zu\n",iter);
937
938 }
939 while (status == GSL_CONTINUE && iter < maxit);
940
941 // Read charges before deallocating x
942 for (i = 0; i < nlocal; i++) {
943 forceLambda[i] = gsl_vector_get(s->x,atom->tag[i]-1);
944 }
945
946 gsl_multimin_fdfminimizer_free(s);
947 gsl_vector_free(x);
948}
static void forceLambda_df_wrap(const gsl_vector *, void *, gsl_vector *)
static void forceLambda_fdf_wrap(const gsl_vector *, void *, double *, gsl_vector *)
static double forceLambda_f_wrap(const gsl_vector *, void *)
gsl_multimin_function_fdf forceLambda_minimizer

References dEdLambda_all, dEdLambda_loc, forceLambda, forceLambda_all, forceLambda_df_wrap(), forceLambda_f_wrap(), forceLambda_fdf_wrap(), forceLambda_loc, forceLambda_minimizer, grad_tol, maxit, min_tol, s, step, and T.

Referenced by compute().

Here is the call graph for this function:
Here is the caller graph for this function:

◆ calculateElecDerivatives()

void PairHDNNP4G::calculateElecDerivatives ( double * dEelecdQ,
double ** f )
protected

Definition at line 1003 of file pair_hdnnp_4g.cpp.

1004{
1005 int i,j,jmap;
1006 int nlocal = atom->nlocal;
1007 int nall = atom->natoms;
1008 int *tag = atom->tag;
1009 int *type = atom->type;
1010
1011 double **x = atom->x;
1012 double *q = atom->q;
1013 double qi,qj;
1014 double dx,dy,dz;
1015 double rij,rij2,erfrij;
1016 double gams2;
1017 double sij,tij;
1018 double fsrij,dfsrij; // corrections due to screening
1019
1020 double eta;
1021
1022 if (periodic) eta = 1 / kspacehdnnp->g_ewald; // LAMMPS truncation (RuNNer truncation has been removed)
1023
1024 for (i = 0; i < nlocal; i++)
1025 {
1026 qi = q[i];
1027 if (periodic)
1028 {
1029 double sqrt2eta = (sqrt(2.0) * eta);
1030 double ksum = 0.0;
1031 for (j = 0; j < nall; j++)
1032 {
1033 double Aij = 0.0;
1034 qj = qall[j];
1035 dx = x[i][0] - xx[j];
1036 dy = x[i][1] - xy[j];
1037 dz = x[i][2] - xz[j];
1038 // Reciprocal part
1039 for (int k = 0; k < kspacehdnnp->kcount; k++) {
1040 double kdr = (dx * kspacehdnnp->kxvecs[k] * kspacehdnnp->unitk[0] +
1041 dy * kspacehdnnp->kyvecs[k] * kspacehdnnp->unitk[1] +
1042 dz * kspacehdnnp->kzvecs[k] * kspacehdnnp->unitk[2]) * cflength;
1043 if (dx != 0.0) Aij += 2.0 * kspacehdnnp->kcoeff[k] * cos(kdr);
1044 }
1045 dEelecdQ[i] += qj * Aij;
1046 //dEelecdQ[i] += qj * kcos[i][j];
1047 }
1048 // Add remaining k-space contributions here
1049 dEelecdQ[i] += qi * (kcoeff_sum - 2 / (sqrt2eta * sqrt(M_PI)));
1050
1051 // Real space
1052 for (int jj = 0; jj < list->numneigh[i]; ++jj) {
1053 j = list->firstneigh[i][jj];
1054 j &= NEIGHMASK;
1055 jmap = atom->map(tag[j]);
1056 qj = qall[tag[j]-1];
1057 dx = x[i][0] - x[j][0];
1058 dy = x[i][1] - x[j][1];
1059 dz = x[i][2] - x[j][2];
1060 rij2 = SQR(dx) + SQR(dy) + SQR(dz);
1061 rij = sqrt(rij2) * cflength;
1062
1063 gams2 = gammaSqrt2[type[i]-1][type[jmap]-1];
1064
1065 //double Aij = (erfc(rij / sqrt2eta) - erfc(rij / gams2)) / rij;
1066 double Aij = erfc_val[i][jj];
1067
1068 dEelecdQ[i] += qj * Aij; // Add Aij contribution regardless of screening
1069
1070 if (rij < screening_info[2])
1071 {
1072 erfrij = erf(rij / gams2);
1073 fsrij = screening_f(rij);
1074 dfsrij = screening_df(rij);
1075
1076 sij = erfrij * (fsrij - 1) / rij;
1077
1078 tij = (2 / (sqrt(M_PI)*gams2) * exp(- pow(rij / gams2,2)) *
1079 (fsrij - 1) + erfrij*dfsrij - erfrij*(fsrij-1)/rij) / rij2;
1080
1081 dEelecdQ[i] += qj * (sij); // Add sij contributions if inside screening cutoff
1082
1083 f[i][0] -= 0.5 * (qi * qj * dx * tij) / cfenergy;
1084 f[i][1] -= 0.5 * (qi * qj * dy * tij) / cfenergy;
1085 f[i][2] -= 0.5 * (qi * qj * dz * tij) / cfenergy;
1086
1087 f[j][0] += 0.5 * (qi * qj * dx * tij) / cfenergy;
1088 f[j][1] += 0.5 * (qi * qj * dy * tij) / cfenergy;
1089 f[j][2] += 0.5 * (qi * qj * dz * tij) / cfenergy;
1090 }
1091 }
1092 }else
1093 {
1094 for (j = 0; j < nall; j++)
1095 {
1096 // Retrieve position, type and charge from global arrays
1097 //TODO check
1098 dx = x[i][0] - xx[j];
1099 dy = x[i][1] - xy[j];
1100 dz = x[i][2] - xz[j];
1101 qj = qall[j];
1102 rij2 = SQR(dx) + SQR(dy) + SQR(dz);
1103 rij = sqrt(rij2) * cflength;
1104
1105 if (rij != 0.0)
1106 {
1107 gams2 = gammaSqrt2[type[i]-1][type_all[j]-1];
1108
1109 erfrij = erf(rij / gams2);
1110 fsrij = screening_f(rij);
1111 dfsrij = screening_df(rij);
1112
1113 sij = erfrij * (fsrij - 1) / rij;
1114 tij = (2 / (sqrt(M_PI)*gams2) * exp(- pow(rij / gams2,2)) *
1115 (fsrij - 1) + erfrij*dfsrij - erfrij*(fsrij-1)/rij) / rij2;
1116
1117 dEelecdQ[i] += qj * ((erfrij/rij) + sij);
1118 f[i][0] -= qi * qj * dx * tij;
1119 f[i][1] -= qi * qj * dy * tij;
1120 f[i][2] -= qi * qj * dz * tij;
1121 }
1122 }
1123 }
1124 }
1125 kcoeff_sum = 0.0; // re-initialize to 0.0 here
1126}

References cfenergy, cflength, erfc_val, gammaSqrt2, kcoeff_sum, kspacehdnnp, list, periodic, qall, screening_df(), screening_f(), screening_info, SQR, type_all, xx, xy, and xz.

Referenced by compute().

Here is the call graph for this function:
Here is the caller graph for this function:

◆ calculateElecForce()

void PairHDNNP4G::calculateElecForce ( double ** f)
protected

Definition at line 1130 of file pair_hdnnp_4g.cpp.

1131{
1132
1133 int i,j,k;
1134 int nlocal = atom->nlocal;
1135 int nall = atom->natoms;
1136 int *tag = atom->tag;
1137 int *type = atom->type;
1138
1139 double rij;
1140 double qi,qj,qk;
1141 double *q = atom->q;
1142 double **x = atom->x;
1143 double delr,gams2;
1144 double dx,dy,dz;
1145
1146 double eta;
1147
1148 if (periodic) eta = 1 / kspacehdnnp->g_ewald; // LAMMPS truncation
1149
1150 // lambda_i * dChidr contributions are added into the force vectors in n2p2
1151 interface.getForcesChi(forceLambda_all, atom->f);
1152
1153 for (i = 0; i < nlocal; i++) {
1154 qi = q[i];
1155 double lambdai = forceLambda[i];
1156 if (periodic) {
1157 double sqrt2eta = (sqrt(2.0) * eta);
1158 double dAdrx = 0.0;
1159 double dAdry = 0.0;
1160 double dAdrz = 0.0;
1161
1162 // Real space
1163 for (int jj = 0; jj < list->numneigh[i]; ++jj) {
1164 k = list->firstneigh[i][jj];
1165 k &= NEIGHMASK;
1166 int jmap = atom->map(tag[k]);
1167 qk = qall[tag[k]-1];
1168 double lambdak = forceLambda_all[tag[k]-1];
1169 dx = x[i][0] - x[k][0];
1170 dy = x[i][1] - x[k][1];
1171 dz = x[i][2] - x[k][2];
1172 double rij2 = SQR(dx) + SQR(dy) + SQR(dz);
1173 rij = sqrt(rij2) * cflength;
1174
1175 if (rij < kspacehdnnp->ewald_real_cutoff) {
1176 gams2 = gammaSqrt2[type[i]- 1][type[jmap]-1];
1177 //delr = (2 / sqrt(M_PI) * (-exp(-pow(rij / sqrt2eta, 2))
1178 // / sqrt2eta + exp(-pow(rij / gams2, 2)) / gams2)
1179 // - 1 / rij * (erfc(rij / sqrt2eta) - erfc(rij / gams2))) / rij2;
1180 delr = (2 / sqrt(M_PI) * (-exp(-pow(rij / sqrt2eta, 2))
1181 / sqrt2eta + exp(-pow(rij / gams2, 2)) / gams2)
1182 - erfc_val[i][jj]) / rij2;
1183 dAdrx = dx * delr;
1184 dAdry = dy * delr;
1185 dAdrz = dz * delr;
1186
1187 // Contributions to the local atom i
1188 f[i][0] -= 0.5 * (lambdai * qk + lambdak * qi) * dAdrx / cfenergy;
1189 f[i][1] -= 0.5 * (lambdai * qk + lambdak * qi) * dAdry / cfenergy;
1190 f[i][2] -= 0.5 * (lambdai * qk + lambdak * qi) * dAdrz / cfenergy;
1191
1192 // Contributions to the neighbors of the local atom i
1193 f[k][0] += 0.5 * (lambdai * qk + lambdak * qi) * dAdrx / cfenergy;
1194 f[k][1] += 0.5 * (lambdai * qk + lambdak * qi) * dAdry / cfenergy;
1195 f[k][2] += 0.5 * (lambdai * qk + lambdak * qi) * dAdrz / cfenergy;
1196
1197 // Contributions to the local atom i (pEelecpr)
1198 f[i][0] -= (0.5 * qk * dAdrx * qi) / cfenergy;
1199 f[i][1] -= (0.5 * qk * dAdry * qi) / cfenergy;
1200 f[i][2] -= (0.5 * qk * dAdrz * qi) / cfenergy;
1201
1202 f[k][0] += (0.5 * qk * dAdrx * qi) / cfenergy;
1203 f[k][1] += (0.5 * qk * dAdry * qi) / cfenergy;
1204 f[k][2] += (0.5 * qk * dAdrz * qi) / cfenergy;
1205 }
1206 }
1207 // Reciprocal space
1208 for (j = 0; j < nall; j++){
1209 qj = qall[j];
1210 double lambdaj = forceLambda_all[j];
1211 dx = x[i][0] - xx[j];
1212 dy = x[i][1] - xy[j];
1213 dz = x[i][2] - xz[j];
1214 double ksx = 0;
1215 double ksy = 0;
1216 double ksz = 0;
1217 for (int kk = 0; kk < kspacehdnnp->kcount; kk++) {
1218 double kx = kspacehdnnp->kxvecs[kk] * kspacehdnnp->unitk[0];
1219 double ky = kspacehdnnp->kyvecs[kk] * kspacehdnnp->unitk[1];
1220 double kz = kspacehdnnp->kzvecs[kk] * kspacehdnnp->unitk[2];
1221 double kdr = (dx * kx + dy * ky + dz * kz) * cflength;
1222 ksx -= 2.0 * kspacehdnnp->kcoeff[kk] * sin(kdr) * kx;
1223 ksy -= 2.0 * kspacehdnnp->kcoeff[kk] * sin(kdr) * ky;
1224 ksz -= 2.0 * kspacehdnnp->kcoeff[kk] * sin(kdr) * kz;
1225 }
1226 dAdrx = ksx;
1227 dAdry = ksy;
1228 dAdrz = ksz;
1229 //dAdrx = ksinx[i][j];
1230 //dAdry = ksiny[i][j];
1231 //dAdrz = ksinz[i][j];
1232
1233 // Contributions to the local atom i
1234 f[i][0] -= (lambdai * qj + lambdaj * qi) * dAdrx * (cflength/cfenergy);
1235 f[i][1] -= (lambdai * qj + lambdaj * qi) * dAdry * (cflength/cfenergy);
1236 f[i][2] -= (lambdai * qj + lambdaj * qi) * dAdrz * (cflength/cfenergy);
1237
1238 // pEelecpr
1239 f[i][0] -= (qj * dAdrx * qi) * (cflength/cfenergy);
1240 f[i][1] -= (qj * dAdry * qi) * (cflength/cfenergy);
1241 f[i][2] -= (qj * dAdrz * qi) * (cflength/cfenergy);
1242
1243 // Contributions to the neighbors of the local atom i
1244 /*f[k][0] += (lambdai * qj + lambdaj * qi) * dAdrx * (cflength/cfenergy);
1245 f[k][1] += (lambdai * qj + lambdaj * qi) * dAdry * (cflength/cfenergy);
1246 f[k][2] += (lambdai * qj + lambdaj * qi) * dAdrz * (cflength/cfenergy);*/
1247
1248 /*f[k][0] += (qj * dAdrx * qi) * (cflength/cfenergy);
1249 f[k][1] += (qj * dAdry * qi) * (cflength/cfenergy);
1250 f[k][2] += (qj * dAdrz * qi) * (cflength/cfenergy);*/
1251 }
1252 } else {
1253 // Over all atoms in the system
1254 for (j = 0; j < nall; j++) {
1255 double jt0 = 0;
1256 double jt1 = 0;
1257 double jt2 = 0;
1258 //qj = q[j];
1259 qj = qall[j];
1260 if (i == j) {
1261 // We have to loop over all atoms once again to calculate dAdrQ terms
1262 for (k = 0; k < nall; k++) {
1263 //qk = q[k];
1264 qk = qall[k];
1265 //dx = x[i][0] - x[k][0];
1266 dx = x[i][0] - xx[k];
1267 //dy = x[i][1] - x[k][1];
1268 dy = x[i][1] - xy[k];
1269 //dz = x[i][2] - x[k][2];
1270 dz = x[i][2] - xz[k];
1271 double rij2 = SQR(dx) + SQR(dy) + SQR(dz);
1272 rij = sqrt(rij2) * cflength;
1273
1274 if (rij != 0.0)
1275 {
1276 //gams2 = gammaSqrt2[type[i]-1][type[k]-1];
1277 gams2 = gammaSqrt2[type[i]-1][type_all[k]-1];
1278 delr = (2 / (sqrt(M_PI) * gams2) * exp(-pow(rij / gams2, 2)) - erf(rij / gams2) / rij);
1279
1280 jt0 += (dx / rij2) * delr * qk;
1281 jt1 += (dy / rij2) * delr * qk;
1282 jt2 += (dz / rij2) * delr * qk;
1283 }
1284 }
1285 } else {
1286 //TODO
1287 //dx = x[i][0] - x[j][0];
1288 dx = x[i][0] - xx[j];
1289 //dy = x[i][1] - x[j][1];
1290 dy = x[i][1] - xy[j];
1291 //dz = x[i][2] - x[j][2];
1292 dz = x[i][2] - xz[j];
1293 double rij2 = SQR(dx) + SQR(dy) + SQR(dz);
1294 rij = sqrt(rij2) * cflength;
1295
1296 //gams2 = gammaSqrt2[type[i]-1][type[j]-1];
1297 gams2 = gammaSqrt2[type[i]-1][type_all[j]-1];
1298 delr = (2 / (sqrt(M_PI) * gams2) * exp(-pow(rij / gams2, 2)) - erf(rij / gams2) / rij);
1299
1300 jt0 = (dx / rij2) * delr * qi;
1301 jt1 = (dy / rij2) * delr * qi;
1302 jt2 = (dz / rij2) * delr * qi;
1303 }
1304 f[i][0] -= (forceLambda_all[j] * (jt0) + 0.5 * qj * jt0) / cfenergy;
1305 f[i][1] -= (forceLambda_all[j] * (jt1) + 0.5 * qj * jt1) / cfenergy;
1306 f[i][2] -= (forceLambda_all[j] * (jt2) + 0.5 * qj * jt2) / cfenergy;
1307 }
1308 }
1309 }
1310}

References cfenergy, cflength, erfc_val, forceLambda, forceLambda_all, gammaSqrt2, interface, kspacehdnnp, list, periodic, qall, SQR, type_all, xx, xy, and xz.

Referenced by compute().

Here is the caller graph for this function:

◆ calculate_kspace_terms()

void PairHDNNP4G::calculate_kspace_terms ( )
protected

Definition at line 950 of file pair_hdnnp_4g.cpp.

951{
952 int i,j,k;
953 int nlocal = atom->nlocal;
954 int nall = atom->natoms;
955
956 double **x = atom->x;
957 double dx,dy,dz;
958 double kdum_cos,kdum_sinx,kdum_siny,kdum_sinz;
959
960 // This term is used in dEdQ calculation and can be calculated beforehand
961 for (k = 0; k < kspacehdnnp->kcount; k++)
962 {
963 kcoeff_sum += 2 * kspacehdnnp->kcoeff[k];
964 }
965
966 for (i = 0; i < nlocal; i++)
967 {
968 for (j = 0; j < nall; j++)
969 {
970 kdum_cos = 0.0;
971 kdum_sinx = 0.0;
972 kdum_siny = 0.0;
973 kdum_sinz = 0.0;
974
975 /*dx = x[i][0] - xx[j];
976 dy = x[i][1] - xy[j];
977 dz = x[i][2] - xz[j];
978
979 for (int k = 0; k < kspacehdnnp->kcount; k++) {
980 double kx = kspacehdnnp->kxvecs[k] * kspacehdnnp->unitk[0];
981 double ky = kspacehdnnp->kyvecs[k] * kspacehdnnp->unitk[1];
982 double kz = kspacehdnnp->kzvecs[k] * kspacehdnnp->unitk[2];
983 double kdr = (dx * kx + dy * ky + dz * kz) * cflength;
984
985 // Cos term
986 if (dx != 0.0) kdum_cos += 2.0 * kspacehdnnp->kcoeff[k] * cos(kdr);
987
988 // Sin terms
989 double sinkdr = sin(kdr);
990 kdum_sinx -= 2.0 * kspacehdnnp->kcoeff[k] * sinkdr * kx;
991 kdum_siny -= 2.0 * kspacehdnnp->kcoeff[k] * sinkdr * ky;
992 kdum_sinz -= 2.0 * kspacehdnnp->kcoeff[k] * sinkdr * kz;
993 }
994 kcos[i][j] = kdum_cos;
995 ksinx[i][j] = kdum_sinx;
996 ksiny[i][j] = kdum_siny;
997 ksinz[i][j] = kdum_sinz;*/
998 }
999 }
1000}

References kcoeff_sum, and kspacehdnnp.

Referenced by compute().

Here is the caller graph for this function:

◆ screening_f()

double PairHDNNP4G::screening_f ( double r)
protected

Definition at line 1314 of file pair_hdnnp_4g.cpp.

1315{
1316 double x;
1317
1318 if (r >= screening_info[2]) return 1.0;
1319 else if (r <= screening_info[1]) return 0.0;
1320 else
1321 {
1322 x = (r-screening_info[1])*screening_info[3];
1323 return 1.0 - 0.5*(cos(M_PI*x)+1);
1324 }
1325}

References screening_info.

Referenced by calculateElecDerivatives().

Here is the caller graph for this function:

◆ screening_df()

double PairHDNNP4G::screening_df ( double r)
protected

Definition at line 1329 of file pair_hdnnp_4g.cpp.

1329 {
1330
1331 double x;
1332
1333 if (r >= screening_info[2] || r <= screening_info[1]) return 0.0;
1334 else {
1335 x = (r - screening_info[1]) * screening_info[3];
1336 return -screening_info[3] * (-M_PI_2 * sin(M_PI * x));
1337 }
1338}

References screening_info.

Referenced by calculateElecDerivatives().

Here is the caller graph for this function:

Friends And Related Symbol Documentation

◆ FixHDNNP

friend class FixHDNNP
friend

Definition at line 38 of file pair_hdnnp_4g.h.

References FixHDNNP.

Referenced by FixHDNNP.

◆ KSpaceHDNNP

friend class KSpaceHDNNP
friend

Definition at line 39 of file pair_hdnnp_4g.h.

References KSpaceHDNNP.

Referenced by compute(), and KSpaceHDNNP.

Member Data Documentation

◆ kspacehdnnp

class KSpaceHDNNP* LAMMPS_NS::PairHDNNP4G::kspacehdnnp
protected

◆ me

int LAMMPS_NS::PairHDNNP4G::me
protected

Definition at line 60 of file pair_hdnnp_4g.h.

Referenced by PairHDNNP4G().

◆ nprocs

int LAMMPS_NS::PairHDNNP4G::nprocs
protected

Definition at line 60 of file pair_hdnnp_4g.h.

Referenced by PairHDNNP4G().

◆ periodic

bool LAMMPS_NS::PairHDNNP4G::periodic
protected

◆ showew

bool LAMMPS_NS::PairHDNNP4G::showew
protected

◆ resetew

bool LAMMPS_NS::PairHDNNP4G::resetew
protected

Definition at line 63 of file pair_hdnnp_4g.h.

Referenced by handleExtrapolationWarnings(), init_style(), PairHDNNP4G(), and settings().

◆ showewsum

int LAMMPS_NS::PairHDNNP4G::showewsum
protected

◆ maxew

int LAMMPS_NS::PairHDNNP4G::maxew
protected

◆ numExtrapolationWarningsTotal

long LAMMPS_NS::PairHDNNP4G::numExtrapolationWarningsTotal
protected

Definition at line 66 of file pair_hdnnp_4g.h.

Referenced by handleExtrapolationWarnings(), PairHDNNP4G(), and settings().

◆ numExtrapolationWarningsSummary

long LAMMPS_NS::PairHDNNP4G::numExtrapolationWarningsSummary
protected

Definition at line 67 of file pair_hdnnp_4g.h.

Referenced by handleExtrapolationWarnings(), PairHDNNP4G(), and settings().

◆ cflength

double LAMMPS_NS::PairHDNNP4G::cflength
protected

◆ cfenergy

double LAMMPS_NS::PairHDNNP4G::cfenergy
protected

◆ maxCutoffRadius

double LAMMPS_NS::PairHDNNP4G::maxCutoffRadius
protected

Definition at line 70 of file pair_hdnnp_4g.h.

Referenced by coeff(), init_one(), init_style(), PairHDNNP4G(), and transferNeighborList().

◆ directory

char* LAMMPS_NS::PairHDNNP4G::directory
protected

Definition at line 71 of file pair_hdnnp_4g.h.

Referenced by init_style(), PairHDNNP4G(), and settings().

◆ emap

char* LAMMPS_NS::PairHDNNP4G::emap
protected

Definition at line 72 of file pair_hdnnp_4g.h.

Referenced by init_style(), PairHDNNP4G(), and settings().

◆ list

class NeighList* LAMMPS_NS::PairHDNNP4G::list
protected

◆ interface

nnp::InterfaceLammps LAMMPS_NS::PairHDNNP4G::interface
protected

◆ chi

double* LAMMPS_NS::PairHDNNP4G::chi
protected

Definition at line 77 of file pair_hdnnp_4g.h.

Referenced by PairHDNNP4G().

◆ hardness

double * LAMMPS_NS::PairHDNNP4G::hardness
protected

Definition at line 77 of file pair_hdnnp_4g.h.

Referenced by forceLambda_df(), forceLambda_f(), and PairHDNNP4G().

◆ sigmaSqrtPi

double * LAMMPS_NS::PairHDNNP4G::sigmaSqrtPi
protected

Definition at line 77 of file pair_hdnnp_4g.h.

Referenced by forceLambda_df(), forceLambda_f(), and PairHDNNP4G().

◆ gammaSqrt2

double ** LAMMPS_NS::PairHDNNP4G::gammaSqrt2
protected

◆ dEdQ

double* LAMMPS_NS::PairHDNNP4G::dEdQ
protected

Definition at line 78 of file pair_hdnnp_4g.h.

Referenced by allocate(), compute(), forceLambda_df(), forceLambda_f(), and PairHDNNP4G().

◆ forceLambda

double * LAMMPS_NS::PairHDNNP4G::forceLambda
protected

◆ grad_tol

double LAMMPS_NS::PairHDNNP4G::grad_tol
protected

Definition at line 79 of file pair_hdnnp_4g.h.

Referenced by calculateForceLambda(), and PairHDNNP4G().

◆ min_tol

double LAMMPS_NS::PairHDNNP4G::min_tol
protected

Definition at line 79 of file pair_hdnnp_4g.h.

Referenced by calculateForceLambda(), and PairHDNNP4G().

◆ step

double LAMMPS_NS::PairHDNNP4G::step
protected

Definition at line 79 of file pair_hdnnp_4g.h.

Referenced by calculateForceLambda(), and PairHDNNP4G().

◆ maxit

int LAMMPS_NS::PairHDNNP4G::maxit
protected

Definition at line 80 of file pair_hdnnp_4g.h.

Referenced by calculateForceLambda(), and PairHDNNP4G().

◆ minim_init_style

int LAMMPS_NS::PairHDNNP4G::minim_init_style
protected

Definition at line 81 of file pair_hdnnp_4g.h.

Referenced by PairHDNNP4G().

◆ T

const gsl_multimin_fdfminimizer_type* LAMMPS_NS::PairHDNNP4G::T
protected

Definition at line 93 of file pair_hdnnp_4g.h.

Referenced by calculateForceLambda(), and PairHDNNP4G().

◆ s

gsl_multimin_fdfminimizer* LAMMPS_NS::PairHDNNP4G::s
protected

Definition at line 94 of file pair_hdnnp_4g.h.

Referenced by calculateForceLambda(), and PairHDNNP4G().

◆ forceLambda_minimizer

gsl_multimin_function_fdf LAMMPS_NS::PairHDNNP4G::forceLambda_minimizer
protected

Definition at line 96 of file pair_hdnnp_4g.h.

Referenced by calculateForceLambda().

◆ E_elec

double LAMMPS_NS::PairHDNNP4G::E_elec
protected

Definition at line 105 of file pair_hdnnp_4g.h.

Referenced by compute(), and PairHDNNP4G().

◆ kcoeff_sum

double LAMMPS_NS::PairHDNNP4G::kcoeff_sum
protected

Definition at line 106 of file pair_hdnnp_4g.h.

Referenced by calculate_kspace_terms(), calculateElecDerivatives(), and PairHDNNP4G().

◆ nmax

int LAMMPS_NS::PairHDNNP4G::nmax
protected

Definition at line 108 of file pair_hdnnp_4g.h.

◆ type_all

int* LAMMPS_NS::PairHDNNP4G::type_all
protected

◆ type_loc

int * LAMMPS_NS::PairHDNNP4G::type_loc
protected

Definition at line 110 of file pair_hdnnp_4g.h.

Referenced by allocate(), compute(), and PairHDNNP4G().

◆ dEdLambda_loc

double* LAMMPS_NS::PairHDNNP4G::dEdLambda_loc
protected

Definition at line 111 of file pair_hdnnp_4g.h.

Referenced by allocate(), calculateForceLambda(), compute(), forceLambda_df(), and PairHDNNP4G().

◆ dEdLambda_all

double * LAMMPS_NS::PairHDNNP4G::dEdLambda_all
protected

Definition at line 111 of file pair_hdnnp_4g.h.

Referenced by allocate(), calculateForceLambda(), compute(), forceLambda_df(), and PairHDNNP4G().

◆ qall_loc

double* LAMMPS_NS::PairHDNNP4G::qall_loc
protected

Definition at line 112 of file pair_hdnnp_4g.h.

Referenced by allocate(), compute(), and PairHDNNP4G().

◆ qall

double * LAMMPS_NS::PairHDNNP4G::qall
protected

◆ xx

double* LAMMPS_NS::PairHDNNP4G::xx
protected

◆ xy

double * LAMMPS_NS::PairHDNNP4G::xy
protected

◆ xz

double * LAMMPS_NS::PairHDNNP4G::xz
protected

◆ xx_loc

double* LAMMPS_NS::PairHDNNP4G::xx_loc
protected

Definition at line 114 of file pair_hdnnp_4g.h.

Referenced by allocate(), compute(), and PairHDNNP4G().

◆ xy_loc

double * LAMMPS_NS::PairHDNNP4G::xy_loc
protected

Definition at line 114 of file pair_hdnnp_4g.h.

Referenced by allocate(), compute(), and PairHDNNP4G().

◆ xz_loc

double * LAMMPS_NS::PairHDNNP4G::xz_loc
protected

Definition at line 114 of file pair_hdnnp_4g.h.

Referenced by allocate(), compute(), and PairHDNNP4G().

◆ forceLambda_loc

double* LAMMPS_NS::PairHDNNP4G::forceLambda_loc
protected

Definition at line 115 of file pair_hdnnp_4g.h.

Referenced by allocate(), calculateForceLambda(), compute(), and PairHDNNP4G().

◆ forceLambda_all

double * LAMMPS_NS::PairHDNNP4G::forceLambda_all
protected

◆ erfc_val

double** LAMMPS_NS::PairHDNNP4G::erfc_val
protected

◆ kcos

double** LAMMPS_NS::PairHDNNP4G::kcos
protected

Definition at line 118 of file pair_hdnnp_4g.h.

Referenced by PairHDNNP4G().

◆ ksinx

double ** LAMMPS_NS::PairHDNNP4G::ksinx
protected

Definition at line 118 of file pair_hdnnp_4g.h.

Referenced by PairHDNNP4G().

◆ ksiny

double ** LAMMPS_NS::PairHDNNP4G::ksiny
protected

Definition at line 118 of file pair_hdnnp_4g.h.

Referenced by PairHDNNP4G().

◆ ksinz

double ** LAMMPS_NS::PairHDNNP4G::ksinz
protected

Definition at line 118 of file pair_hdnnp_4g.h.

Referenced by PairHDNNP4G().

◆ screening_info

double* LAMMPS_NS::PairHDNNP4G::screening_info
protected

Definition at line 127 of file pair_hdnnp_4g.h.

Referenced by calculateElecDerivatives(), PairHDNNP4G(), screening_df(), and screening_f().


The documentation for this class was generated from the following files: