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

#include <fix_hdnnp.h>

Inheritance diagram for LAMMPS_NS::FixHDNNP:
Collaboration diagram for LAMMPS_NS::FixHDNNP:

Public Member Functions

 FixHDNNP (class LAMMPS *, int, char **)
 
 ~FixHDNNP ()
 
int setmask ()
 
virtual void post_constructor ()
 
virtual void init ()
 
void init_list (int, class NeighList *)
 
void setup_pre_force (int)
 
virtual void pre_force (int)
 
void min_setup_pre_force (int)
 
void min_pre_force (int)
 

Protected Member Functions

virtual void pertype_parameters (char *)
 
void isPeriodic ()
 
void calculate_electronegativities ()
 
void process_first_network ()
 
void allocate_QEq ()
 
void deallocate_QEq ()
 
double QEq_f (const gsl_vector *)
 
void QEq_df (const gsl_vector *, gsl_vector *)
 
void QEq_fdf (const gsl_vector *, double *, gsl_vector *)
 
void calculate_QEqCharges ()
 
void calculate_erfc_terms ()
 

Static Protected Member Functions

static double QEq_f_wrap (const gsl_vector *, void *)
 
static void QEq_df_wrap (const gsl_vector *, void *, gsl_vector *)
 
static void QEq_fdf_wrap (const gsl_vector *, void *, double *, gsl_vector *)
 

Protected Attributes

class PairHDNNP4Ghdnnp
 
class KSpaceHDNNPkspacehdnnp
 
class NeighList * list
 
char * pertype_option
 
int hdnnpflag
 
int kspaceflag
 
int ngroup
 
bool periodic
 
double qRef
 
double * Q
 
gsl_multimin_function_fdf QEq_minimizer
 QEq energy minimization via gsl library.
 
const gsl_multimin_fdfminimizer_type * T
 
gsl_multimin_fdfminimizer * s
 
int * type_all
 Global storage.
 
int * type_loc
 
double * qall
 
double * qall_loc
 
double * dEdQ_all
 
double * dEdQ_loc
 
double * xx
 
double * xy
 
double * xz
 
double * xx_loc
 
double * xy_loc
 
double * xz_loc
 

Friends

class PairHDNNP4G
 

Detailed Description

Definition at line 29 of file fix_hdnnp.h.

Constructor & Destructor Documentation

◆ FixHDNNP()

FixHDNNP::FixHDNNP ( class LAMMPS * lmp,
int narg,
char ** arg )

Definition at line 52 of file fix_hdnnp.cpp.

52 :
53 Fix(lmp, narg, arg),
54 hdnnp (nullptr),
55 kspacehdnnp (nullptr),
56 list (nullptr),
57 pertype_option(nullptr),
58 hdnnpflag (0 ),
59 kspaceflag (0 ),
60 ngroup (0 ),
61 periodic (false ),
62 qRef (0.0 ),
63 Q (nullptr),
64 type_all (nullptr),
65 type_loc (nullptr),
66 qall (nullptr),
67 qall_loc (nullptr),
68 dEdQ_all (nullptr),
69 dEdQ_loc (nullptr),
70 xx (nullptr),
71 xy (nullptr),
72 xz (nullptr),
73 xx_loc (nullptr),
74 xy_loc (nullptr),
75 xz_loc (nullptr)
76
77{
78 if (narg<9 || narg>11) error->all(FLERR,"Illegal fix hdnnp command");
79
80 nevery = utils::inumeric(FLERR,arg[3],false,lmp);
81 if (nevery <= 0) error->all(FLERR,"Illegal fix hdnnp command");
82
83 int len = strlen(arg[8]) + 1;
84 pertype_option = new char[len];
85 strcpy(pertype_option,arg[8]);
86
87 hdnnp = nullptr;
88 kspacehdnnp = nullptr;
89 hdnnp = (PairHDNNP4G *) force->pair_match("^hdnnp/4g",0);
90 kspacehdnnp = (KSpaceHDNNP *) force->kspace_match("^hdnnp",0);
91
92 hdnnp->chi = nullptr;
93 hdnnp->hardness = nullptr;
94 hdnnp->sigmaSqrtPi = nullptr;
95 hdnnp->gammaSqrt2 = nullptr;
96 hdnnp->screening_info = nullptr;
97
98 // User-defined minimization parameters used in pair_hdnnp as well
99 // TODO: read only on proc 0 and then Bcast ?
100 hdnnp->grad_tol = utils::numeric(FLERR,arg[4],false,lmp); //tolerance for gradient check
101 hdnnp->min_tol = utils::numeric(FLERR,arg[5],false,lmp); //tolerance
102 hdnnp->step = utils::numeric(FLERR,arg[6],false,lmp); //initial hdnnp->step size
103 hdnnp->maxit = utils::inumeric(FLERR,arg[7],false,lmp); //maximum number of iterations
104 hdnnp->minim_init_style = utils::inumeric(FLERR,arg[10],false,lmp); //initialization style
105
106 // TODO: check these initializations and allocations
107 int natoms = atom->natoms;
108
109 // TODO: these are not necessary in case of periodic systems
110 memory->create(xx,atom->natoms,"fix_hdnnp:xx");
111 memory->create(xy,atom->natoms,"fix_hdnnp:xy");
112 memory->create(xz,atom->natoms,"fix_hdnnp:xz");
113 memory->create(xx_loc,atom->natoms,"fix_hdnnp:xx_loc");
114 memory->create(xy_loc,atom->natoms,"fix_hdnnp:xy_loc");
115 memory->create(xz_loc,atom->natoms,"fix_hdnnp:xz_loc");
116 memory->create(type_loc,atom->natoms,"fix_hdnnp:type_loc");
117 memory->create(type_all,atom->natoms,"fix_hdnnp:type_all");
118
119}
class PairHDNNP4G * hdnnp
Definition fix_hdnnp.h:47
friend class PairHDNNP4G
Definition fix_hdnnp.h:30
int * type_all
Global storage.
Definition fix_hdnnp.h:87
class NeighList * list
Definition fix_hdnnp.h:49
class KSpaceHDNNP * kspacehdnnp
Definition fix_hdnnp.h:48

