78 if (narg<9 || narg>11) error->all(FLERR,
"Illegal fix hdnnp command");
80 nevery = utils::inumeric(FLERR,arg[3],
false,lmp);
81 if (nevery <= 0) error->all(FLERR,
"Illegal fix hdnnp command");
83 int len = strlen(arg[8]) + 1;
93 hdnnp->hardness =
nullptr;
94 hdnnp->sigmaSqrtPi =
nullptr;
95 hdnnp->gammaSqrt2 =
nullptr;
96 hdnnp->screening_info =
nullptr;
100 hdnnp->grad_tol = utils::numeric(FLERR,arg[4],
false,lmp);
101 hdnnp->min_tol = utils::numeric(FLERR,arg[5],
false,lmp);
102 hdnnp->step = utils::numeric(FLERR,arg[6],
false,lmp);
103 hdnnp->maxit = utils::inumeric(FLERR,arg[7],
false,lmp);
104 hdnnp->minim_init_style = utils::inumeric(FLERR,arg[10],
false,lmp);
107 int natoms = atom->natoms;
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");
277 double Qtot_loc = 0.0;
278 int n = atom->nlocal;
293 for (
int i = 0; i < n; i++) {
297 MPI_Allreduce(&Qtot_loc,&
qRef,1,MPI_DOUBLE,MPI_SUM,world);
302 std::chrono::steady_clock::time_point begin = std::chrono::steady_clock::now();
305 std::chrono::steady_clock::time_point end = std::chrono::steady_clock::now();
348 int nlocal = atom->nlocal;
349 int *tag = atom->tag;
350 int *type = atom->type;
352 double **x = atom->x;
357 for (
int i = 0; i < nlocal; i++)
359 int nneigh =
list->numneigh[i];
360 if (nneigh > maxnumneigh) maxnumneigh = nneigh;
365 memory->create(
hdnnp->erfc_val,nlocal+1,maxnumneigh+1,
"fix_hdnnp:erfc_val");
367 for (
int i = 0; i < nlocal; i++){
368 for (
int j = 0; j < maxnumneigh; j++)
369 hdnnp->erfc_val[i][j] = 0.0;
375 double sqrt2eta = (sqrt(2.0) * eta);
376 for (i = 0; i < nlocal; i++)
378 for (
int jj = 0; jj <
list->numneigh[i]; ++jj) {
379 j =
list->firstneigh[i][jj];
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;
396 int *tag = atom->tag;
397 int *type = atom->type;
398 int nlocal = atom->nlocal;
399 int nall = atom->natoms;
401 double **x = atom->x;
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;
407 double iiterm,ijterm;
421 double sqrt2eta = (sqrt(2.0) * eta);
425 for (i = 0; i < nlocal; i++)
427 double const qi = gsl_vector_get(v, tag[i]-1);
428 double qi2 = qi * qi;
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]);
435 for (
int jj = 0; jj <
list->numneigh[i]; ++jj) {
436 j =
list->firstneigh[i][jj];
438 jmap = atom->map(tag[j]);
439 double const qj = gsl_vector_get(v, tag[j]-1);
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;
446 double real = 0.5 * qi * qj *
hdnnp->erfc_val[i][jj];
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;
468 hdnnp->E_elec = E_real + E_self;
469 E_qeq_loc +=
hdnnp->E_elec;
473 for (i = 0; i < nlocal; i++) {
474 double const qi = gsl_vector_get(v,tag[i]-1);
475 double qi2 = qi * qi;
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;
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;
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);
504 MPI_Allreduce(&E_qeq_loc,&E_qeq,1,MPI_DOUBLE,MPI_SUM,world);
522 int nlocal = atom->nlocal;
523 int nall = atom->natoms;
524 int *tag = atom->tag;
525 int *type = atom->type;
527 double **x = atom->x;
547 double sqrt2eta = (sqrt(2.0) * eta);
548 for (i = 0; i < nlocal; i++)
550 double const qi = gsl_vector_get(v,tag[i]-1);
569 for (
int jj = 0; jj <
list->numneigh[i]; ++jj) {
570 j =
list->firstneigh[i][jj];
572 double const qj = gsl_vector_get(v, tag[j]-1);
580 jsum += qj *
hdnnp->erfc_val[i][jj];
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;
590 for (i = 0; i < nlocal; i++) {
591 double const qi = gsl_vector_get(v,tag[i]-1);
595 for (j = 0; j < nall; j++) {
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;
605 grad =
hdnnp->chi[i] +
hdnnp->hardness[type[i]-1]*qi + qi/(
hdnnp->sigmaSqrtPi[type[i]-1]) + jsum;
606 grad_sum_loc += grad;
613 MPI_Allreduce(&grad_sum_loc,&grad_sum,1,MPI_DOUBLE,MPI_SUM,world);
616 for (i = 0; i < nall; i++){
618 gsl_vector_set(dEdQ,i,grad_i - (grad_sum)/nall);
649 int *tag = atom->tag;
657 nsize = atom->natoms;
658 nlocal = atom->nlocal;
676 for (
int i =0; i < atom->natoms; i++){
683 for (
int i = 0; i < atom->nlocal; i++) {
687 MPI_Allreduce(
qall_loc,
qall,atom->natoms,MPI_DOUBLE,MPI_SUM,world);
692 for (
int i = 0; i < atom->natoms; i++){
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];
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);
717 Q = gsl_vector_alloc(nsize);
718 for (i = 0; i < nsize; i++)
720 if (
hdnnp->minim_init_style == 0)
722 gsl_vector_set(
Q, i, 0.0);
723 }
else if (
hdnnp->minim_init_style == 1)
725 gsl_vector_set(
Q, i,
qall[i]);
728 error->all(FLERR,
"Invalid minimization style. Allowed values are 0 and 1.");
736 T = gsl_multimin_fdfminimizer_vector_bfgs2;
737 s = gsl_multimin_fdfminimizer_alloc(
T, nsize);
745 status = gsl_multimin_fdfminimizer_iterate(
s);
748 for(i = 0; i < nsize; i++) {
749 qsum_it = qsum_it + gsl_vector_get(
s->x, i);
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);
755 status = gsl_multimin_test_gradient(
s->gradient,
hdnnp->grad_tol);
760 while (status == GSL_CONTINUE && iter < hdnnp->maxit);
763 for (
int i = 0; i < atom->nlocal; i++){
764 q[i] = gsl_vector_get(
s->x,tag[i]-1);
768 gsl_multimin_fdfminimizer_free(
s);