cbd5163943b5754f9c32dc2aaf95737bc5bab3f9
[alexxy/gromacs.git] / src / gromacs / mdlib / coupling.cpp
1 /*
2  * This file is part of the GROMACS molecular simulation package.
3  *
4  * Copyright (c) 1991-2000, University of Groningen, The Netherlands.
5  * Copyright (c) 2001-2004, The GROMACS development team.
6  * Copyright (c) 2013,2014,2015,2016,2017,2018, by the GROMACS development team, led by
7  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
8  * and including many others, as listed in the AUTHORS file in the
9  * top-level source directory and at http://www.gromacs.org.
10  *
11  * GROMACS is free software; you can redistribute it and/or
12  * modify it under the terms of the GNU Lesser General Public License
13  * as published by the Free Software Foundation; either version 2.1
14  * of the License, or (at your option) any later version.
15  *
16  * GROMACS is distributed in the hope that it will be useful,
17  * but WITHOUT ANY WARRANTY; without even the implied warranty of
18  * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE.  See the GNU
19  * Lesser General Public License for more details.
20  *
21  * You should have received a copy of the GNU Lesser General Public
22  * License along with GROMACS; if not, see
23  * http://www.gnu.org/licenses, or write to the Free Software Foundation,
24  * Inc., 51 Franklin Street, Fifth Floor, Boston, MA  02110-1301  USA.
25  *
26  * If you want to redistribute modifications to GROMACS, please
27  * consider that scientific software is very special. Version
28  * control is crucial - bugs must be traceable. We will be happy to
29  * consider code for inclusion in the official distribution, but
30  * derived work must not be called official GROMACS. Details are found
31  * in the README & COPYING files - if they are missing, get the
32  * official version at http://www.gromacs.org.
33  *
34  * To help us fund GROMACS development, we humbly ask that you cite
35  * the research papers on the package. Check out http://www.gromacs.org.
36  */
37 #include "gmxpre.h"
38
39 #include <assert.h>
40
41 #include <cmath>
42
43 #include <algorithm>
44
45 #include "gromacs/domdec/domdec_struct.h"
46 #include "gromacs/gmxlib/nrnb.h"
47 #include "gromacs/math/functions.h"
48 #include "gromacs/math/invertmatrix.h"
49 #include "gromacs/math/units.h"
50 #include "gromacs/math/vec.h"
51 #include "gromacs/math/vecdump.h"
52 #include "gromacs/mdlib/expanded.h"
53 #include "gromacs/mdlib/gmx_omp_nthreads.h"
54 #include "gromacs/mdlib/sim_util.h"
55 #include "gromacs/mdlib/update.h"
56 #include "gromacs/mdtypes/commrec.h"
57 #include "gromacs/mdtypes/group.h"
58 #include "gromacs/mdtypes/inputrec.h"
59 #include "gromacs/mdtypes/md_enums.h"
60 #include "gromacs/mdtypes/state.h"
61 #include "gromacs/pbcutil/boxutilities.h"
62 #include "gromacs/pbcutil/pbc.h"
63 #include "gromacs/random/gammadistribution.h"
64 #include "gromacs/random/normaldistribution.h"
65 #include "gromacs/random/tabulatednormaldistribution.h"
66 #include "gromacs/random/threefry.h"
67 #include "gromacs/random/uniformrealdistribution.h"
68 #include "gromacs/utility/cstringutil.h"
69 #include "gromacs/utility/fatalerror.h"
70 #include "gromacs/utility/smalloc.h"
71
72 #define NTROTTERPARTS 3
73
74 /* Suzuki-Yoshida Constants, for n=3 and n=5, for symplectic integration  */
75 /* for n=1, w0 = 1 */
76 /* for n=3, w0 = w2 = 1/(2-2^-(1/3)), w1 = 1-2*w0 */
77 /* for n=5, w0 = w1 = w3 = w4 = 1/(4-4^-(1/3)), w1 = 1-4*w0 */
78
79 #define MAX_SUZUKI_YOSHIDA_NUM 5
80 #define SUZUKI_YOSHIDA_NUM  5
81
82 static const double  sy_const_1[] = { 1. };
83 static const double  sy_const_3[] = { 0.828981543588751, -0.657963087177502, 0.828981543588751 };
84 static const double  sy_const_5[] = { 0.2967324292201065, 0.2967324292201065, -0.186929716880426, 0.2967324292201065, 0.2967324292201065 };
85
86 static const double* sy_const[] = {
87     nullptr,
88     sy_const_1,
89     nullptr,
90     sy_const_3,
91     nullptr,
92     sy_const_5
93 };
94
95 /*
96    static const double sy_const[MAX_SUZUKI_YOSHIDA_NUM+1][MAX_SUZUKI_YOSHIDA_NUM+1] = {
97     {},
98     {1},
99     {},
100     {0.828981543588751,-0.657963087177502,0.828981543588751},
101     {},
102     {0.2967324292201065,0.2967324292201065,-0.186929716880426,0.2967324292201065,0.2967324292201065}
103    };*/
104
105 /* these integration routines are only referenced inside this file */
106 static void NHC_trotter(t_grpopts *opts, int nvar, gmx_ekindata_t *ekind, real dtfull,
107                         double xi[], double vxi[], double scalefac[], real *veta, t_extmass *MassQ, gmx_bool bEkinAveVel)
108
109 {
110     /* general routine for both barostat and thermostat nose hoover chains */
111
112     int           i, j, mi, mj;
113     double        Ekin, Efac, reft, kT, nd;
114     double        dt;
115     t_grp_tcstat *tcstat;
116     double       *ivxi, *ixi;
117     double       *iQinv;
118     double       *GQ;
119     gmx_bool      bBarostat;
120     int           mstepsi, mstepsj;
121     int           ns = SUZUKI_YOSHIDA_NUM; /* set the degree of integration in the types/state.h file */
122     int           nh = opts->nhchainlength;
123
124     snew(GQ, nh);
125     mstepsi = mstepsj = ns;
126
127 /* if scalefac is NULL, we are doing the NHC of the barostat */
128
129     bBarostat = FALSE;
130     if (scalefac == nullptr)
131     {
132         bBarostat = TRUE;
133     }
134
135     for (i = 0; i < nvar; i++)
136     {
137
138         /* make it easier to iterate by selecting
139            out the sub-array that corresponds to this T group */
140
141         ivxi = &vxi[i*nh];
142         ixi  = &xi[i*nh];
143         if (bBarostat)
144         {
145             iQinv = &(MassQ->QPinv[i*nh]);
146             nd    = 1.0; /* THIS WILL CHANGE IF NOT ISOTROPIC */
147             reft  = std::max<real>(0, opts->ref_t[0]);
148             Ekin  = gmx::square(*veta)/MassQ->Winv;
149         }
150         else
151         {
152             iQinv  = &(MassQ->Qinv[i*nh]);
153             tcstat = &ekind->tcstat[i];
154             nd     = opts->nrdf[i];
155             reft   = std::max<real>(0, opts->ref_t[i]);
156             if (bEkinAveVel)
157             {
158                 Ekin = 2*trace(tcstat->ekinf)*tcstat->ekinscalef_nhc;
159             }
160             else
161             {
162                 Ekin = 2*trace(tcstat->ekinh)*tcstat->ekinscaleh_nhc;
163             }
164         }
165         kT = BOLTZ*reft;
166
167         for (mi = 0; mi < mstepsi; mi++)
168         {
169             for (mj = 0; mj < mstepsj; mj++)
170             {
171                 /* weighting for this step using Suzuki-Yoshida integration - fixed at 5 */
172                 dt = sy_const[ns][mj] * dtfull / mstepsi;
173
174                 /* compute the thermal forces */
175                 GQ[0] = iQinv[0]*(Ekin - nd*kT);
176
177                 for (j = 0; j < nh-1; j++)
178                 {
179                     if (iQinv[j+1] > 0)
180                     {
181                         /* we actually don't need to update here if we save the
182                            state of the GQ, but it's easier to just recompute*/
183                         GQ[j+1] = iQinv[j+1]*((gmx::square(ivxi[j])/iQinv[j])-kT);
184                     }
185                     else
186                     {
187                         GQ[j+1] = 0;
188                     }
189                 }
190
191                 ivxi[nh-1] += 0.25*dt*GQ[nh-1];
192                 for (j = nh-1; j > 0; j--)
193                 {
194                     Efac      = exp(-0.125*dt*ivxi[j]);
195                     ivxi[j-1] = Efac*(ivxi[j-1]*Efac + 0.25*dt*GQ[j-1]);
196                 }
197
198                 Efac = exp(-0.5*dt*ivxi[0]);
199                 if (bBarostat)
200                 {
201                     *veta *= Efac;
202                 }
203                 else
204                 {
205                     scalefac[i] *= Efac;
206                 }
207                 Ekin *= (Efac*Efac);
208
209                 /* Issue - if the KE is an average of the last and the current temperatures, then we might not be
210                    able to scale the kinetic energy directly with this factor.  Might take more bookkeeping -- have to
211                    think about this a bit more . . . */
212
213                 GQ[0] = iQinv[0]*(Ekin - nd*kT);
214
215                 /* update thermostat positions */
216                 for (j = 0; j < nh; j++)
217                 {
218                     ixi[j] += 0.5*dt*ivxi[j];
219                 }
220
221                 for (j = 0; j < nh-1; j++)
222                 {
223                     Efac    = exp(-0.125*dt*ivxi[j+1]);
224                     ivxi[j] = Efac*(ivxi[j]*Efac + 0.25*dt*GQ[j]);
225                     if (iQinv[j+1] > 0)
226                     {
227                         GQ[j+1] = iQinv[j+1]*((gmx::square(ivxi[j])/iQinv[j])-kT);
228                     }
229                     else
230                     {
231                         GQ[j+1] = 0;
232                     }
233                 }
234                 ivxi[nh-1] += 0.25*dt*GQ[nh-1];
235             }
236         }
237     }
238     sfree(GQ);
239 }
240
241 static void boxv_trotter(t_inputrec *ir, real *veta, real dt, tensor box,
242                          gmx_ekindata_t *ekind, tensor vir, real pcorr, t_extmass *MassQ)
243 {
244
245     real   pscal;
246     double alpha;
247     int    nwall;
248     real   GW, vol;
249     tensor ekinmod, localpres;
250
251     /* The heat bath is coupled to a separate barostat, the last temperature group.  In the
252        2006 Tuckerman et al paper., the order is iL_{T_baro} iL {T_part}
253      */
254
255     if (ir->epct == epctSEMIISOTROPIC)
256     {
257         nwall = 2;
258     }
259     else
260     {
261         nwall = 3;
262     }
263
264     /* eta is in pure units.  veta is in units of ps^-1. GW is in
265        units of ps^-2.  However, eta has a reference of 1 nm^3, so care must be
266        taken to use only RATIOS of eta in updating the volume. */
267
268     /* we take the partial pressure tensors, modify the
269        kinetic energy tensor, and recovert to pressure */
270
271     if (ir->opts.nrdf[0] == 0)
272     {
273         gmx_fatal(FARGS, "Barostat is coupled to a T-group with no degrees of freedom\n");
274     }
275     /* alpha factor for phase space volume, then multiply by the ekin scaling factor.  */
276     alpha  = 1.0 + DIM/((double)ir->opts.nrdf[0]);
277     alpha *= ekind->tcstat[0].ekinscalef_nhc;
278     msmul(ekind->ekin, alpha, ekinmod);
279     /* for now, we use Elr = 0, because if you want to get it right, you
280        really should be using PME. Maybe print a warning? */
281
282     pscal   = calc_pres(ir->ePBC, nwall, box, ekinmod, vir, localpres)+pcorr;
283
284     vol = det(box);
285     GW  = (vol*(MassQ->Winv/PRESFAC))*(DIM*pscal - trace(ir->ref_p));  /* W is in ps^2 * bar * nm^3 */
286
287     *veta += 0.5*dt*GW;
288 }
289
290 /*
291  * This file implements temperature and pressure coupling algorithms:
292  * For now only the Weak coupling and the modified weak coupling.
293  *
294  * Furthermore computation of pressure and temperature is done here
295  *
296  */
297
298 real calc_pres(int ePBC, int nwall, matrix box, tensor ekin, tensor vir,
299                tensor pres)
300 {
301     int  n, m;
302     real fac;
303
304     if (ePBC == epbcNONE || (ePBC == epbcXY && nwall != 2))
305     {
306         clear_mat(pres);
307     }
308     else
309     {
310         /* Uitzoeken welke ekin hier van toepassing is, zie Evans & Morris - E.
311          * Wrs. moet de druktensor gecorrigeerd worden voor de netto stroom in
312          * het systeem...
313          */
314
315         fac = PRESFAC*2.0/det(box);
316         for (n = 0; (n < DIM); n++)
317         {
318             for (m = 0; (m < DIM); m++)
319             {
320                 pres[n][m] = (ekin[n][m] - vir[n][m])*fac;
321             }
322         }
323
324         if (debug)
325         {
326             pr_rvecs(debug, 0, "PC: pres", pres, DIM);
327             pr_rvecs(debug, 0, "PC: ekin", ekin, DIM);
328             pr_rvecs(debug, 0, "PC: vir ", vir, DIM);
329             pr_rvecs(debug, 0, "PC: box ", box, DIM);
330         }
331     }
332     return trace(pres)/DIM;
333 }
334
335 real calc_temp(real ekin, real nrdf)
336 {
337     if (nrdf > 0)
338     {
339         return (2.0*ekin)/(nrdf*BOLTZ);
340     }
341     else
342     {
343         return 0;
344     }
345 }
346
347 /*! \brief Sets 1/mass for Parrinello-Rahman in wInv; NOTE: PRESFAC is not included, so not in GROMACS units! */
348 static void calcParrinelloRahmanInvMass(const t_inputrec *ir, const matrix box,
349                                         tensor wInv)
350 {
351     real maxBoxLength;
352
353     /* TODO: See if we can make the mass independent of the box size */
354     maxBoxLength = std::max(box[XX][XX], box[YY][YY]);
355     maxBoxLength = std::max(maxBoxLength, box[ZZ][ZZ]);
356
357     for (int d = 0; d < DIM; d++)
358     {
359         for (int n = 0; n < DIM; n++)
360         {
361             wInv[d][n] = (4*M_PI*M_PI*ir->compress[d][n])/(3*ir->tau_p*ir->tau_p*maxBoxLength);
362         }
363     }
364 }
365
366 void parrinellorahman_pcoupl(FILE *fplog, gmx_int64_t step,
367                              const t_inputrec *ir, real dt, const tensor pres,
368                              tensor box, tensor box_rel, tensor boxv,
369                              tensor M, matrix mu, gmx_bool bFirstStep)
370 {
371     /* This doesn't do any coordinate updating. It just
372      * integrates the box vector equations from the calculated
373      * acceleration due to pressure difference. We also compute
374      * the tensor M which is used in update to couple the particle
375      * coordinates to the box vectors.
376      *
377      * In Nose and Klein (Mol.Phys 50 (1983) no 5., p 1055) this is
378      * given as
379      *            -1    .           .     -1
380      * M_nk = (h')   * (h' * h + h' h) * h
381      *
382      * with the dots denoting time derivatives and h is the transformation from
383      * the scaled frame to the real frame, i.e. the TRANSPOSE of the box.
384      * This also goes for the pressure and M tensors - they are transposed relative
385      * to ours. Our equation thus becomes:
386      *
387      *                  -1       .    .           -1
388      * M_gmx = M_nk' = b  * (b * b' + b * b') * b'
389      *
390      * where b is the gromacs box matrix.
391      * Our box accelerations are given by
392      *   ..                                    ..
393      *   b = vol/W inv(box') * (P-ref_P)     (=h')
394      */
395
396     real   vol = box[XX][XX]*box[YY][YY]*box[ZZ][ZZ];
397     real   atot, arel, change;
398     tensor invbox, pdiff, t1, t2;
399
400     gmx::invertBoxMatrix(box, invbox);
401
402     if (!bFirstStep)
403     {
404         /* Note that PRESFAC does not occur here.
405          * The pressure and compressibility always occur as a product,
406          * therefore the pressure unit drops out.
407          */
408         tensor winv;
409         calcParrinelloRahmanInvMass(ir, box, winv);
410
411         m_sub(pres, ir->ref_p, pdiff);
412
413         if (ir->epct == epctSURFACETENSION)
414         {
415             /* Unlike Berendsen coupling it might not be trivial to include a z
416              * pressure correction here? On the other hand we don't scale the
417              * box momentarily, but change accelerations, so it might not be crucial.
418              */
419             real xy_pressure = 0.5*(pres[XX][XX]+pres[YY][YY]);
420             for (int d = 0; d < ZZ; d++)
421             {
422                 pdiff[d][d] = (xy_pressure-(pres[ZZ][ZZ]-ir->ref_p[d][d]/box[d][d]));
423             }
424         }
425
426         tmmul(invbox, pdiff, t1);
427         /* Move the off-diagonal elements of the 'force' to one side to ensure
428          * that we obey the box constraints.
429          */
430         for (int d = 0; d < DIM; d++)
431         {
432             for (int n = 0; n < d; n++)
433             {
434                 t1[d][n] += t1[n][d];
435                 t1[n][d]  = 0;
436             }
437         }
438
439         switch (ir->epct)
440         {
441             case epctANISOTROPIC:
442                 for (int d = 0; d < DIM; d++)
443                 {
444                     for (int n = 0; n <= d; n++)
445                     {
446                         t1[d][n] *= winv[d][n]*vol;
447                     }
448                 }
449                 break;
450             case epctISOTROPIC:
451                 /* calculate total volume acceleration */
452                 atot = box[XX][XX]*box[YY][YY]*t1[ZZ][ZZ]+
453                     box[XX][XX]*t1[YY][YY]*box[ZZ][ZZ]+
454                     t1[XX][XX]*box[YY][YY]*box[ZZ][ZZ];
455                 arel = atot/(3*vol);
456                 /* set all RELATIVE box accelerations equal, and maintain total V
457                  * change speed */
458                 for (int d = 0; d < DIM; d++)
459                 {
460                     for (int n = 0; n <= d; n++)
461                     {
462                         t1[d][n] = winv[0][0]*vol*arel*box[d][n];
463                     }
464                 }
465                 break;
466             case epctSEMIISOTROPIC:
467             case epctSURFACETENSION:
468                 /* Note the correction to pdiff above for surftens. coupling  */
469
470                 /* calculate total XY volume acceleration */
471                 atot = box[XX][XX]*t1[YY][YY]+t1[XX][XX]*box[YY][YY];
472                 arel = atot/(2*box[XX][XX]*box[YY][YY]);
473                 /* set RELATIVE XY box accelerations equal, and maintain total V
474                  * change speed. Dont change the third box vector accelerations */
475                 for (int d = 0; d < ZZ; d++)
476                 {
477                     for (int n = 0; n <= d; n++)
478                     {
479                         t1[d][n] = winv[d][n]*vol*arel*box[d][n];
480                     }
481                 }
482                 for (int n = 0; n < DIM; n++)
483                 {
484                     t1[ZZ][n] *= winv[ZZ][n]*vol;
485                 }
486                 break;
487             default:
488                 gmx_fatal(FARGS, "Parrinello-Rahman pressure coupling type %s "
489                           "not supported yet\n", EPCOUPLTYPETYPE(ir->epct));
490         }
491
492         real maxchange = 0;
493         for (int d = 0; d < DIM; d++)
494         {
495             for (int n = 0; n <= d; n++)
496             {
497                 boxv[d][n] += dt*t1[d][n];
498
499                 /* We do NOT update the box vectors themselves here, since
500                  * we need them for shifting later. It is instead done last
501                  * in the update() routine.
502                  */
503
504                 /* Calculate the change relative to diagonal elements-
505                    since it's perfectly ok for the off-diagonal ones to
506                    be zero it doesn't make sense to check the change relative
507                    to its current size.
508                  */
509
510                 change = std::fabs(dt*boxv[d][n]/box[d][d]);
511
512                 if (change > maxchange)
513                 {
514                     maxchange = change;
515                 }
516             }
517         }
518
519         if (maxchange > 0.01 && fplog)
520         {
521             char buf[22];
522             fprintf(fplog,
523                     "\nStep %s  Warning: Pressure scaling more than 1%%. "
524                     "This may mean your system\n is not yet equilibrated. "
525                     "Use of Parrinello-Rahman pressure coupling during\n"
526                     "equilibration can lead to simulation instability, "
527                     "and is discouraged.\n",
528                     gmx_step_str(step, buf));
529         }
530     }
531
532     preserve_box_shape(ir, box_rel, boxv);
533
534     mtmul(boxv, box, t1);   /* t1=boxv * b' */
535     mmul(invbox, t1, t2);
536     mtmul(t2, invbox, M);
537
538     /* Determine the scaling matrix mu for the coordinates */
539     for (int d = 0; d < DIM; d++)
540     {
541         for (int n = 0; n <= d; n++)
542         {
543             t1[d][n] = box[d][n] + dt*boxv[d][n];
544         }
545     }
546     preserve_box_shape(ir, box_rel, t1);
547     /* t1 is the box at t+dt, determine mu as the relative change */
548     mmul_ur0(invbox, t1, mu);
549 }
550
551 void berendsen_pcoupl(FILE *fplog, gmx_int64_t step,
552                       const t_inputrec *ir, real dt,
553                       const tensor pres, const matrix box,
554                       const matrix force_vir, const matrix constraint_vir,
555                       matrix mu, double *baros_integral)
556 {
557     int     d, n;
558     real    scalar_pressure, xy_pressure, p_corr_z;
559     char    buf[STRLEN];
560
561     /*
562      *  Calculate the scaling matrix mu
563      */
564     scalar_pressure = 0;
565     xy_pressure     = 0;
566     for (d = 0; d < DIM; d++)
567     {
568         scalar_pressure += pres[d][d]/DIM;
569         if (d != ZZ)
570         {
571             xy_pressure += pres[d][d]/(DIM-1);
572         }
573     }
574     /* Pressure is now in bar, everywhere. */
575 #define factor(d, m) (ir->compress[d][m]*dt/ir->tau_p)
576
577     /* mu has been changed from pow(1+...,1/3) to 1+.../3, since this is
578      * necessary for triclinic scaling
579      */
580     clear_mat(mu);
581     switch (ir->epct)
582     {
583         case epctISOTROPIC:
584             for (d = 0; d < DIM; d++)
585             {
586                 mu[d][d] = 1.0 - factor(d, d)*(ir->ref_p[d][d] - scalar_pressure) /DIM;
587             }
588             break;
589         case epctSEMIISOTROPIC:
590             for (d = 0; d < ZZ; d++)
591             {
592                 mu[d][d] = 1.0 - factor(d, d)*(ir->ref_p[d][d]-xy_pressure)/DIM;
593             }
594             mu[ZZ][ZZ] =
595                 1.0 - factor(ZZ, ZZ)*(ir->ref_p[ZZ][ZZ] - pres[ZZ][ZZ])/DIM;
596             break;
597         case epctANISOTROPIC:
598             for (d = 0; d < DIM; d++)
599             {
600                 for (n = 0; n < DIM; n++)
601                 {
602                     mu[d][n] = (d == n ? 1.0 : 0.0)
603                         -factor(d, n)*(ir->ref_p[d][n] - pres[d][n])/DIM;
604                 }
605             }
606             break;
607         case epctSURFACETENSION:
608             /* ir->ref_p[0/1] is the reference surface-tension times *
609              * the number of surfaces                                */
610             if (ir->compress[ZZ][ZZ])
611             {
612                 p_corr_z = dt/ir->tau_p*(ir->ref_p[ZZ][ZZ] - pres[ZZ][ZZ]);
613             }
614             else
615             {
616                 /* when the compressibity is zero, set the pressure correction   *
617                  * in the z-direction to zero to get the correct surface tension */
618                 p_corr_z = 0;
619             }
620             mu[ZZ][ZZ] = 1.0 - ir->compress[ZZ][ZZ]*p_corr_z;
621             for (d = 0; d < DIM-1; d++)
622             {
623                 mu[d][d] = 1.0 + factor(d, d)*(ir->ref_p[d][d]/(mu[ZZ][ZZ]*box[ZZ][ZZ])
624                                                - (pres[ZZ][ZZ]+p_corr_z - xy_pressure))/(DIM-1);
625             }
626             break;
627         default:
628             gmx_fatal(FARGS, "Berendsen pressure coupling type %s not supported yet\n",
629                       EPCOUPLTYPETYPE(ir->epct));
630     }
631     /* To fullfill the orientation restrictions on triclinic boxes
632      * we will set mu_yx, mu_zx and mu_zy to 0 and correct
633      * the other elements of mu to first order.
634      */
635     mu[YY][XX] += mu[XX][YY];
636     mu[ZZ][XX] += mu[XX][ZZ];
637     mu[ZZ][YY] += mu[YY][ZZ];
638     mu[XX][YY]  = 0;
639     mu[XX][ZZ]  = 0;
640     mu[YY][ZZ]  = 0;
641
642     /* Keep track of the work the barostat applies on the system.
643      * Without constraints force_vir tells us how Epot changes when scaling.
644      * With constraints constraint_vir gives us the constraint contribution
645      * to both Epot and Ekin. Although we are not scaling velocities, scaling
646      * the coordinates leads to scaling of distances involved in constraints.
647      * This in turn changes the angular momentum (even if the constrained
648      * distances are corrected at the next step). The kinetic component
649      * of the constraint virial captures the angular momentum change.
650      */
651     for (int d = 0; d < DIM; d++)
652     {
653         for (int n = 0; n <= d; n++)
654         {
655             *baros_integral -= 2*(mu[d][n] - (n == d ? 1 : 0))*(force_vir[d][n] + constraint_vir[d][n]);
656         }
657     }
658
659     if (debug)
660     {
661         pr_rvecs(debug, 0, "PC: pres ", pres, 3);
662         pr_rvecs(debug, 0, "PC: mu   ", mu, 3);
663     }
664
665     if (mu[XX][XX] < 0.99 || mu[XX][XX] > 1.01 ||
666         mu[YY][YY] < 0.99 || mu[YY][YY] > 1.01 ||
667         mu[ZZ][ZZ] < 0.99 || mu[ZZ][ZZ] > 1.01)
668     {
669         char buf2[22];
670         sprintf(buf, "\nStep %s  Warning: pressure scaling more than 1%%, "
671                 "mu: %g %g %g\n",
672                 gmx_step_str(step, buf2), mu[XX][XX], mu[YY][YY], mu[ZZ][ZZ]);
673         if (fplog)
674         {
675             fprintf(fplog, "%s", buf);
676         }
677         fprintf(stderr, "%s", buf);
678     }
679 }
680
681 void berendsen_pscale(const t_inputrec *ir, const matrix mu,
682                       matrix box, matrix box_rel,
683                       int start, int nr_atoms,
684                       rvec x[], const unsigned short cFREEZE[],
685                       t_nrnb *nrnb)
686 {
687     ivec   *nFreeze = ir->opts.nFreeze;
688     int     n, d;
689     int     nthreads gmx_unused;
690
691 #ifndef __clang_analyzer__
692     // cppcheck-suppress unreadVariable
693     nthreads = gmx_omp_nthreads_get(emntUpdate);
694 #endif
695
696     /* Scale the positions */
697 #pragma omp parallel for num_threads(nthreads) schedule(static)
698     for (n = start; n < start+nr_atoms; n++)
699     {
700         // Trivial OpenMP region that does not throw
701         int g;
702
703         if (cFREEZE == nullptr)
704         {
705             g = 0;
706         }
707         else
708         {
709             g = cFREEZE[n];
710         }
711
712         if (!nFreeze[g][XX])
713         {
714             x[n][XX] = mu[XX][XX]*x[n][XX]+mu[YY][XX]*x[n][YY]+mu[ZZ][XX]*x[n][ZZ];
715         }
716         if (!nFreeze[g][YY])
717         {
718             x[n][YY] = mu[YY][YY]*x[n][YY]+mu[ZZ][YY]*x[n][ZZ];
719         }
720         if (!nFreeze[g][ZZ])
721         {
722             x[n][ZZ] = mu[ZZ][ZZ]*x[n][ZZ];
723         }
724     }
725     /* compute final boxlengths */
726     for (d = 0; d < DIM; d++)
727     {
728         box[d][XX] = mu[XX][XX]*box[d][XX]+mu[YY][XX]*box[d][YY]+mu[ZZ][XX]*box[d][ZZ];
729         box[d][YY] = mu[YY][YY]*box[d][YY]+mu[ZZ][YY]*box[d][ZZ];
730         box[d][ZZ] = mu[ZZ][ZZ]*box[d][ZZ];
731     }
732
733     preserve_box_shape(ir, box_rel, box);
734
735     /* (un)shifting should NOT be done after this,
736      * since the box vectors might have changed
737      */
738     inc_nrnb(nrnb, eNR_PCOUPL, nr_atoms);
739 }
740
741 void berendsen_tcoupl(const t_inputrec *ir, const gmx_ekindata_t *ekind, real dt,
742                       std::vector<double> &therm_integral)
743 {
744     const t_grpopts *opts = &ir->opts;
745
746     for (int i = 0; (i < opts->ngtc); i++)
747     {
748         real Ek, T;
749
750         if (ir->eI == eiVV)
751         {
752             Ek = trace(ekind->tcstat[i].ekinf);
753             T  = ekind->tcstat[i].T;
754         }
755         else
756         {
757             Ek = trace(ekind->tcstat[i].ekinh);
758             T  = ekind->tcstat[i].Th;
759         }
760
761         if ((opts->tau_t[i] > 0) && (T > 0.0))
762         {
763             real reft               = std::max<real>(0, opts->ref_t[i]);
764             real lll                = std::sqrt(1.0 + (dt/opts->tau_t[i])*(reft/T-1.0));
765             ekind->tcstat[i].lambda = std::max<real>(std::min<real>(lll, 1.25), 0.8);
766         }
767         else
768         {
769             ekind->tcstat[i].lambda = 1.0;
770         }
771
772         /* Keep track of the amount of energy we are adding to the system */
773         therm_integral[i] -= (gmx::square(ekind->tcstat[i].lambda) - 1)*Ek;
774
775         if (debug)
776         {
777             fprintf(debug, "TC: group %d: T: %g, Lambda: %g\n",
778                     i, T, ekind->tcstat[i].lambda);
779         }
780     }
781 }
782
783 void andersen_tcoupl(t_inputrec *ir, gmx_int64_t step,
784                      const t_commrec *cr, const t_mdatoms *md, t_state *state, real rate, const gmx_bool *randomize, const real *boltzfac)
785 {
786     const int                                 *gatindex = (DOMAINDECOMP(cr) ? cr->dd->globalAtomIndices.data() : nullptr);
787     int                                        i;
788     int                                        gc = 0;
789     gmx::ThreeFry2x64<0>                       rng(ir->andersen_seed, gmx::RandomDomain::Thermostat);
790     gmx::UniformRealDistribution<real>         uniformDist;
791     gmx::TabulatedNormalDistribution<real, 14> normalDist;
792
793     /* randomize the velocities of the selected particles */
794
795     for (i = 0; i < md->homenr; i++)  /* now loop over the list of atoms */
796     {
797         int      ng = gatindex ? gatindex[i] : i;
798         gmx_bool bRandomize;
799
800         rng.restart(step, ng);
801
802         if (md->cTC)
803         {
804             gc = md->cTC[i];  /* assign the atom to a temperature group if there are more than one */
805         }
806         if (randomize[gc])
807         {
808             if (ir->etc == etcANDERSENMASSIVE)
809             {
810                 /* Randomize particle always */
811                 bRandomize = TRUE;
812             }
813             else
814             {
815                 /* Randomize particle probabilistically */
816                 uniformDist.reset();
817                 bRandomize = uniformDist(rng) < rate;
818             }
819             if (bRandomize)
820             {
821                 real scal;
822                 int  d;
823
824                 scal = std::sqrt(boltzfac[gc]*md->invmass[i]);
825
826                 normalDist.reset();
827
828                 for (d = 0; d < DIM; d++)
829                 {
830                     state->v[i][d] = scal*normalDist(rng);
831                 }
832             }
833         }
834     }
835 }
836
837
838 void nosehoover_tcoupl(t_grpopts *opts, gmx_ekindata_t *ekind, real dt,
839                        double xi[], double vxi[], t_extmass *MassQ)
840 {
841     int   i;
842     real  reft, oldvxi;
843
844     /* note that this routine does not include Nose-hoover chains yet. Should be easy to add. */
845
846     for (i = 0; (i < opts->ngtc); i++)
847     {
848         reft     = std::max<real>(0, opts->ref_t[i]);
849         oldvxi   = vxi[i];
850         vxi[i]  += dt*MassQ->Qinv[i]*(ekind->tcstat[i].Th - reft);
851         xi[i]   += dt*(oldvxi + vxi[i])*0.5;
852     }
853 }
854
855 void trotter_update(t_inputrec *ir, gmx_int64_t step, gmx_ekindata_t *ekind,
856                     gmx_enerdata_t *enerd, t_state *state,
857                     tensor vir, t_mdatoms *md,
858                     t_extmass *MassQ, int **trotter_seqlist, int trotter_seqno)
859 {
860
861     int             n, i, d, ngtc, gc = 0, t;
862     t_grp_tcstat   *tcstat;
863     t_grpopts      *opts;
864     gmx_int64_t     step_eff;
865     real            dt;
866     double         *scalefac, dtc;
867     int            *trotter_seq;
868     rvec            sumv = {0, 0, 0};
869     gmx_bool        bCouple;
870
871     if (trotter_seqno <= ettTSEQ2)
872     {
873         step_eff = step-1;  /* the velocity verlet calls are actually out of order -- the first half step
874                                is actually the last half step from the previous step.  Thus the first half step
875                                actually corresponds to the n-1 step*/
876
877     }
878     else
879     {
880         step_eff = step;
881     }
882
883     bCouple = (ir->nsttcouple == 1 ||
884                do_per_step(step_eff+ir->nsttcouple, ir->nsttcouple));
885
886     trotter_seq = trotter_seqlist[trotter_seqno];
887
888     if ((trotter_seq[0] == etrtSKIPALL) || (!bCouple))
889     {
890         return;
891     }
892     dtc  = ir->nsttcouple*ir->delta_t; /* This is OK for NPT, because nsttcouple == nstpcouple is enforcesd */
893     opts = &(ir->opts);                /* just for ease of referencing */
894     ngtc = opts->ngtc;
895     assert(ngtc > 0);
896     snew(scalefac, opts->ngtc);
897     for (i = 0; i < ngtc; i++)
898     {
899         scalefac[i] = 1;
900     }
901     /* execute the series of trotter updates specified in the trotterpart array */
902
903     for (i = 0; i < NTROTTERPARTS; i++)
904     {
905         /* allow for doubled intgrators by doubling dt instead of making 2 calls */
906         if ((trotter_seq[i] == etrtBAROV2) || (trotter_seq[i] == etrtBARONHC2) || (trotter_seq[i] == etrtNHC2))
907         {
908             dt = 2 * dtc;
909         }
910         else
911         {
912             dt = dtc;
913         }
914
915         switch (trotter_seq[i])
916         {
917             case etrtBAROV:
918             case etrtBAROV2:
919                 boxv_trotter(ir, &(state->veta), dt, state->box, ekind, vir,
920                              enerd->term[F_PDISPCORR], MassQ);
921                 break;
922             case etrtBARONHC:
923             case etrtBARONHC2:
924                 NHC_trotter(opts, state->nnhpres, ekind, dt, state->nhpres_xi.data(),
925                             state->nhpres_vxi.data(), nullptr, &(state->veta), MassQ, FALSE);
926                 break;
927             case etrtNHC:
928             case etrtNHC2:
929                 NHC_trotter(opts, opts->ngtc, ekind, dt, state->nosehoover_xi.data(),
930                             state->nosehoover_vxi.data(), scalefac, nullptr, MassQ, (ir->eI == eiVV));
931                 /* need to rescale the kinetic energies and velocities here.  Could
932                    scale the velocities later, but we need them scaled in order to
933                    produce the correct outputs, so we'll scale them here. */
934
935                 for (t = 0; t < ngtc; t++)
936                 {
937                     tcstat                  = &ekind->tcstat[t];
938                     tcstat->vscale_nhc      = scalefac[t];
939                     tcstat->ekinscaleh_nhc *= (scalefac[t]*scalefac[t]);
940                     tcstat->ekinscalef_nhc *= (scalefac[t]*scalefac[t]);
941                 }
942                 /* now that we've scaled the groupwise velocities, we can add them up to get the total */
943                 /* but do we actually need the total? */
944
945                 /* modify the velocities as well */
946                 for (n = 0; n < md->homenr; n++)
947                 {
948                     if (md->cTC) /* does this conditional need to be here? is this always true?*/
949                     {
950                         gc = md->cTC[n];
951                     }
952                     for (d = 0; d < DIM; d++)
953                     {
954                         state->v[n][d] *= scalefac[gc];
955                     }
956
957                     if (debug)
958                     {
959                         for (d = 0; d < DIM; d++)
960                         {
961                             sumv[d] += (state->v[n][d])/md->invmass[n];
962                         }
963                     }
964                 }
965                 break;
966             default:
967                 break;
968         }
969     }
970     /* check for conserved momentum -- worth looking at this again eventually, but not working right now.*/
971     sfree(scalefac);
972 }
973
974
975 extern void init_npt_masses(t_inputrec *ir, t_state *state, t_extmass *MassQ, gmx_bool bInit)
976 {
977     int           n, i, j, d, ngtc, nh;
978     t_grpopts    *opts;
979     real          reft, kT, ndj, nd;
980
981     opts    = &(ir->opts); /* just for ease of referencing */
982     ngtc    = ir->opts.ngtc;
983     nh      = state->nhchainlength;
984
985     if (ir->eI == eiMD)
986     {
987         if (bInit)
988         {
989             snew(MassQ->Qinv, ngtc);
990         }
991         for (i = 0; (i < ngtc); i++)
992         {
993             if ((opts->tau_t[i] > 0) && (opts->ref_t[i] > 0))
994             {
995                 MassQ->Qinv[i] = 1.0/(gmx::square(opts->tau_t[i]/M_2PI)*opts->ref_t[i]);
996             }
997             else
998             {
999                 MassQ->Qinv[i] = 0.0;
1000             }
1001         }
1002     }
1003     else if (EI_VV(ir->eI))
1004     {
1005         /* Set pressure variables */
1006
1007         if (bInit)
1008         {
1009             if (state->vol0 == 0)
1010             {
1011                 state->vol0 = det(state->box);
1012                 /* because we start by defining a fixed
1013                    compressibility, we need the volume at this
1014                    compressibility to solve the problem. */
1015             }
1016         }
1017
1018         /* units are nm^3 * ns^2 / (nm^3 * bar / kJ/mol) = kJ/mol  */
1019         /* Consider evaluating eventually if this the right mass to use.  All are correct, some might be more stable  */
1020         MassQ->Winv = (PRESFAC*trace(ir->compress)*BOLTZ*opts->ref_t[0])/(DIM*state->vol0*gmx::square(ir->tau_p/M_2PI));
1021         /* An alternate mass definition, from Tuckerman et al. */
1022         /* MassQ->Winv = 1.0/(gmx::square(ir->tau_p/M_2PI)*(opts->nrdf[0]+DIM)*BOLTZ*opts->ref_t[0]); */
1023         for (d = 0; d < DIM; d++)
1024         {
1025             for (n = 0; n < DIM; n++)
1026             {
1027                 MassQ->Winvm[d][n] = PRESFAC*ir->compress[d][n]/(state->vol0*gmx::square(ir->tau_p/M_2PI));
1028                 /* not clear this is correct yet for the anisotropic case. Will need to reevaluate
1029                    before using MTTK for anisotropic states.*/
1030             }
1031         }
1032         /* Allocate space for thermostat variables */
1033         if (bInit)
1034         {
1035             snew(MassQ->Qinv, ngtc*nh);
1036         }
1037
1038         /* now, set temperature variables */
1039         for (i = 0; i < ngtc; i++)
1040         {
1041             if (opts->tau_t[i] > 0 && opts->ref_t[i] > 0 && opts->nrdf[i] > 0)
1042             {
1043                 reft = std::max<real>(0, opts->ref_t[i]);
1044                 nd   = opts->nrdf[i];
1045                 kT   = BOLTZ*reft;
1046                 for (j = 0; j < nh; j++)
1047                 {
1048                     if (j == 0)
1049                     {
1050                         ndj = nd;
1051                     }
1052                     else
1053                     {
1054                         ndj = 1;
1055                     }
1056                     MassQ->Qinv[i*nh+j]   = 1.0/(gmx::square(opts->tau_t[i]/M_2PI)*ndj*kT);
1057                 }
1058             }
1059             else
1060             {
1061                 for (j = 0; j < nh; j++)
1062                 {
1063                     MassQ->Qinv[i*nh+j] = 0.0;
1064                 }
1065             }
1066         }
1067     }
1068 }
1069
1070 int **init_npt_vars(t_inputrec *ir, t_state *state, t_extmass *MassQ, gmx_bool bTrotter)
1071 {
1072     int           i, j, nnhpres, nh;
1073     t_grpopts    *opts;
1074     real          bmass, qmass, reft, kT;
1075     int         **trotter_seq;
1076
1077     opts    = &(ir->opts); /* just for ease of referencing */
1078     nnhpres = state->nnhpres;
1079     nh      = state->nhchainlength;
1080
1081     if (EI_VV(ir->eI) && (ir->epc == epcMTTK) && (ir->etc != etcNOSEHOOVER))
1082     {
1083         gmx_fatal(FARGS, "Cannot do MTTK pressure coupling without Nose-Hoover temperature control");
1084     }
1085
1086     init_npt_masses(ir, state, MassQ, TRUE);
1087
1088     /* first, initialize clear all the trotter calls */
1089     snew(trotter_seq, ettTSEQMAX);
1090     for (i = 0; i < ettTSEQMAX; i++)
1091     {
1092         snew(trotter_seq[i], NTROTTERPARTS);
1093         for (j = 0; j < NTROTTERPARTS; j++)
1094         {
1095             trotter_seq[i][j] = etrtNONE;
1096         }
1097         trotter_seq[i][0] = etrtSKIPALL;
1098     }
1099
1100     if (!bTrotter)
1101     {
1102         /* no trotter calls, so we never use the values in the array.
1103          * We access them (so we need to define them, but ignore
1104          * then.*/
1105
1106         return trotter_seq;
1107     }
1108
1109     /* compute the kinetic energy by using the half step velocities or
1110      * the kinetic energies, depending on the order of the trotter calls */
1111
1112     if (ir->eI == eiVV)
1113     {
1114         if (inputrecNptTrotter(ir))
1115         {
1116             /* This is the complicated version - there are 4 possible calls, depending on ordering.
1117                We start with the initial one. */
1118             /* first, a round that estimates veta. */
1119             trotter_seq[0][0] = etrtBAROV;
1120
1121             /* trotter_seq[1] is etrtNHC for 1/2 step velocities - leave zero */
1122
1123             /* The first half trotter update */
1124             trotter_seq[2][0] = etrtBAROV;
1125             trotter_seq[2][1] = etrtNHC;
1126             trotter_seq[2][2] = etrtBARONHC;
1127
1128             /* The second half trotter update */
1129             trotter_seq[3][0] = etrtBARONHC;
1130             trotter_seq[3][1] = etrtNHC;
1131             trotter_seq[3][2] = etrtBAROV;
1132
1133             /* trotter_seq[4] is etrtNHC for second 1/2 step velocities - leave zero */
1134
1135         }
1136         else if (inputrecNvtTrotter(ir))
1137         {
1138             /* This is the easy version - there are only two calls, both the same.
1139                Otherwise, even easier -- no calls  */
1140             trotter_seq[2][0] = etrtNHC;
1141             trotter_seq[3][0] = etrtNHC;
1142         }
1143         else if (inputrecNphTrotter(ir))
1144         {
1145             /* This is the complicated version - there are 4 possible calls, depending on ordering.
1146                We start with the initial one. */
1147             /* first, a round that estimates veta. */
1148             trotter_seq[0][0] = etrtBAROV;
1149
1150             /* trotter_seq[1] is etrtNHC for 1/2 step velocities - leave zero */
1151
1152             /* The first half trotter update */
1153             trotter_seq[2][0] = etrtBAROV;
1154             trotter_seq[2][1] = etrtBARONHC;
1155
1156             /* The second half trotter update */
1157             trotter_seq[3][0] = etrtBARONHC;
1158             trotter_seq[3][1] = etrtBAROV;
1159
1160             /* trotter_seq[4] is etrtNHC for second 1/2 step velocities - leave zero */
1161         }
1162     }
1163     else if (ir->eI == eiVVAK)
1164     {
1165         if (inputrecNptTrotter(ir))
1166         {
1167             /* This is the complicated version - there are 4 possible calls, depending on ordering.
1168                We start with the initial one. */
1169             /* first, a round that estimates veta. */
1170             trotter_seq[0][0] = etrtBAROV;
1171
1172             /* The first half trotter update, part 1 -- double update, because it commutes */
1173             trotter_seq[1][0] = etrtNHC;
1174
1175             /* The first half trotter update, part 2 */
1176             trotter_seq[2][0] = etrtBAROV;
1177             trotter_seq[2][1] = etrtBARONHC;
1178
1179             /* The second half trotter update, part 1 */
1180             trotter_seq[3][0] = etrtBARONHC;
1181             trotter_seq[3][1] = etrtBAROV;
1182
1183             /* The second half trotter update */
1184             trotter_seq[4][0] = etrtNHC;
1185         }
1186         else if (inputrecNvtTrotter(ir))
1187         {
1188             /* This is the easy version - there is only one call, both the same.
1189                Otherwise, even easier -- no calls  */
1190             trotter_seq[1][0] = etrtNHC;
1191             trotter_seq[4][0] = etrtNHC;
1192         }
1193         else if (inputrecNphTrotter(ir))
1194         {
1195             /* This is the complicated version - there are 4 possible calls, depending on ordering.
1196                We start with the initial one. */
1197             /* first, a round that estimates veta. */
1198             trotter_seq[0][0] = etrtBAROV;
1199
1200             /* The first half trotter update, part 1 -- leave zero */
1201             trotter_seq[1][0] = etrtNHC;
1202
1203             /* The first half trotter update, part 2 */
1204             trotter_seq[2][0] = etrtBAROV;
1205             trotter_seq[2][1] = etrtBARONHC;
1206
1207             /* The second half trotter update, part 1 */
1208             trotter_seq[3][0] = etrtBARONHC;
1209             trotter_seq[3][1] = etrtBAROV;
1210
1211             /* The second half trotter update -- blank for now */
1212         }
1213     }
1214
1215     switch (ir->epct)
1216     {
1217         case epctISOTROPIC:
1218         default:
1219             bmass = DIM*DIM; /* recommended mass parameters for isotropic barostat */
1220     }
1221
1222     snew(MassQ->QPinv, nnhpres*opts->nhchainlength);
1223
1224     /* barostat temperature */
1225     if ((ir->tau_p > 0) && (opts->ref_t[0] > 0))
1226     {
1227         reft = std::max<real>(0, opts->ref_t[0]);
1228         kT   = BOLTZ*reft;
1229         for (i = 0; i < nnhpres; i++)
1230         {
1231             for (j = 0; j < nh; j++)
1232             {
1233                 if (j == 0)
1234                 {
1235                     qmass = bmass;
1236                 }
1237                 else
1238                 {
1239                     qmass = 1;
1240                 }
1241                 MassQ->QPinv[i*opts->nhchainlength+j]   = 1.0/(gmx::square(opts->tau_t[0]/M_2PI)*qmass*kT);
1242             }
1243         }
1244     }
1245     else
1246     {
1247         for (i = 0; i < nnhpres; i++)
1248         {
1249             for (j = 0; j < nh; j++)
1250             {
1251                 MassQ->QPinv[i*nh+j] = 0.0;
1252             }
1253         }
1254     }
1255     return trotter_seq;
1256 }
1257
1258 static real energyNoseHoover(const t_inputrec *ir, const t_state *state, const t_extmass *MassQ)
1259 {
1260     real energy = 0;
1261
1262     int  nh     = state->nhchainlength;
1263
1264     for (int i = 0; i < ir->opts.ngtc; i++)
1265     {
1266         const double *ixi   = &state->nosehoover_xi[i*nh];
1267         const double *ivxi  = &state->nosehoover_vxi[i*nh];
1268         const double *iQinv = &(MassQ->Qinv[i*nh]);
1269
1270         int           nd    = ir->opts.nrdf[i];
1271         real          reft  = std::max<real>(ir->opts.ref_t[i], 0);
1272         real          kT    = BOLTZ * reft;
1273
1274         if (nd > 0.0)
1275         {
1276             if (inputrecNvtTrotter(ir))
1277             {
1278                 /* contribution from the thermal momenta of the NH chain */
1279                 for (int j = 0; j < nh; j++)
1280                 {
1281                     if (iQinv[j] > 0)
1282                     {
1283                         energy += 0.5*gmx::square(ivxi[j])/iQinv[j];
1284                         /* contribution from the thermal variable of the NH chain */
1285                         int ndj;
1286                         if (j == 0)
1287                         {
1288                             ndj = nd;
1289                         }
1290                         else
1291                         {
1292                             ndj = 1.0;
1293                         }
1294                         energy += ndj*ixi[j]*kT;
1295                     }
1296                 }
1297             }
1298             else  /* Other non Trotter temperature NH control  -- no chains yet. */
1299             {
1300                 energy += 0.5*BOLTZ*nd*gmx::square(ivxi[0])/iQinv[0];
1301                 energy += nd*ixi[0]*kT;
1302             }
1303         }
1304     }
1305
1306     return energy;
1307 }
1308
1309 /* Returns the energy from the barostat thermostat chain */
1310 static real energyPressureMTTK(const t_inputrec *ir, const t_state *state, const t_extmass *MassQ)
1311 {
1312     real energy = 0;
1313
1314     int  nh     = state->nhchainlength;
1315
1316     for (int i = 0; i < state->nnhpres; i++)
1317     {
1318         /* note -- assumes only one degree of freedom that is thermostatted in barostat */
1319         real    reft  = std::max<real>(ir->opts.ref_t[0], 0.0); /* using 'System' temperature */
1320         real    kT    = BOLTZ * reft;
1321
1322         for (int j = 0; j < nh; j++)
1323         {
1324             double iQinv = MassQ->QPinv[i*nh + j];
1325             if (iQinv > 0)
1326             {
1327                 energy += 0.5*gmx::square(state->nhpres_vxi[i*nh + j]/iQinv);
1328                 /* contribution from the thermal variable of the NH chain */
1329                 energy += state->nhpres_xi[i*nh + j]*kT;
1330             }
1331             if (debug)
1332             {
1333                 fprintf(debug, "P-T-group: %10d Chain %4d ThermV: %15.8f ThermX: %15.8f", i, j, state->nhpres_vxi[i*nh + j], state->nhpres_xi[i*nh + j]);
1334             }
1335         }
1336     }
1337
1338     return energy;
1339 }
1340
1341 /* Returns the energy accumulated by the V-rescale or Berendsen thermostat */
1342 static real energyVrescale(const t_inputrec *ir, const t_state *state)
1343 {
1344     real energy = 0;
1345     for (int i = 0; i < ir->opts.ngtc; i++)
1346     {
1347         energy += state->therm_integral[i];
1348     }
1349
1350     return energy;
1351 }
1352
1353 real NPT_energy(const t_inputrec *ir, const t_state *state, const t_extmass *MassQ)
1354 {
1355     real energyNPT = 0;
1356
1357     if (ir->epc != epcNO)
1358     {
1359         /* Compute the contribution of the pressure to the conserved quantity*/
1360
1361         real vol  = det(state->box);
1362
1363         switch (ir->epc)
1364         {
1365             case epcPARRINELLORAHMAN:
1366             {
1367                 /* contribution from the pressure momenta */
1368                 tensor invMass;
1369                 calcParrinelloRahmanInvMass(ir, state->box, invMass);
1370                 for (int d = 0; d < DIM; d++)
1371                 {
1372                     for (int n = 0; n <= d; n++)
1373                     {
1374                         if (invMass[d][n] > 0)
1375                         {
1376                             energyNPT += 0.5*gmx::square(state->boxv[d][n])/(invMass[d][n]*PRESFAC);
1377                         }
1378                     }
1379                 }
1380
1381                 /* Contribution from the PV term.
1382                  * Not that with non-zero off-diagonal reference pressures,
1383                  * i.e. applied shear stresses, there are additional terms.
1384                  * We don't support this here, since that requires keeping
1385                  * track of unwrapped box diagonal elements. This case is
1386                  * excluded in integratorHasConservedEnergyQuantity().
1387                  */
1388                 energyNPT += vol*trace(ir->ref_p)/(DIM*PRESFAC);
1389                 break;
1390             }
1391             case epcMTTK:
1392                 /* contribution from the pressure momenta */
1393                 energyNPT += 0.5*gmx::square(state->veta)/MassQ->Winv;
1394
1395                 /* contribution from the PV term */
1396                 energyNPT += vol*trace(ir->ref_p)/(DIM*PRESFAC);
1397
1398                 if (ir->epc == epcMTTK)
1399                 {
1400                     /* contribution from the MTTK chain */
1401                     energyNPT += energyPressureMTTK(ir, state, MassQ);
1402                 }
1403                 break;
1404             case epcBERENDSEN:
1405                 energyNPT += state->baros_integral;
1406                 break;
1407             default:
1408                 GMX_RELEASE_ASSERT(false, "Conserved energy quantity for pressure coupling is not handled. A case should be added with either the conserved quantity added or nothing added and an exclusion added to integratorHasConservedEnergyQuantity().");
1409         }
1410     }
1411
1412     switch (ir->etc)
1413     {
1414         case etcNO:
1415             break;
1416         case etcVRESCALE:
1417         case etcBERENDSEN:
1418             energyNPT += energyVrescale(ir, state);
1419             break;
1420         case etcNOSEHOOVER:
1421             energyNPT += energyNoseHoover(ir, state, MassQ);
1422             break;
1423         case etcANDERSEN:
1424         case etcANDERSENMASSIVE:
1425             // Not supported, excluded in integratorHasConservedEnergyQuantity()
1426             break;
1427         default:
1428             GMX_RELEASE_ASSERT(false, "Conserved energy quantity for temperature coupling is not handled. A case should be added with either the conserved quantity added or nothing added and an exclusion added to integratorHasConservedEnergyQuantity().");
1429     }
1430
1431     return energyNPT;
1432 }
1433
1434
1435 static real vrescale_sumnoises(real                            nn,
1436                                gmx::ThreeFry2x64<>            *rng,
1437                                gmx::NormalDistribution<real>  *normalDist)
1438 {
1439 /*
1440  * Returns the sum of nn independent gaussian noises squared
1441  * (i.e. equivalent to summing the square of the return values
1442  * of nn calls to a normal distribution).
1443  */
1444     const real                     ndeg_tol = 0.0001;
1445     real                           r;
1446     gmx::GammaDistribution<real>   gammaDist(0.5*nn, 1.0);
1447
1448     if (nn < 2 + ndeg_tol)
1449     {
1450         int  nn_int, i;
1451         real gauss;
1452
1453         nn_int = (int)(nn + 0.5);
1454
1455         if (nn - nn_int < -ndeg_tol || nn - nn_int > ndeg_tol)
1456         {
1457             gmx_fatal(FARGS, "The v-rescale thermostat was called with a group with #DOF=%f, but for #DOF<3 only integer #DOF are supported", nn + 1);
1458         }
1459
1460         r = 0;
1461         for (i = 0; i < nn_int; i++)
1462         {
1463             gauss = (*normalDist)(*rng);
1464             r    += gauss*gauss;
1465         }
1466     }
1467     else
1468     {
1469         /* Use a gamma distribution for any real nn > 2 */
1470         r = 2.0*gammaDist(*rng);
1471     }
1472
1473     return r;
1474 }
1475
1476 static real vrescale_resamplekin(real kk, real sigma, real ndeg, real taut,
1477                                  gmx_int64_t step, gmx_int64_t seed)
1478 {
1479 /*
1480  * Generates a new value for the kinetic energy,
1481  * according to Bussi et al JCP (2007), Eq. (A7)
1482  * kk:    present value of the kinetic energy of the atoms to be thermalized (in arbitrary units)
1483  * sigma: target average value of the kinetic energy (ndeg k_b T/2)  (in the same units as kk)
1484  * ndeg:  number of degrees of freedom of the atoms to be thermalized
1485  * taut:  relaxation time of the thermostat, in units of 'how often this routine is called'
1486  */
1487     real                           factor, rr, ekin_new;
1488     gmx::ThreeFry2x64<64>          rng(seed, gmx::RandomDomain::Thermostat);
1489     gmx::NormalDistribution<real>  normalDist;
1490
1491     if (taut > 0.1)
1492     {
1493         factor = exp(-1.0/taut);
1494     }
1495     else
1496     {
1497         factor = 0.0;
1498     }
1499
1500     rng.restart(step, 0);
1501
1502     rr = normalDist(rng);
1503
1504     ekin_new =
1505         kk +
1506         (1.0 - factor)*(sigma*(vrescale_sumnoises(ndeg-1, &rng, &normalDist) + rr*rr)/ndeg - kk) +
1507         2.0*rr*std::sqrt(kk*sigma/ndeg*(1.0 - factor)*factor);
1508
1509     return ekin_new;
1510 }
1511
1512 void vrescale_tcoupl(t_inputrec *ir, gmx_int64_t step,
1513                      gmx_ekindata_t *ekind, real dt,
1514                      double therm_integral[])
1515 {
1516     t_grpopts *opts;
1517     int        i;
1518     real       Ek, Ek_ref1, Ek_ref, Ek_new;
1519
1520     opts = &ir->opts;
1521
1522     for (i = 0; (i < opts->ngtc); i++)
1523     {
1524         if (ir->eI == eiVV)
1525         {
1526             Ek = trace(ekind->tcstat[i].ekinf);
1527         }
1528         else
1529         {
1530             Ek = trace(ekind->tcstat[i].ekinh);
1531         }
1532
1533         if (opts->tau_t[i] >= 0 && opts->nrdf[i] > 0 && Ek > 0)
1534         {
1535             Ek_ref1 = 0.5*opts->ref_t[i]*BOLTZ;
1536             Ek_ref  = Ek_ref1*opts->nrdf[i];
1537
1538             Ek_new  = vrescale_resamplekin(Ek, Ek_ref, opts->nrdf[i],
1539                                            opts->tau_t[i]/dt,
1540                                            step, ir->ld_seed);
1541
1542             /* Analytically Ek_new>=0, but we check for rounding errors */
1543             if (Ek_new <= 0)
1544             {
1545                 ekind->tcstat[i].lambda = 0.0;
1546             }
1547             else
1548             {
1549                 ekind->tcstat[i].lambda = std::sqrt(Ek_new/Ek);
1550             }
1551
1552             therm_integral[i] -= Ek_new - Ek;
1553
1554             if (debug)
1555             {
1556                 fprintf(debug, "TC: group %d: Ekr %g, Ek %g, Ek_new %g, Lambda: %g\n",
1557                         i, Ek_ref, Ek, Ek_new, ekind->tcstat[i].lambda);
1558             }
1559         }
1560         else
1561         {
1562             ekind->tcstat[i].lambda = 1.0;
1563         }
1564     }
1565 }
1566
1567 void rescale_velocities(gmx_ekindata_t *ekind, t_mdatoms *mdatoms,
1568                         int start, int end, rvec v[])
1569 {
1570     t_grp_acc      *gstat;
1571     t_grp_tcstat   *tcstat;
1572     unsigned short *cACC, *cTC;
1573     int             ga, gt, n, d;
1574     real            lg;
1575     rvec            vrel;
1576
1577     tcstat = ekind->tcstat;
1578     cTC    = mdatoms->cTC;
1579
1580     if (ekind->bNEMD)
1581     {
1582         gstat  = ekind->grpstat;
1583         cACC   = mdatoms->cACC;
1584
1585         ga = 0;
1586         gt = 0;
1587         for (n = start; n < end; n++)
1588         {
1589             if (cACC)
1590             {
1591                 ga   = cACC[n];
1592             }
1593             if (cTC)
1594             {
1595                 gt   = cTC[n];
1596             }
1597             /* Only scale the velocity component relative to the COM velocity */
1598             rvec_sub(v[n], gstat[ga].u, vrel);
1599             lg = tcstat[gt].lambda;
1600             for (d = 0; d < DIM; d++)
1601             {
1602                 v[n][d] = gstat[ga].u[d] + lg*vrel[d];
1603             }
1604         }
1605     }
1606     else
1607     {
1608         gt = 0;
1609         for (n = start; n < end; n++)
1610         {
1611             if (cTC)
1612             {
1613                 gt   = cTC[n];
1614             }
1615             lg = tcstat[gt].lambda;
1616             for (d = 0; d < DIM; d++)
1617             {
1618                 v[n][d] *= lg;
1619             }
1620         }
1621     }
1622 }
1623
1624
1625 /* set target temperatures if we are annealing */
1626 void update_annealing_target_temp(t_inputrec *ir, real t, gmx_update_t *upd)
1627 {
1628     int  i, j, n, npoints;
1629     real pert, thist = 0, x;
1630
1631     for (i = 0; i < ir->opts.ngtc; i++)
1632     {
1633         npoints = ir->opts.anneal_npoints[i];
1634         switch (ir->opts.annealing[i])
1635         {
1636             case eannNO:
1637                 continue;
1638             case  eannPERIODIC:
1639                 /* calculate time modulo the period */
1640                 pert  = ir->opts.anneal_time[i][npoints-1];
1641                 n     = static_cast<int>(t / pert);
1642                 thist = t - n*pert; /* modulo time */
1643                 /* Make sure rounding didn't get us outside the interval */
1644                 if (std::fabs(thist-pert) < GMX_REAL_EPS*100)
1645                 {
1646                     thist = 0;
1647                 }
1648                 break;
1649             case eannSINGLE:
1650                 thist = t;
1651                 break;
1652             default:
1653                 gmx_fatal(FARGS, "Death horror in update_annealing_target_temp (i=%d/%d npoints=%d)", i, ir->opts.ngtc, npoints);
1654         }
1655         /* We are doing annealing for this group if we got here,
1656          * and we have the (relative) time as thist.
1657          * calculate target temp */
1658         j = 0;
1659         while ((j < npoints-1) && (thist > (ir->opts.anneal_time[i][j+1])))
1660         {
1661             j++;
1662         }
1663         if (j < npoints-1)
1664         {
1665             /* Found our position between points j and j+1.
1666              * Interpolate: x is the amount from j+1, (1-x) from point j
1667              * First treat possible jumps in temperature as a special case.
1668              */
1669             if ((ir->opts.anneal_time[i][j+1]-ir->opts.anneal_time[i][j]) < GMX_REAL_EPS*100)
1670             {
1671                 ir->opts.ref_t[i] = ir->opts.anneal_temp[i][j+1];
1672             }
1673             else
1674             {
1675                 x = ((thist-ir->opts.anneal_time[i][j])/
1676                      (ir->opts.anneal_time[i][j+1]-ir->opts.anneal_time[i][j]));
1677                 ir->opts.ref_t[i] = x*ir->opts.anneal_temp[i][j+1]+(1-x)*ir->opts.anneal_temp[i][j];
1678             }
1679         }
1680         else
1681         {
1682             ir->opts.ref_t[i] = ir->opts.anneal_temp[i][npoints-1];
1683         }
1684     }
1685
1686     update_temperature_constants(upd, ir);
1687 }