120 if(eflag || vflag) ev_setup(eflag,vflag);
121 else evflag = vflag_fdotr = eflag_global = eflag_atom = 0;
126 interface.setLocalAtoms(atom->nlocal,atom->type);
161 for (
int i =0; i < atom->natoms; i++){
181 for (
int i = 0; i < atom->nlocal; i++){
182 qall_loc[atom->tag[i]-1] = atom->q[i];
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];
190 MPI_Allreduce(
qall_loc,
qall,atom->natoms,MPI_DOUBLE,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);
215 for (
int i = 0; i < atom->nlocal; i++){
218 for (
int i = 0; i < atom->natoms; i++){
236 ev_tally(0,0,atom->nlocal,1,
interface.getEnergy(),0.0,0.0,0.0,0.0,0.0);
240 for (
int i = 0; i < atom->nlocal; ++i)
244 if (vflag_fdotr) virial_fdotr_compute();
255 if (narg == 0) error->all(FLERR,
"Illegal pair_style command");
258 int len = strlen(
"nnp/") + 1;
267 len = strlen(
"") + 1;
268 emap =
new char[len];
275 if (strcmp(arg[iarg],
"dir") == 0) {
277 error->all(FLERR,
"Illegal pair_style command");
279 len = strlen(arg[iarg+1]) + 2;
284 }
else if (strcmp(arg[iarg],
"emap") == 0) {
286 error->all(FLERR,
"Illegal pair_style command");
288 len = strlen(arg[iarg+1]) + 1;
289 emap =
new char[len];
290 sprintf(
emap,
"%s", arg[iarg+1]);
293 }
else if (strcmp(arg[iarg],
"showew") == 0) {
295 error->all(FLERR,
"Illegal pair_style command");
296 if (strcmp(arg[iarg+1],
"yes") == 0)
298 else if (strcmp(arg[iarg+1],
"no") == 0)
301 error->all(FLERR,
"Illegal pair_style command");
304 }
else if (strcmp(arg[iarg],
"showewsum") == 0) {
306 error->all(FLERR,
"Illegal pair_style command");
307 showewsum = utils::inumeric(FLERR,arg[iarg+1],
false,lmp);
310 }
else if (strcmp(arg[iarg],
"maxew") == 0) {
312 error->all(FLERR,
"Illegal pair_style command");
313 maxew = utils::inumeric(FLERR,arg[iarg+1],
false,lmp);
316 }
else if (strcmp(arg[iarg],
"resetew") == 0) {
318 error->all(FLERR,
"Illegal pair_style command");
319 if (strcmp(arg[iarg+1],
"yes") == 0)
321 else if (strcmp(arg[iarg+1],
"no") == 0)
324 error->all(FLERR,
"Illegal pair_style command");
327 }
else if (strcmp(arg[iarg],
"cflength") == 0) {
329 error->all(FLERR,
"Illegal pair_style command");
330 cflength = utils::numeric(FLERR,arg[iarg+1],
false,lmp);
333 }
else if (strcmp(arg[iarg],
"cfenergy") == 0) {
335 error->all(FLERR,
"Illegal pair_style command");
336 cfenergy = utils::numeric(FLERR,arg[iarg+1],
false,lmp);
338 }
else error->all(FLERR,
"Illegal pair_style command");
350 if (narg != 3) error->all(FLERR,
"Incorrect args for pair coefficients");
354 utils::bounds(FLERR,arg[0],1,atom->ntypes,ilo,ihi,error);
355 utils::bounds(FLERR,arg[1],1,atom->ntypes,jlo,jhi,error);
361 for(
int i=ilo; i<=ihi; i++) {
362 for(
int j=MAX(jlo,i); j<=jhi; j++) {
368 if (count == 0) error->all(FLERR,
"Incorrect args for pair coefficients");
480 int n = atom->ntypes;
481 int natoms = atom->natoms;
482 int nlocal = atom->nlocal;
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++)
491 memory->create(cutsq,n+1,n+1,
"pair:cutsq");
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");
519 for (
int i = 0; i < natoms+1; i++)
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];
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;
553 interface.addNeighbor(i,j,atom->tag[j],atom->type[j],dx,dy,dz,d2);
563 long numCurrentEW = (long)
interface.getNumExtrapolationWarnings();
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);
584 for(
int i=1;i<comm->nprocs;i++) {
585 if(numEWPerProc[i] > 0) {
589 MPI_Recv(&bs, 1, MPI_LONG, i, 0, world, &ms);
590 char* buf =
new char[bs];
592 MPI_Recv(buf, bs, MPI_BYTE, i, 0, world, &ms);
599 else if(numCurrentEW > 0) {
603 char* buf =
new char[bs];
606 MPI_Send(&bs, 1, MPI_LONG, 0, 0, world);
607 MPI_Send(buf, bs, MPI_BYTE, 0, 0, world);
611 if(comm->me == 0)
delete[] numEWPerProc;
619 &globalEW, 1, MPI_LONG, MPI_SUM, 0, world);
624 "### NNP EW SUMMARY ### TS: %10ld EW %10ld EWPERSTEP %10.3e\n",
631 "### NNP EW SUMMARY ### TS: %10ld EW %10ld EWPERSTEP %10.3e\n",
643 error->one(FLERR,
"Too many extrapolation warnings");
662 int *type = atom->type;
663 int nlocal = atom->nlocal;
664 int *tag = atom->tag;
665 int nall = atom->natoms;
667 double **x = atom->x;
668 double E_real, E_recip, E_self;
669 double E_lambda,E_lambda_loc;
670 double iiterm,ijterm;
680 double sqrt2eta = (sqrt(2.0) * eta);
684 for (i = 0; i < nlocal; i++)
686 double const lambda_i = gsl_vector_get(v, tag[i]-1);
687 double lambda_i2 = lambda_i * lambda_i;
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;
695 for (
int jj = 0; jj <
list->numneigh[i]; ++jj) {
696 j =
list->firstneigh[i][jj];
698 double const lambda_j = gsl_vector_get(v, tag[j]-1);
706 double real = 0.5 * lambda_i * lambda_j *
erfc_val[i][jj];
713 double sf_real_loc = 0.0;
714 double sf_im_loc = 0.0;
717 for (i = 0; i < nlocal; i++)
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];
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);
727 E_lambda_loc += E_real + E_self;
731 for (i = 0; i < nlocal; i++) {
732 double const lambda_i = gsl_vector_get(v,i);
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;
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];
743 ijterm = lambda_i * lambda_j * (erf(rij /
gammaSqrt2[type[i]-1][type[j]-1]) / rij);
749 MPI_Allreduce(&E_lambda_loc,&E_lambda,1,MPI_DOUBLE,MPI_SUM,world);
765 int nlocal = atom->nlocal;
766 int nall = atom->natoms;
767 int *tag = atom->tag;
768 int *type = atom->type;
770 double **x = atom->x;
773 double grad_sum,grad_sum_loc,grad_i;
784 double sqrt2eta = (sqrt(2.0) * eta);
785 for (i = 0; i < nlocal; i++)
787 double const lambda_i = gsl_vector_get(v,tag[i]-1);
800 for (
int jj = 0; jj <
list->numneigh[i]; ++jj) {
801 j =
list->firstneigh[i][jj];
803 double const lambda_j = gsl_vector_get(v, tag[j]-1);
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;
821 for (i = 0; i < nlocal; i++) {
822 double const lambda_i = gsl_vector_get(v,i);
825 for (j = 0; j < nall; j++) {
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];
832 local_sum += lambda_j * erf(rij /
gammaSqrt2[type[i]-1][type[j]-1]) / rij;
837 grad_sum = grad_sum + val;
838 gsl_vector_set(dEdLambda,i,val);
843 MPI_Allreduce(&grad_sum_loc,&grad_sum,1,MPI_DOUBLE,MPI_SUM,world);
846 for (i = 0; i < nall; i++){
848 gsl_vector_set(dEdLambda,i,grad_i - (grad_sum)/nall);
884 nsize = atom->natoms;
885 nlocal = atom->nlocal;
895 for (
int i =0; i < atom->natoms; i++) {
903 for (
int i = 0; i < atom->nlocal; i++){
910 x = gsl_vector_alloc(nsize);
911 for (i = 0; i < nsize; i++) {
915 T = gsl_multimin_fdfminimizer_vector_bfgs2;
916 s = gsl_multimin_fdfminimizer_alloc(
T, nsize);
923 status = gsl_multimin_fdfminimizer_iterate(
s);
926 for(i = 0; i < nsize; i++) {
927 psum_it = psum_it + gsl_vector_get(
s->x, i);
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);
934 status = gsl_multimin_test_gradient(
s->gradient,
grad_tol);
939 while (status == GSL_CONTINUE && iter <
maxit);
942 for (i = 0; i < nlocal; i++) {
946 gsl_multimin_fdfminimizer_free(
s);
1006 int nlocal = atom->nlocal;
1007 int nall = atom->natoms;
1008 int *tag = atom->tag;
1009 int *type = atom->type;
1011 double **x = atom->x;
1012 double *q = atom->q;
1015 double rij,rij2,erfrij;
1018 double fsrij,dfsrij;
1024 for (i = 0; i < nlocal; i++)
1029 double sqrt2eta = (sqrt(2.0) * eta);
1031 for (j = 0; j < nall; j++)
1035 dx = x[i][0] -
xx[j];
1036 dy = x[i][1] -
xy[j];
1037 dz = x[i][2] -
xz[j];
1043 if (dx != 0.0) Aij += 2.0 *
kspacehdnnp->kcoeff[k] * cos(kdr);
1045 dEelecdQ[i] += qj * Aij;
1049 dEelecdQ[i] += qi * (
kcoeff_sum - 2 / (sqrt2eta * sqrt(M_PI)));
1052 for (
int jj = 0; jj <
list->numneigh[i]; ++jj) {
1053 j =
list->firstneigh[i][jj];
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];
1068 dEelecdQ[i] += qj * Aij;
1072 erfrij = erf(rij / gams2);
1076 sij = erfrij * (fsrij - 1) / rij;
1078 tij = (2 / (sqrt(M_PI)*gams2) * exp(- pow(rij / gams2,2)) *
1079 (fsrij - 1) + erfrij*dfsrij - erfrij*(fsrij-1)/rij) / rij2;
1081 dEelecdQ[i] += qj * (sij);
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;
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;
1094 for (j = 0; j < nall; j++)
1098 dx = x[i][0] -
xx[j];
1099 dy = x[i][1] -
xy[j];
1100 dz = x[i][2] -
xz[j];
1109 erfrij = erf(rij / gams2);
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;
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;
1134 int nlocal = atom->nlocal;
1135 int nall = atom->natoms;
1136 int *tag = atom->tag;
1137 int *type = atom->type;
1141 double *q = atom->q;
1142 double **x = atom->x;
1153 for (i = 0; i < nlocal; i++) {
1157 double sqrt2eta = (sqrt(2.0) * eta);
1163 for (
int jj = 0; jj <
list->numneigh[i]; ++jj) {
1164 k =
list->firstneigh[i][jj];
1166 int jmap = atom->map(tag[k]);
1167 qk =
qall[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);
1175 if (rij < kspacehdnnp->ewald_real_cutoff) {
1176 gams2 =
gammaSqrt2[type[i]- 1][type[jmap]-1];
1180 delr = (2 / sqrt(M_PI) * (-exp(-pow(rij / sqrt2eta, 2))
1181 / sqrt2eta + exp(-pow(rij / gams2, 2)) / gams2)
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;
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;
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;
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;
1208 for (j = 0; j < nall; j++){
1211 dx = x[i][0] -
xx[j];
1212 dy = x[i][1] -
xy[j];
1213 dz = x[i][2] -
xz[j];
1217 for (
int kk = 0; kk <
kspacehdnnp->kcount; kk++) {
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;
1254 for (j = 0; j < nall; j++) {
1262 for (k = 0; k < nall; k++) {
1266 dx = x[i][0] -
xx[k];
1268 dy = x[i][1] -
xy[k];
1270 dz = x[i][2] -
xz[k];
1271 double rij2 =
SQR(dx) +
SQR(dy) +
SQR(dz);
1278 delr = (2 / (sqrt(M_PI) * gams2) * exp(-pow(rij / gams2, 2)) - erf(rij / gams2) / rij);
1280 jt0 += (dx / rij2) * delr * qk;
1281 jt1 += (dy / rij2) * delr * qk;
1282 jt2 += (dz / rij2) * delr * qk;
1288 dx = x[i][0] -
xx[j];
1290 dy = x[i][1] -
xy[j];
1292 dz = x[i][2] -
xz[j];
1293 double rij2 =
SQR(dx) +
SQR(dy) +
SQR(dz);
1298 delr = (2 / (sqrt(M_PI) * gams2) * exp(-pow(rij / gams2, 2)) - erf(rij / gams2) / rij);
1300 jt0 = (dx / rij2) * delr * qi;
1301 jt1 = (dy / rij2) * delr * qi;
1302 jt2 = (dz / rij2) * delr * qi;