References dEdQ_all, dEdQ_loc, hdnnp, hdnnpflag, kspaceflag, kspacehdnnp, list, ngroup, PairHDNNP4G, periodic, pertype_option, Q, qall, qall_loc, qRef, type_all, type_loc, xx, xx_loc, xy, xy_loc, xz, and xz_loc.

Referenced by QEq_df_wrap(), QEq_f_wrap(), and QEq_fdf_wrap().

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

◆ ~FixHDNNP()

FixHDNNP::~FixHDNNP ( )

Definition at line 123 of file fix_hdnnp.cpp.

124{
125 if (copymode) return;
126
127 delete[] pertype_option;
128
129 memory->destroy(hdnnp->chi);
130 memory->destroy(hdnnp->hardness);
131 memory->destroy(hdnnp->sigmaSqrtPi);
132 memory->destroy(hdnnp->gammaSqrt2);
133
134 memory->destroy(qall);
135 memory->destroy(qall_loc);
136 memory->destroy(dEdQ_loc);
137 memory->destroy(dEdQ_all);
138
139 memory->destroy(xx);
140 memory->destroy(xy);
141 memory->destroy(xz);
142 memory->destroy(xx_loc);
143 memory->destroy(xy_loc);
144 memory->destroy(xz_loc);
145 memory->destroy(type_loc);
146 memory->destroy(type_all);
147
148}

References dEdQ_all, dEdQ_loc, hdnnp, pertype_option, qall, qall_loc, type_all, type_loc, xx, xx_loc, xy, xy_loc, xz, and xz_loc.

Member Function Documentation

◆ setmask()

int FixHDNNP::setmask ( )

Definition at line 156 of file fix_hdnnp.cpp.

157{
158 int mask = 0;
159 mask |= PRE_FORCE;
160 mask |= PRE_FORCE_RESPA;
161 mask |= MIN_PRE_FORCE;
162 return mask;
163}

◆ post_constructor()

void FixHDNNP::post_constructor ( )
virtual

Definition at line 150 of file fix_hdnnp.cpp.

151{
153
154}
virtual void pertype_parameters(char *)

References pertype_option, and pertype_parameters().

Here is the call graph for this function:

◆ init()

void FixHDNNP::init ( )
virtual

Definition at line 165 of file fix_hdnnp.cpp.

166{
167 if (!atom->q_flag)
168 error->all(FLERR,"Fix hdnnp requires atom attribute q");
169
170 ngroup = group->count(igroup);
171 if (ngroup == 0) error->all(FLERR,"Fix hdnnp group has no atoms");
172
173 // need a half neighbor list w/ Newton off and ghost neighbors
174 // built whenever re-neighboring occurs
175
176 //int irequest = neighbor->request(this,instance_me);
177 //neighbor->requests[irequest]->pair = 0;
178 //neighbor->requests[irequest]->fix = 1;
179 //neighbor->requests[irequest]->newton = 2;
180 //neighbor->requests[irequest]->ghost = 1;
181
182 isPeriodic();
183
184 //if (periodic) neighbor->add_request(this, NeighConst::REQ_DEFAULT);
185 //else neighbor->add_request(this, NeighConst::REQ_FULL);
186 neighbor->add_request(this, NeighConst::REQ_FULL |
187 NeighConst::REQ_GHOST |
188 NeighConst::REQ_NEWTON_OFF);
189
190 // TODO : do we really need a full NL in periodic cases ?
191 //if (periodic) { // periodic : full neighborlist
192 // neighbor->requests[irequest]->half = 0;
193 // neighbor->requests[irequest]->full = 1;
194 //}
195
196 allocate_QEq();
197}

References allocate_QEq(), isPeriodic(), and ngroup.

Here is the call graph for this function:

◆ init_list()

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

Definition at line 253 of file fix_hdnnp.cpp.

254{
255 list = ptr;
256}

References list.

◆ setup_pre_force()

void FixHDNNP::setup_pre_force ( int vflag)

Definition at line 258 of file fix_hdnnp.cpp.

259{
260 pre_force(vflag);
261}
virtual void pre_force(int)

References pre_force().

Referenced by min_setup_pre_force().

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

◆ pre_force()

void FixHDNNP::pre_force ( int )
virtual

Definition at line 274 of file fix_hdnnp.cpp.

274 {
275
276 double *q = atom->q;
277 double Qtot_loc = 0.0;
278 int n = atom->nlocal;
279 int j,jmap;
280
281 //deallocate_QEq();
282 //allocate_QEq();
283
284 if(periodic) {
285 //force->kspace->setup();
286 kspacehdnnp->ewald_sfexp();
287 }
288
289 // Calculate atomic electronegativities \Chi_i
291
292 // Calculate the current total charge
293 for (int i = 0; i < n; i++) {
294 //std::cout << q[i] << '\n';
295 Qtot_loc += q[i];
296 }
297 MPI_Allreduce(&Qtot_loc,&qRef,1,MPI_DOUBLE,MPI_SUM,world);
298
299 //TODO
301
302 std::chrono::steady_clock::time_point begin = std::chrono::steady_clock::now();
303 // Minimize QEq energy and calculate atomic charges
305 std::chrono::steady_clock::time_point end = std::chrono::steady_clock::now();
306 //std::cout << "iQEq time (s) = " << std::chrono::duration_cast<std::chrono::microseconds>(end - begin).count() / 1000000.0 << std::endl;
307
308}
void calculate_electronegativities()

References calculate_electronegativities(), calculate_erfc_terms(), calculate_QEqCharges(), kspacehdnnp, periodic, and qRef.

Referenced by min_pre_force(), and setup_pre_force().

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

◆ min_setup_pre_force()

void FixHDNNP::min_setup_pre_force ( int vflag)

Definition at line 263 of file fix_hdnnp.cpp.

264{
265 setup_pre_force(vflag);
266}
void setup_pre_force(int)

References setup_pre_force().

Here is the call graph for this function:

◆ min_pre_force()

void FixHDNNP::min_pre_force ( int vflag)

Definition at line 268 of file fix_hdnnp.cpp.

269{
270 pre_force(vflag);
271}

References pre_force().

Here is the call graph for this function:

◆ pertype_parameters()

void FixHDNNP::pertype_parameters ( char * arg)
protectedvirtual

Definition at line 199 of file fix_hdnnp.cpp.

200{
201 if (strcmp(arg,"hdnnp") == 0) {
202 hdnnpflag = 1;
203 Pair *pair = force->pair_match("hdnnp",0);
204 if (pair == NULL) error->all(FLERR,"No pair hdnnp for fix hdnnp");
205 }
206}

References hdnnpflag.

Referenced by post_constructor().

Here is the caller graph for this function:

◆ isPeriodic()

void FixHDNNP::isPeriodic ( )
protected

Definition at line 775 of file fix_hdnnp.cpp.

776{
777 if (domain->nonperiodic == 0) periodic = true;
778 else periodic = false;
779}

References periodic.

Referenced by init().

Here is the caller graph for this function:

◆ calculate_electronegativities()

void FixHDNNP::calculate_electronegativities ( )
protected

Definition at line 310 of file fix_hdnnp.cpp.

311{
312 // Run first set of atomic NNs
314
315 // Read QEq arrays from n2p2 into LAMMPS
316 hdnnp->interface.getQEqParams(hdnnp->chi,hdnnp->hardness,hdnnp->sigmaSqrtPi,hdnnp->gammaSqrt2,qRef);
317
318 // Read screening function information from n2p2 into LAMMPS
319 hdnnp->interface.getScreeningInfo(hdnnp->screening_info); //TODO: read function type
320}

References hdnnp, process_first_network(), and qRef.

Referenced by pre_force().

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

◆ process_first_network()

void FixHDNNP::process_first_network ( )
protected

Definition at line 323 of file fix_hdnnp.cpp.

324{
325 if(hdnnp->interface.getNnpType() == InterfaceLammps::NNPType::HDNNP_4G)
326 {
327 // Set number of local atoms and add element.
328 hdnnp->interface.setLocalAtoms(atom->nlocal,atom->type);
329
330 // Set tags of local atoms.
331 hdnnp->interface.setLocalTags(atom->tag);
332
333 // Transfer local neighbor list to HDNNP interface.
334 hdnnp->transferNeighborList();
335
336 // Run the first NN for electronegativities
337 hdnnp->interface.process();
338 }
339 else{ //TODO
340 error->all(FLERR,"This fix style can only be used with a 4G-HDNNP.");
341 }
342}

References hdnnp, and nnp::Mode::HDNNP_4G.

Referenced by calculate_electronegativities().

Here is the caller graph for this function:

◆ allocate_QEq()

void FixHDNNP::allocate_QEq ( )
protected

Definition at line 209 of file fix_hdnnp.cpp.

210{
211 int ne = atom->ntypes;
212 memory->create(hdnnp->chi,atom->natoms,"qeq:hdnnp->chi");
213 memory->create(hdnnp->hardness,ne,"qeq:hdnnp->hardness");
214 memory->create(hdnnp->sigmaSqrtPi,ne,"qeq:hdnnp->sigmaSqrtPi");
215 memory->create(hdnnp->gammaSqrt2,ne,ne,"qeq:hdnnp->gammaSqrt2");
216 memory->create(hdnnp->screening_info,4,"qeq:screening");
217 memory->create(qall,atom->natoms,"qeq:qall");
218 memory->create(qall_loc,atom->natoms,"qeq:qall_loc");
219 memory->create(dEdQ_loc,atom->natoms,"qeq:dEdQ_loc");
220 memory->create(dEdQ_all,atom->natoms,"qeq:dEdQ_all");
221
222 // Initialization
223 for (int i =0; i < atom->natoms; i++){
224 hdnnp->chi[i] = 0.0;
225 }
226 for (int i = 0; i < ne; i++){
227 hdnnp->hardness[i] = 0.0;
228 hdnnp->sigmaSqrtPi[i] = 0.0;
229 for (int j = 0; j < ne; j++){
230 hdnnp->gammaSqrt2[i][j] = 0.0;
231 }
232 }
233 for (int i = 0; i < 4; i++){
234 hdnnp->screening_info[i] = 0.0;
235 }
236}

References dEdQ_all, dEdQ_loc, hdnnp, qall, and qall_loc.

Referenced by init().

Here is the caller graph for this function:

◆ deallocate_QEq()

void FixHDNNP::deallocate_QEq ( )
protected

Definition at line 239 of file fix_hdnnp.cpp.

239 {
240
241 memory->destroy(hdnnp->chi);
242 memory->destroy(hdnnp->hardness);
243 memory->destroy(hdnnp->sigmaSqrtPi);
244 memory->destroy(hdnnp->gammaSqrt2);
245 memory->destroy(hdnnp->screening_info);
246 memory->destroy(qall);
247 memory->destroy(qall_loc);
248 memory->destroy(dEdQ_loc);
249 memory->destroy(dEdQ_all);
250
251}

References dEdQ_all, dEdQ_loc, hdnnp, qall, and qall_loc.

◆ QEq_f()

double FixHDNNP::QEq_f ( const gsl_vector * v)
protected

Definition at line 393 of file fix_hdnnp.cpp.

394{
395 int i,j,jmap;
396 int *tag = atom->tag;
397 int *type = atom->type;
398 int nlocal = atom->nlocal;
399 int nall = atom->natoms;
400
401 double **x = atom->x;
402 double *q = atom->q;
403
404 double E_qeq_loc,E_qeq;
405 double E_elec_loc,E_scr_loc,E_scr;
406 double E_real,E_recip,E_self; // for periodic examples
407 double iiterm,ijterm;
408
409 double eta;
410
411 if(periodic) eta = 1 / kspacehdnnp->g_ewald; // LAMMPS truncation
412
413 E_qeq = 0.0;
414 E_qeq_loc = 0.0;
415 E_scr = 0.0;
416 E_scr_loc = 0.0;
417 hdnnp->E_elec = 0.0;
418
419 if (periodic)
420 {
421 double sqrt2eta = (sqrt(2.0) * eta);
422 E_recip = 0.0;
423 E_real = 0.0;
424 E_self = 0.0;
425 for (i = 0; i < nlocal; i++) // over local atoms
426 {
427 double const qi = gsl_vector_get(v, tag[i]-1);
428 double qi2 = qi * qi;
429 // Self term
430 E_self += qi2 * (1 / (2.0 * hdnnp->sigmaSqrtPi[type[i]-1]) - 1 / (sqrt(2.0 * M_PI) * eta));
431 E_qeq_loc += hdnnp->chi[i] * qi + 0.5 * hdnnp->hardness[type[i]-1] * qi2;
432 E_scr -= qi2 / (2.0 * hdnnp->sigmaSqrtPi[type[i]-1]); // self screening term TODO:parallel ?
433 // Real Term
434 // TODO: we loop over the full neighbor list, could this be optimized ?
435 for (int jj = 0; jj < list->numneigh[i]; ++jj) {
436 j = list->firstneigh[i][jj];
437 j &= NEIGHMASK;
438 jmap = atom->map(tag[j]);
439 double const qj = gsl_vector_get(v, tag[j]-1); // mapping based on tags
440 double const dx = x[i][0] - x[j][0];
441 double const dy = x[i][1] - x[j][1];
442 double const dz = x[i][2] - x[j][2];
443 double const rij = sqrt(SQR(dx) + SQR(dy) + SQR(dz)) * hdnnp->cflength;
444 //double erfcRij = (erfc(rij / sqrt2eta) - erfc(rij / hdnnp->gammaSqrt2[type[i]-1][type[jmap]-1])) / rij;
445 //double real = 0.5 * qi * qj * erfcRij;
446 double real = 0.5 * qi * qj * hdnnp->erfc_val[i][jj];
447 E_real += real;
448 if (rij <= hdnnp->screening_info[2]) {
449 E_scr += 0.5 * qi * qj *
450 erf(rij/hdnnp->gammaSqrt2[type[i]-1][type[jmap]-1])*(hdnnp->screening_f(rij) - 1) / rij;
451 }
452 }
453 }
454 // Reciprocal Term
455 if (kspacehdnnp->ewaldflag) // Ewald Sum
456 {
457 // Calls the charge equilibration energy calculation routine in the KSpace base class
458 // Returns reciprocal energy
459 E_recip = kspacehdnnp->compute_ewald_eqeq(v);
460 }
461 else if (kspacehdnnp->pppmflag) // PPPM
462 {
463 //TODO: add contributions to Eqeq for PPPM style
464 kspacehdnnp->particle_map();
465 kspacehdnnp->make_rho_qeq(v); // map my particle charge onto my local 3d density grid
466 E_recip = kspacehdnnp->compute_pppm_eqeq(); // TODO: WIP
467 }
468 hdnnp->E_elec = E_real + E_self; // do not add E_recip, it is already global
469 E_qeq_loc += hdnnp->E_elec;
470 }else
471 {
472 // first loop over local atoms
473 for (i = 0; i < nlocal; i++) {
474 double const qi = gsl_vector_get(v,tag[i]-1);
475 double qi2 = qi * qi;
476 // add i terms
477 iiterm = qi2 * (1 / (2.0 * hdnnp->sigmaSqrtPi[type[i]-1]) + (0.5 * hdnnp->hardness[type[i]-1]));
478 E_qeq_loc += iiterm + hdnnp->chi[i] * qi;
479 hdnnp->E_elec += iiterm;
480 E_scr -= iiterm; //TODO parallel ?
481 // Looping over all atoms (parallelization of necessary arrays has been done beforehand)
482 for (j = 0; j < nall; j++) {
483 double const qj = gsl_vector_get(v, j);
484 double const dx = xx[j] - x[i][0];
485 double const dy = xy[j] - x[i][1];
486 double const dz = xz[j] - x[i][2];
487 double const rij = sqrt(SQR(dx) + SQR(dy) + SQR(dz)) * hdnnp->cflength;
488 if (rij != 0.0) //TODO check
489 {
490 ijterm = (erf(rij / hdnnp->gammaSqrt2[type[i]-1][type_all[j]-1]) / rij);
491 E_qeq_loc += 0.5 * ijterm * qi * qj;
492 hdnnp->E_elec += ijterm;
493 if(rij <= hdnnp->screening_info[2]) {
494 E_scr += ijterm * (hdnnp->screening_f(rij) - 1);
495 }
496 }
497 }
498 }
499 }
500
501 //TODO: add communication steps for E_elec !!!
502 hdnnp->E_elec = hdnnp->E_elec + E_scr; // add screening energy
503
504 MPI_Allreduce(&E_qeq_loc,&E_qeq,1,MPI_DOUBLE,MPI_SUM,world); // MPI_SUM of local QEQ contributions
505
506 if (periodic) E_qeq += E_recip; // adding already all-reduced reciprocal part now
507
508 //fprintf(stderr, "Erecip = %24.16E\n", E_recip);
509 return E_qeq;
510}
#define SQR(x)
Definition fix_hdnnp.cpp:44

References hdnnp, kspacehdnnp, list, periodic, SQR, type_all, xx, xy, and xz.

Referenced by QEq_f_wrap(), and QEq_fdf().

Here is the caller graph for this function:

◆ QEq_df()

void FixHDNNP::QEq_df ( const gsl_vector * v,
gsl_vector * dEdQ )
protected

Definition at line 519 of file fix_hdnnp.cpp.

520{
521 int i,j,jmap;
522 int nlocal = atom->nlocal;
523 int nall = atom->natoms;
524 int *tag = atom->tag;
525 int *type = atom->type;
526
527 double **x = atom->x;
528 double *q = atom->q;
529
530 double grad;
531 double grad_sum_loc;
532 double grad_sum;
533 double grad_recip; // reciprocal space contribution to the gradient
534 double grad_i;
535 double jsum; //summation over neighbors & kspace respectively
536 double recip_sum;
537
538 double eta;
539
540 if (periodic) eta = 1 / kspacehdnnp->g_ewald; // LAMMPS truncation
541
542
543 grad_sum = 0.0;
544 grad_sum_loc = 0.0;
545 if (periodic)
546 {
547 double sqrt2eta = (sqrt(2.0) * eta);
548 for (i = 0; i < nlocal; i++) // over local atoms
549 {
550 double const qi = gsl_vector_get(v,tag[i]-1);
551 // Reciprocal contribution
552 if (kspacehdnnp->ewaldflag)
553 {
554 grad_recip = 0.0;
555 for (int k = 0; k < kspacehdnnp->kcount; k++) // over k-space
556 {
557 grad_recip += 2.0 * kspacehdnnp->kcoeff[k] *
558 (kspacehdnnp->sf_real[k] * kspacehdnnp->sfexp_rl[k][i] +
559 kspacehdnnp->sf_im[k] * kspacehdnnp->sfexp_im[k][i]);
560 }
561 }
562 else if (kspacehdnnp->pppmflag)
563 {
564 //TODO: calculate dEdQ_i for a given local atom i
565 grad_recip = kspacehdnnp->compute_pppm_dEdQ(i);
566 }
567 // Real contribution - over neighbors
568 jsum = 0.0;
569 for (int jj = 0; jj < list->numneigh[i]; ++jj) {
570 j = list->firstneigh[i][jj];
571 j &= NEIGHMASK;
572 double const qj = gsl_vector_get(v, tag[j]-1);
573 //jmap = atom->map(tag[j]);
574 //double const dx = x[i][0] - x[j][0];
575 //double const dy = x[i][1] - x[j][1];
576 //double const dz = x[i][2] - x[j][2];
577 //double const rij = sqrt(SQR(dx) + SQR(dy) + SQR(dz)) * hdnnp->cflength;
578 //double erfcRij = (erfc(rij / sqrt2eta) - erfc(rij / hdnnp->gammaSqrt2[type[i]-1][type[jmap]-1]));
579 //jsum += qj * erfcRij / rij;
580 jsum += qj * hdnnp->erfc_val[i][jj];
581 }
582 grad = jsum + grad_recip + hdnnp->chi[i] + hdnnp->hardness[type[i]-1]*qi +
583 qi * (1/(hdnnp->sigmaSqrtPi[type[i]-1])- 2/(eta * sqrt(2.0 * M_PI)));
584 grad_sum_loc += grad;
585 dEdQ_loc[tag[i]-1] = grad; // fill gradient array based on tags instead of local IDs
586 }
587 }else
588 {
589 // first loop over local atoms
590 for (i = 0; i < nlocal; i++) { // TODO: indices
591 double const qi = gsl_vector_get(v,tag[i]-1);
592 // second loop over 'all' atoms
593 jsum = 0.0;
594 // Looping over all atoms (parallelization of necessary arrays has been done beforehand)
595 for (j = 0; j < nall; j++) {
596 {
597 double const qj = gsl_vector_get(v, j);
598 double const dx = xx[j] - x[i][0];
599 double const dy = xy[j] - x[i][1];
600 double const dz = xz[j] - x[i][2];
601 double const rij = sqrt(SQR(dx) + SQR(dy) + SQR(dz)) * hdnnp->cflength;
602 if (rij != 0.0) jsum += qj * erf(rij / hdnnp->gammaSqrt2[type[i]-1][type_all[j]-1]) / rij;
603 }
604 }
605 grad = hdnnp->chi[i] + hdnnp->hardness[type[i]-1]*qi + qi/(hdnnp->sigmaSqrtPi[type[i]-1]) + jsum;
606 grad_sum_loc += grad;
607 dEdQ_loc[tag[i]-1] = grad;
608 //gsl_vector_set(dEdQ,i,grad);
609 }
610 }
611
612 MPI_Allreduce(dEdQ_loc,dEdQ_all,atom->natoms,MPI_DOUBLE,MPI_SUM,world);
613 MPI_Allreduce(&grad_sum_loc,&grad_sum,1,MPI_DOUBLE,MPI_SUM,world);
614
615 // Gradient projection
616 for (i = 0; i < nall; i++){
617 grad_i = dEdQ_all[i];
618 gsl_vector_set(dEdQ,i,grad_i - (grad_sum)/nall);
619 }
620}

References dEdQ_all, dEdQ_loc, hdnnp, kspacehdnnp, list, periodic, SQR, type_all, xx, xy, and xz.

Referenced by QEq_df_wrap(), and QEq_fdf().

Here is the caller graph for this function:

◆ QEq_fdf()

void FixHDNNP::QEq_fdf ( const gsl_vector * v,
double * f,
gsl_vector * df )
protected

Definition at line 629 of file fix_hdnnp.cpp.

630{
631 *f = QEq_f(v);
632 QEq_df(v, df);
633}
void QEq_df(const gsl_vector *, gsl_vector *)
double QEq_f(const gsl_vector *)

References QEq_df(), and QEq_f().

Referenced by QEq_fdf_wrap().

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

◆ QEq_f_wrap()

double FixHDNNP::QEq_f_wrap ( const gsl_vector * v,
void * params )
staticprotected

Definition at line 513 of file fix_hdnnp.cpp.

514{
515 return static_cast<FixHDNNP*>(params)->QEq_f(v);
516}
FixHDNNP(class LAMMPS *, int, char **)
Definition fix_hdnnp.cpp:52

References FixHDNNP(), and QEq_f().

Referenced by calculate_QEqCharges().

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

◆ QEq_df_wrap()

void FixHDNNP::QEq_df_wrap ( const gsl_vector * v,
void * params,
gsl_vector * df )
staticprotected

Definition at line 623 of file fix_hdnnp.cpp.

624{
625 static_cast<FixHDNNP*>(params)->QEq_df(v, df);
626}

References FixHDNNP(), and QEq_df().

Referenced by calculate_QEqCharges().

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

◆ QEq_fdf_wrap()

void FixHDNNP::QEq_fdf_wrap ( const gsl_vector * v,
void * params,
double * E,
gsl_vector * df )
staticprotected

Definition at line 636 of file fix_hdnnp.cpp.

637{
638 static_cast<FixHDNNP*>(params)->QEq_fdf(v, E, df);
639}
void QEq_fdf(const gsl_vector *, double *, gsl_vector *)

References FixHDNNP(), and QEq_fdf().

Referenced by calculate_QEqCharges().

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

◆ calculate_QEqCharges()

void FixHDNNP::calculate_QEqCharges ( )
protected

Definition at line 642 of file fix_hdnnp.cpp.

643{
644 size_t iter = 0;
645 int status;
646 int i,j;
647 int nsize;
648 int nlocal;
649 int *tag = atom->tag;
650
651 double *q = atom->q;
652 double qsum_it;
653 double gradsum;
654 double qi;
655 double df,alpha;
656
657 nsize = atom->natoms; // total number of atoms
658 nlocal = atom->nlocal; // total number of atoms
659
660 gsl_vector *Q; // charge vector
661 QEq_minimizer.n = nsize; // it should be n_all in the future
662 QEq_minimizer.f = &QEq_f_wrap; // function pointer f(x)
663 QEq_minimizer.df = &QEq_df_wrap; // function pointer df(x)
665 QEq_minimizer.params = this;
666
667 //fprintf(stderr, "q[%d] = %24.16E\n", atom->tag[0], q[0]);
668
669 // Allocation
670 //memory->create(qall,atom->natoms,"qeq:qall");
671 //memory->create(qall_loc,atom->natoms,"qeq:qall_loc");
672 //memory->create(dEdQ_loc,atom->natoms,"qeq:dEdQ_loc");
673 //memory->create(dEdQ_all,atom->natoms,"qeq:dEdQ_all");
674
675 // Initialization
676 for (int i =0; i < atom->natoms; i++){
677 qall[i] = 0.0;
678 qall_loc[i] = 0.0;
679 dEdQ_loc[i] = 0.0;
680 dEdQ_all[i] = 0.0;
681 }
682
683 for (int i = 0; i < atom->nlocal; i++) {
684 qall_loc[tag[i] - 1] = q[i];
685 }
686
687 MPI_Allreduce(qall_loc,qall,atom->natoms,MPI_DOUBLE,MPI_SUM,world);
688
689 if (!periodic) // we need global position arrays in nonperiodic systems
690 {
691 // Initialize global arrays
692 for (int i = 0; i < atom->natoms; i++){
693 type_loc[i] = 0;
694 xx_loc[i] = 0.0;
695 xy_loc[i] = 0.0;
696 xz_loc[i] = 0.0;
697 xx[i] = 0.0;
698 xy[i] = 0.0;
699 xz[i] = 0.0;
700 }
701
702 // Create global sparse arrays here
703 for (int i = 0; i < atom->nlocal; i++){
704 xx_loc[tag[i]-1] = atom->x[i][0];
705 xy_loc[tag[i]-1] = atom->x[i][1];
706 xz_loc[tag[i]-1] = atom->x[i][2];
707 type_loc[tag[i]-1] = atom->type[i];
708 }
709 MPI_Allreduce(xx_loc,xx,atom->natoms,MPI_DOUBLE,MPI_SUM,world);
710 MPI_Allreduce(xy_loc,xy,atom->natoms,MPI_DOUBLE,MPI_SUM,world);
711 MPI_Allreduce(xz_loc,xz,atom->natoms,MPI_DOUBLE,MPI_SUM,world);
712 MPI_Allreduce(type_loc,type_all,atom->natoms,MPI_DOUBLE,MPI_SUM,world);
713 }
714
715
716 // Set the initial guess vector
717 Q = gsl_vector_alloc(nsize);
718 for (i = 0; i < nsize; i++)
719 {
720 if (hdnnp->minim_init_style == 0)
721 {
722 gsl_vector_set(Q, i, 0.0);
723 }else if (hdnnp->minim_init_style == 1)
724 {
725 gsl_vector_set(Q, i, qall[i]);
726 }else
727 {
728 error->all(FLERR,"Invalid minimization style. Allowed values are 0 and 1.");
729 }
730 }
731
732 //memory->destroy(qall);
733 //memory->destroy(qall_loc);
734
735 // TODO: is bfgs2 standard ?
736 T = gsl_multimin_fdfminimizer_vector_bfgs2;
737 s = gsl_multimin_fdfminimizer_alloc(T, nsize);
738 gsl_multimin_fdfminimizer_set(s, &QEq_minimizer, Q, hdnnp->step, hdnnp->min_tol); // tol = 0 might be expensive ???
739 do
740 {
741 //fprintf(stderr, "eqeq-iter %zu\n", iter);
742 iter++;
743 qsum_it = 0.0;
744 gradsum = 0.0;
745 status = gsl_multimin_fdfminimizer_iterate(s);
746 // Projection (enforcing constraints)
747 // TODO: could this be done more efficiently ?
748 for(i = 0; i < nsize; i++) {
749 qsum_it = qsum_it + gsl_vector_get(s->x, i); // total charge after the minimization hdnnp->step
750 }
751 for(i = 0; i < nsize; i++) {
752 qi = gsl_vector_get(s->x,i);
753 gsl_vector_set(s->x,i, qi - (qsum_it-qRef)/nsize); // charge projection
754 }
755 status = gsl_multimin_test_gradient(s->gradient, hdnnp->grad_tol); // check for convergence
756
757 // TODO: dump also iteration time ?
758 //if (status == GSL_SUCCESS) printf ("Minimum charge distribution is found at iteration : %zu\n", iter);
759 }
760 while (status == GSL_CONTINUE && iter < hdnnp->maxit);
761
762 // Read calculated atomic charges back into local arrays for further calculations
763 for (int i = 0; i < atom->nlocal; i++){
764 q[i] = gsl_vector_get(s->x,tag[i]-1);
765 }
766
767 // Deallocation
768 gsl_multimin_fdfminimizer_free(s);
769 gsl_vector_free(Q);
770 //memory->destroy(dEdQ_loc);
771 //memory->destroy(dEdQ_all);
772}
gsl_multimin_fdfminimizer * s
Definition fix_hdnnp.h:71
const gsl_multimin_fdfminimizer_type * T
Definition fix_hdnnp.h:70
static double QEq_f_wrap(const gsl_vector *, void *)
static void QEq_df_wrap(const gsl_vector *, void *, gsl_vector *)
gsl_multimin_function_fdf QEq_minimizer
QEq energy minimization via gsl library.
Definition fix_hdnnp.h:69
static void QEq_fdf_wrap(const gsl_vector *, void *, double *, gsl_vector *)

References dEdQ_all, dEdQ_loc, hdnnp, periodic, Q, qall, qall_loc, QEq_df_wrap(), QEq_f_wrap(), QEq_fdf_wrap(), QEq_minimizer, qRef, s, T, type_all, type_loc, xx, xx_loc, xy, xy_loc, xz, and xz_loc.

Referenced by pre_force().

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

◆ calculate_erfc_terms()

void FixHDNNP::calculate_erfc_terms ( )
protected

Definition at line 345 of file fix_hdnnp.cpp.

346{
347 int i,j,jmap;
348 int nlocal = atom->nlocal;
349 int *tag = atom->tag;
350 int *type = atom->type;
351
352 double **x = atom->x;
353 double eta;
354
355 int maxnumneigh = 0;
356 // TODO is this already available in LAMMPS ?
357 for (int i = 0; i < nlocal; i++)
358 {
359 int nneigh = list->numneigh[i];
360 if (nneigh > maxnumneigh) maxnumneigh = nneigh;
361 }
362
363 //maxnumneigh = 100000;
364 // allocate and initialize
365 memory->create(hdnnp->erfc_val,nlocal+1,maxnumneigh+1,"fix_hdnnp:erfc_val");
366
367 for (int i = 0; i < nlocal; i++){
368 for (int j = 0; j < maxnumneigh; j++)
369 hdnnp->erfc_val[i][j] = 0.0;
370 }
371
372 if (periodic)
373 {
374 eta = 1 / kspacehdnnp->g_ewald; // LAMMPS truncation
375 double sqrt2eta = (sqrt(2.0) * eta);
376 for (i = 0; i < nlocal; i++)
377 {
378 for (int jj = 0; jj < list->numneigh[i]; ++jj) {
379 j = list->firstneigh[i][jj];
380 j &= NEIGHMASK;
381 jmap = atom->map(tag[j]);
382 double const dx = x[i][0] - x[j][0];
383 double const dy = x[i][1] - x[j][1];
384 double const dz = x[i][2] - x[j][2];
385 double const rij = sqrt(SQR(dx) + SQR(dy) + SQR(dz)) * hdnnp->cflength;
386 hdnnp->erfc_val[i][jj] = (erfc(rij/sqrt2eta) - erfc(rij/hdnnp->gammaSqrt2[type[i]-1][type[jmap]-1])) / rij;
387 }
388 }
389 }
390}

References hdnnp, kspacehdnnp, list, periodic, and SQR.

Referenced by pre_force().

Here is the caller graph for this function:

Friends And Related Symbol Documentation

◆ PairHDNNP4G

friend class PairHDNNP4G
friend

Definition at line 30 of file fix_hdnnp.h.

References PairHDNNP4G.

Referenced by FixHDNNP(), and PairHDNNP4G.

Member Data Documentation

◆ hdnnp

◆ kspacehdnnp

class KSpaceHDNNP* LAMMPS_NS::FixHDNNP::kspacehdnnp
protected

Definition at line 48 of file fix_hdnnp.h.

Referenced by calculate_erfc_terms(), FixHDNNP(), pre_force(), QEq_df(), and QEq_f().

◆ list

class NeighList* LAMMPS_NS::FixHDNNP::list
protected

Definition at line 49 of file fix_hdnnp.h.

Referenced by calculate_erfc_terms(), FixHDNNP(), init_list(), QEq_df(), and QEq_f().

◆ pertype_option

char* LAMMPS_NS::FixHDNNP::pertype_option
protected

Definition at line 50 of file fix_hdnnp.h.

Referenced by FixHDNNP(), post_constructor(), and ~FixHDNNP().

◆ hdnnpflag

int LAMMPS_NS::FixHDNNP::hdnnpflag
protected

Definition at line 52 of file fix_hdnnp.h.

Referenced by FixHDNNP(), and pertype_parameters().

◆ kspaceflag

int LAMMPS_NS::FixHDNNP::kspaceflag
protected

Definition at line 53 of file fix_hdnnp.h.

Referenced by FixHDNNP().

◆ ngroup

int LAMMPS_NS::FixHDNNP::ngroup
protected

Definition at line 54 of file fix_hdnnp.h.

Referenced by FixHDNNP(), and init().

◆ periodic

bool LAMMPS_NS::FixHDNNP::periodic
protected

◆ qRef

double LAMMPS_NS::FixHDNNP::qRef
protected

◆ Q

double* LAMMPS_NS::FixHDNNP::Q
protected

Definition at line 58 of file fix_hdnnp.h.

Referenced by calculate_QEqCharges(), and FixHDNNP().

◆ QEq_minimizer

gsl_multimin_function_fdf LAMMPS_NS::FixHDNNP::QEq_minimizer
protected

QEq energy minimization via gsl library.

Definition at line 69 of file fix_hdnnp.h.

Referenced by calculate_QEqCharges().

◆ T

const gsl_multimin_fdfminimizer_type* LAMMPS_NS::FixHDNNP::T
protected

Definition at line 70 of file fix_hdnnp.h.

Referenced by calculate_QEqCharges().

◆ s

gsl_multimin_fdfminimizer* LAMMPS_NS::FixHDNNP::s
protected

Definition at line 71 of file fix_hdnnp.h.

Referenced by calculate_QEqCharges().

◆ type_all

int* LAMMPS_NS::FixHDNNP::type_all
protected

Global storage.

Definition at line 87 of file fix_hdnnp.h.

Referenced by calculate_QEqCharges(), FixHDNNP(), QEq_df(), QEq_f(), and ~FixHDNNP().

◆ type_loc

int * LAMMPS_NS::FixHDNNP::type_loc
protected

Definition at line 87 of file fix_hdnnp.h.

Referenced by calculate_QEqCharges(), FixHDNNP(), and ~FixHDNNP().

◆ qall

double* LAMMPS_NS::FixHDNNP::qall
protected

Definition at line 88 of file fix_hdnnp.h.

Referenced by allocate_QEq(), calculate_QEqCharges(), deallocate_QEq(), FixHDNNP(), and ~FixHDNNP().

◆ qall_loc

double * LAMMPS_NS::FixHDNNP::qall_loc
protected

Definition at line 88 of file fix_hdnnp.h.

Referenced by allocate_QEq(), calculate_QEqCharges(), deallocate_QEq(), FixHDNNP(), and ~FixHDNNP().

◆ dEdQ_all

double* LAMMPS_NS::FixHDNNP::dEdQ_all
protected

◆ dEdQ_loc

double * LAMMPS_NS::FixHDNNP::dEdQ_loc
protected

◆ xx

double* LAMMPS_NS::FixHDNNP::xx
protected

Definition at line 90 of file fix_hdnnp.h.

Referenced by calculate_QEqCharges(), FixHDNNP(), QEq_df(), QEq_f(), and ~FixHDNNP().

◆ xy

double * LAMMPS_NS::FixHDNNP::xy
protected

Definition at line 90 of file fix_hdnnp.h.

Referenced by calculate_QEqCharges(), FixHDNNP(), QEq_df(), QEq_f(), and ~FixHDNNP().

◆ xz

double * LAMMPS_NS::FixHDNNP::xz
protected

Definition at line 90 of file fix_hdnnp.h.

Referenced by calculate_QEqCharges(), FixHDNNP(), QEq_df(), QEq_f(), and ~FixHDNNP().

◆ xx_loc

double* LAMMPS_NS::FixHDNNP::xx_loc
protected

Definition at line 91 of file fix_hdnnp.h.

Referenced by calculate_QEqCharges(), FixHDNNP(), and ~FixHDNNP().

◆ xy_loc

double * LAMMPS_NS::FixHDNNP::xy_loc
protected

Definition at line 91 of file fix_hdnnp.h.

Referenced by calculate_QEqCharges(), FixHDNNP(), and ~FixHDNNP().

◆ xz_loc

double * LAMMPS_NS::FixHDNNP::xz_loc
protected

Definition at line 91 of file fix_hdnnp.h.

Referenced by calculate_QEqCharges(), FixHDNNP(), and ~FixHDNNP().


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