909587bddc088df961c532f48af5b0b4945bd47e
[alexxy/gromacs.git] / src / gromacs / mdlib / repl_ex.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) 2011,2012,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
38 #include "gmxpre.h"
39
40 #include "repl_ex.h"
41
42 #include "config.h"
43
44 #include <cmath>
45
46 #include <random>
47
48 #include "gromacs/domdec/collect.h"
49 #include "gromacs/gmxlib/network.h"
50 #include "gromacs/math/units.h"
51 #include "gromacs/math/vec.h"
52 #include "gromacs/mdlib/main.h"
53 #include "gromacs/mdtypes/commrec.h"
54 #include "gromacs/mdtypes/forcerec.h" // only for gmx_enerdata_t
55 #include "gromacs/mdtypes/inputrec.h"
56 #include "gromacs/mdtypes/md_enums.h"
57 #include "gromacs/mdtypes/state.h"
58 #include "gromacs/random/threefry.h"
59 #include "gromacs/random/uniformintdistribution.h"
60 #include "gromacs/random/uniformrealdistribution.h"
61 #include "gromacs/utility/fatalerror.h"
62 #include "gromacs/utility/pleasecite.h"
63 #include "gromacs/utility/smalloc.h"
64
65
66 #define PROBABILITYCUTOFF 100
67 /* we don't bother evaluating if events are more rare than exp(-100) = 3.7x10^-44 */
68
69 //! Rank in the multisimulaiton
70 #define MSRANK(ms, nodeid)  (nodeid)
71
72 enum {
73     ereTEMP, ereLAMBDA, ereENDSINGLE, ereTL, ereNR
74 };
75 const char *erename[ereNR] = { "temperature", "lambda", "end_single_marker", "temperature and lambda"};
76 /* end_single_marker merely notes the end of single variable replica exchange. All types higher than
77    it are multiple replica exchange methods */
78 /* Eventually, should add 'pressure', 'temperature and pressure', 'lambda_and_pressure', 'temperature_lambda_pressure'?;
79    Let's wait until we feel better about the pressure control methods giving exact ensembles.  Right now, we assume constant pressure  */
80
81 typedef struct gmx_repl_ex
82 {
83     int       repl;        /* replica ID */
84     int       nrepl;       /* total number of replica */
85     real      temp;        /* temperature */
86     int       type;        /* replica exchange type from ere enum */
87     real    **q;           /* quantity, e.g. temperature or lambda; first index is ere, second index is replica ID */
88     gmx_bool  bNPT;        /* use constant pressure and temperature */
89     real     *pres;        /* replica pressures */
90     int      *ind;         /* replica indices */
91     int      *allswaps;    /* used for keeping track of all the replica swaps */
92     int       nst;         /* replica exchange interval (number of steps) */
93     int       nex;         /* number of exchanges per interval */
94     int       seed;        /* random seed */
95     int       nattempt[2]; /* number of even and odd replica change attempts */
96     real     *prob_sum;    /* sum of probabilities */
97     int     **nmoves;      /* number of moves between replicas i and j */
98     int      *nexchange;   /* i-th element of the array is the number of exchanges between replica i-1 and i */
99
100     /* these are helper arrays for replica exchange; allocated here so they
101        don't have to be allocated each time */
102     int      *destinations;
103     int     **cyclic;
104     int     **order;
105     int      *tmpswap;
106     gmx_bool *incycle;
107     gmx_bool *bEx;
108
109     /* helper arrays to hold the quantities that are exchanged */
110     real  *prob;
111     real  *Epot;
112     real  *beta;
113     real  *Vol;
114     real **de;
115
116 } t_gmx_repl_ex;
117
118 static gmx_bool repl_quantity(const gmx_multisim_t *ms,
119                               struct gmx_repl_ex *re, int ere, real q)
120 {
121     real    *qall;
122     gmx_bool bDiff;
123     int      s;
124
125     snew(qall, ms->nsim);
126     qall[re->repl] = q;
127     gmx_sum_sim(ms->nsim, qall, ms);
128
129     bDiff = FALSE;
130     for (s = 1; s < ms->nsim; s++)
131     {
132         if (qall[s] != qall[0])
133         {
134             bDiff = TRUE;
135         }
136     }
137
138     if (bDiff)
139     {
140         /* Set the replica exchange type and quantities */
141         re->type = ere;
142
143         snew(re->q[ere], re->nrepl);
144         for (s = 0; s < ms->nsim; s++)
145         {
146             re->q[ere][s] = qall[s];
147         }
148     }
149     sfree(qall);
150     return bDiff;
151 }
152
153 gmx_repl_ex_t
154 init_replica_exchange(FILE                            *fplog,
155                       const gmx_multisim_t            *ms,
156                       int                              numAtomsInSystem,
157                       const t_inputrec                *ir,
158                       const ReplicaExchangeParameters &replExParams)
159 {
160     real                pres;
161     int                 i, j, k;
162     struct gmx_repl_ex *re;
163     gmx_bool            bTemp;
164     gmx_bool            bLambda = FALSE;
165
166     fprintf(fplog, "\nInitializing Replica Exchange\n");
167
168     if (!isMultiSim(ms) || ms->nsim == 1)
169     {
170         gmx_fatal(FARGS, "Nothing to exchange with only one replica, maybe you forgot to set the -multidir option of mdrun?");
171     }
172     if (!EI_DYNAMICS(ir->eI))
173     {
174         gmx_fatal(FARGS, "Replica exchange is only supported by dynamical simulations");
175         /* Note that PAR(cr) is defined by cr->nnodes > 1, which is
176          * distinct from isMultiSim(ms). A multi-simulation only runs
177          * with real MPI parallelism, but this does not imply PAR(cr)
178          * is true!
179          *
180          * Since we are using a dynamical integrator, the only
181          * decomposition is DD, so PAR(cr) and DOMAINDECOMP(cr) are
182          * synonymous. The only way for cr->nnodes > 1 to be true is
183          * if we are using DD. */
184     }
185
186     snew(re, 1);
187
188     re->repl     = ms->sim;
189     re->nrepl    = ms->nsim;
190     snew(re->q, ereENDSINGLE);
191
192     fprintf(fplog, "Repl  There are %d replicas:\n", re->nrepl);
193
194     /* We only check that the number of atoms in the systms match.
195      * This, of course, do not guarantee that the systems are the same,
196      * but it does guarantee that we can perform replica exchange.
197      */
198     check_multi_int(fplog, ms, numAtomsInSystem, "the number of atoms", FALSE);
199     check_multi_int(fplog, ms, ir->eI, "the integrator", FALSE);
200     check_multi_int64(fplog, ms, ir->init_step+ir->nsteps, "init_step+nsteps", FALSE);
201     const int nst = replExParams.exchangeInterval;
202     check_multi_int64(fplog, ms, (ir->init_step+nst-1)/nst,
203                       "first exchange step: init_step/-replex", FALSE);
204     check_multi_int(fplog, ms, ir->etc, "the temperature coupling", FALSE);
205     check_multi_int(fplog, ms, ir->opts.ngtc,
206                     "the number of temperature coupling groups", FALSE);
207     check_multi_int(fplog, ms, ir->epc, "the pressure coupling", FALSE);
208     check_multi_int(fplog, ms, ir->efep, "free energy", FALSE);
209     check_multi_int(fplog, ms, ir->fepvals->n_lambda, "number of lambda states", FALSE);
210
211     re->temp = ir->opts.ref_t[0];
212     for (i = 1; (i < ir->opts.ngtc); i++)
213     {
214         if (ir->opts.ref_t[i] != re->temp)
215         {
216             fprintf(fplog, "\nWARNING: The temperatures of the different temperature coupling groups are not identical\n\n");
217             fprintf(stderr, "\nWARNING: The temperatures of the different temperature coupling groups are not identical\n\n");
218         }
219     }
220
221     re->type = -1;
222     bTemp    = repl_quantity(ms, re, ereTEMP, re->temp);
223     if (ir->efep != efepNO)
224     {
225         bLambda = repl_quantity(ms, re, ereLAMBDA, (real)ir->fepvals->init_fep_state);
226     }
227     if (re->type == -1)  /* nothing was assigned */
228     {
229         gmx_fatal(FARGS, "The properties of the %d systems are all the same, there is nothing to exchange", re->nrepl);
230     }
231     if (bLambda && bTemp)
232     {
233         re->type = ereTL;
234     }
235
236     if (bTemp)
237     {
238         please_cite(fplog, "Sugita1999a");
239         if (ir->epc != epcNO)
240         {
241             re->bNPT = TRUE;
242             fprintf(fplog, "Repl  Using Constant Pressure REMD.\n");
243             please_cite(fplog, "Okabe2001a");
244         }
245         if (ir->etc == etcBERENDSEN)
246         {
247             gmx_fatal(FARGS, "REMD with the %s thermostat does not produce correct potential energy distributions, consider using the %s thermostat instead",
248                       ETCOUPLTYPE(ir->etc), ETCOUPLTYPE(etcVRESCALE));
249         }
250     }
251     if (bLambda)
252     {
253         if (ir->fepvals->delta_lambda != 0)   /* check this? */
254         {
255             gmx_fatal(FARGS, "delta_lambda is not zero");
256         }
257     }
258     if (re->bNPT)
259     {
260         snew(re->pres, re->nrepl);
261         if (ir->epct == epctSURFACETENSION)
262         {
263             pres = ir->ref_p[ZZ][ZZ];
264         }
265         else
266         {
267             pres = 0;
268             j    = 0;
269             for (i = 0; i < DIM; i++)
270             {
271                 if (ir->compress[i][i] != 0)
272                 {
273                     pres += ir->ref_p[i][i];
274                     j++;
275                 }
276             }
277             pres /= j;
278         }
279         re->pres[re->repl] = pres;
280         gmx_sum_sim(re->nrepl, re->pres, ms);
281     }
282
283     /* Make an index for increasing replica order */
284     /* only makes sense if one or the other is varying, not both!
285        if both are varying, we trust the order the person gave. */
286     snew(re->ind, re->nrepl);
287     for (i = 0; i < re->nrepl; i++)
288     {
289         re->ind[i] = i;
290     }
291
292     if (re->type < ereENDSINGLE)
293     {
294
295         for (i = 0; i < re->nrepl; i++)
296         {
297             for (j = i+1; j < re->nrepl; j++)
298             {
299                 if (re->q[re->type][re->ind[j]] < re->q[re->type][re->ind[i]])
300                 {
301                     /* Unordered replicas are supposed to work, but there
302                      * is still an issues somewhere.
303                      * Note that at this point still re->ind[i]=i.
304                      */
305                     gmx_fatal(FARGS, "Replicas with indices %d < %d have %ss %g > %g, please order your replicas on increasing %s",
306                               i, j,
307                               erename[re->type],
308                               re->q[re->type][i], re->q[re->type][j],
309                               erename[re->type]);
310
311                     k          = re->ind[i];
312                     re->ind[i] = re->ind[j];
313                     re->ind[j] = k;
314                 }
315                 else if (re->q[re->type][re->ind[j]] == re->q[re->type][re->ind[i]])
316                 {
317                     gmx_fatal(FARGS, "Two replicas have identical %ss", erename[re->type]);
318                 }
319             }
320         }
321     }
322
323     /* keep track of all the swaps, starting with the initial placement. */
324     snew(re->allswaps, re->nrepl);
325     for (i = 0; i < re->nrepl; i++)
326     {
327         re->allswaps[i] = re->ind[i];
328     }
329
330     switch (re->type)
331     {
332         case ereTEMP:
333             fprintf(fplog, "\nReplica exchange in temperature\n");
334             for (i = 0; i < re->nrepl; i++)
335             {
336                 fprintf(fplog, " %5.1f", re->q[re->type][re->ind[i]]);
337             }
338             fprintf(fplog, "\n");
339             break;
340         case ereLAMBDA:
341             fprintf(fplog, "\nReplica exchange in lambda\n");
342             for (i = 0; i < re->nrepl; i++)
343             {
344                 fprintf(fplog, " %3d", (int)re->q[re->type][re->ind[i]]);
345             }
346             fprintf(fplog, "\n");
347             break;
348         case ereTL:
349             fprintf(fplog, "\nReplica exchange in temperature and lambda state\n");
350             for (i = 0; i < re->nrepl; i++)
351             {
352                 fprintf(fplog, " %5.1f", re->q[ereTEMP][re->ind[i]]);
353             }
354             fprintf(fplog, "\n");
355             for (i = 0; i < re->nrepl; i++)
356             {
357                 fprintf(fplog, " %5d", (int)re->q[ereLAMBDA][re->ind[i]]);
358             }
359             fprintf(fplog, "\n");
360             break;
361         default:
362             gmx_incons("Unknown replica exchange quantity");
363     }
364     if (re->bNPT)
365     {
366         fprintf(fplog, "\nRepl  p");
367         for (i = 0; i < re->nrepl; i++)
368         {
369             fprintf(fplog, " %5.2f", re->pres[re->ind[i]]);
370         }
371
372         for (i = 0; i < re->nrepl; i++)
373         {
374             if ((i > 0) && (re->pres[re->ind[i]] < re->pres[re->ind[i-1]]))
375             {
376                 fprintf(fplog, "\nWARNING: The reference pressures decrease with increasing temperatures\n\n");
377                 fprintf(stderr, "\nWARNING: The reference pressures decrease with increasing temperatures\n\n");
378             }
379         }
380     }
381     re->nst = nst;
382     if (replExParams.randomSeed == -1)
383     {
384         if (isMasterSim(ms))
385         {
386             re->seed = static_cast<int>(gmx::makeRandomSeed());
387         }
388         else
389         {
390             re->seed = 0;
391         }
392         gmx_sumi_sim(1, &(re->seed), ms);
393     }
394     else
395     {
396         re->seed = replExParams.randomSeed;
397     }
398     fprintf(fplog, "\nReplica exchange interval: %d\n", re->nst);
399     fprintf(fplog, "\nReplica random seed: %d\n", re->seed);
400
401     re->nattempt[0] = 0;
402     re->nattempt[1] = 0;
403
404     snew(re->prob_sum, re->nrepl);
405     snew(re->nexchange, re->nrepl);
406     snew(re->nmoves, re->nrepl);
407     for (i = 0; i < re->nrepl; i++)
408     {
409         snew(re->nmoves[i], re->nrepl);
410     }
411     fprintf(fplog, "Replica exchange information below: ex and x = exchange, pr = probability\n");
412
413     /* generate space for the helper functions so we don't have to snew each time */
414
415     snew(re->destinations, re->nrepl);
416     snew(re->incycle, re->nrepl);
417     snew(re->tmpswap, re->nrepl);
418     snew(re->cyclic, re->nrepl);
419     snew(re->order, re->nrepl);
420     for (i = 0; i < re->nrepl; i++)
421     {
422         snew(re->cyclic[i], re->nrepl+1);
423         snew(re->order[i], re->nrepl);
424     }
425     /* allocate space for the functions storing the data for the replicas */
426     /* not all of these arrays needed in all cases, but they don't take
427        up much space, since the max size is nrepl**2 */
428     snew(re->prob, re->nrepl);
429     snew(re->bEx, re->nrepl);
430     snew(re->beta, re->nrepl);
431     snew(re->Vol, re->nrepl);
432     snew(re->Epot, re->nrepl);
433     snew(re->de, re->nrepl);
434     for (i = 0; i < re->nrepl; i++)
435     {
436         snew(re->de[i], re->nrepl);
437     }
438     re->nex = replExParams.numExchanges;
439     return re;
440 }
441
442 static void exchange_reals(const gmx_multisim_t gmx_unused *ms, int gmx_unused b, real *v, int n)
443 {
444     real *buf;
445     int   i;
446
447     if (v)
448     {
449         snew(buf, n);
450 #if GMX_MPI
451         /*
452            MPI_Sendrecv(v,  n*sizeof(real),MPI_BYTE,MSRANK(ms,b),0,
453            buf,n*sizeof(real),MPI_BYTE,MSRANK(ms,b),0,
454            ms->mpi_comm_masters,MPI_STATUS_IGNORE);
455          */
456         {
457             MPI_Request mpi_req;
458
459             MPI_Isend(v, n*sizeof(real), MPI_BYTE, MSRANK(ms, b), 0,
460                       ms->mpi_comm_masters, &mpi_req);
461             MPI_Recv(buf, n*sizeof(real), MPI_BYTE, MSRANK(ms, b), 0,
462                      ms->mpi_comm_masters, MPI_STATUS_IGNORE);
463             MPI_Wait(&mpi_req, MPI_STATUS_IGNORE);
464         }
465 #endif
466         for (i = 0; i < n; i++)
467         {
468             v[i] = buf[i];
469         }
470         sfree(buf);
471     }
472 }
473
474
475 static void exchange_doubles(const gmx_multisim_t gmx_unused *ms, int gmx_unused b, double *v, int n)
476 {
477     double *buf;
478     int     i;
479
480     if (v)
481     {
482         snew(buf, n);
483 #if GMX_MPI
484         /*
485            MPI_Sendrecv(v,  n*sizeof(double),MPI_BYTE,MSRANK(ms,b),0,
486            buf,n*sizeof(double),MPI_BYTE,MSRANK(ms,b),0,
487            ms->mpi_comm_masters,MPI_STATUS_IGNORE);
488          */
489         {
490             MPI_Request mpi_req;
491
492             MPI_Isend(v, n*sizeof(double), MPI_BYTE, MSRANK(ms, b), 0,
493                       ms->mpi_comm_masters, &mpi_req);
494             MPI_Recv(buf, n*sizeof(double), MPI_BYTE, MSRANK(ms, b), 0,
495                      ms->mpi_comm_masters, MPI_STATUS_IGNORE);
496             MPI_Wait(&mpi_req, MPI_STATUS_IGNORE);
497         }
498 #endif
499         for (i = 0; i < n; i++)
500         {
501             v[i] = buf[i];
502         }
503         sfree(buf);
504     }
505 }
506
507 static void exchange_rvecs(const gmx_multisim_t gmx_unused *ms, int gmx_unused b, rvec *v, int n)
508 {
509     rvec *buf;
510     int   i;
511
512     if (v)
513     {
514         snew(buf, n);
515 #if GMX_MPI
516         /*
517            MPI_Sendrecv(v[0],  n*sizeof(rvec),MPI_BYTE,MSRANK(ms,b),0,
518            buf[0],n*sizeof(rvec),MPI_BYTE,MSRANK(ms,b),0,
519            ms->mpi_comm_masters,MPI_STATUS_IGNORE);
520          */
521         {
522             MPI_Request mpi_req;
523
524             MPI_Isend(v[0], n*sizeof(rvec), MPI_BYTE, MSRANK(ms, b), 0,
525                       ms->mpi_comm_masters, &mpi_req);
526             MPI_Recv(buf[0], n*sizeof(rvec), MPI_BYTE, MSRANK(ms, b), 0,
527                      ms->mpi_comm_masters, MPI_STATUS_IGNORE);
528             MPI_Wait(&mpi_req, MPI_STATUS_IGNORE);
529         }
530 #endif
531         for (i = 0; i < n; i++)
532         {
533             copy_rvec(buf[i], v[i]);
534         }
535         sfree(buf);
536     }
537 }
538
539 static void exchange_state(const gmx_multisim_t *ms, int b, t_state *state)
540 {
541     /* When t_state changes, this code should be updated. */
542     int ngtc, nnhpres;
543     ngtc    = state->ngtc * state->nhchainlength;
544     nnhpres = state->nnhpres* state->nhchainlength;
545     exchange_rvecs(ms, b, state->box, DIM);
546     exchange_rvecs(ms, b, state->box_rel, DIM);
547     exchange_rvecs(ms, b, state->boxv, DIM);
548     exchange_reals(ms, b, &(state->veta), 1);
549     exchange_reals(ms, b, &(state->vol0), 1);
550     exchange_rvecs(ms, b, state->svir_prev, DIM);
551     exchange_rvecs(ms, b, state->fvir_prev, DIM);
552     exchange_rvecs(ms, b, state->pres_prev, DIM);
553     exchange_doubles(ms, b, state->nosehoover_xi.data(), ngtc);
554     exchange_doubles(ms, b, state->nosehoover_vxi.data(), ngtc);
555     exchange_doubles(ms, b, state->nhpres_xi.data(), nnhpres);
556     exchange_doubles(ms, b, state->nhpres_vxi.data(), nnhpres);
557     exchange_doubles(ms, b, state->therm_integral.data(), state->ngtc);
558     exchange_doubles(ms, b, &state->baros_integral, 1);
559     exchange_rvecs(ms, b, as_rvec_array(state->x.data()), state->natoms);
560     exchange_rvecs(ms, b, as_rvec_array(state->v.data()), state->natoms);
561 }
562
563 static void copy_state_serial(const t_state *src, t_state *dest)
564 {
565     if (dest != src)
566     {
567         /* Currently the local state is always a pointer to the global
568          * in serial, so we should never end up here.
569          * TODO: Implement a (trivial) t_state copy once converted to C++.
570          */
571         GMX_RELEASE_ASSERT(false, "State copying is currently not implemented in replica exchange");
572     }
573 }
574
575 static void scale_velocities(t_state *state, real fac)
576 {
577     int i;
578
579     if (as_rvec_array(state->v.data()))
580     {
581         for (i = 0; i < state->natoms; i++)
582         {
583             svmul(fac, state->v[i], state->v[i]);
584         }
585     }
586 }
587
588 static void print_transition_matrix(FILE *fplog, int n, int **nmoves, const int *nattempt)
589 {
590     int   i, j, ntot;
591     float Tprint;
592
593     ntot = nattempt[0] + nattempt[1];
594     fprintf(fplog, "\n");
595     fprintf(fplog, "Repl");
596     for (i = 0; i < n; i++)
597     {
598         fprintf(fplog, "    ");  /* put the title closer to the center */
599     }
600     fprintf(fplog, "Empirical Transition Matrix\n");
601
602     fprintf(fplog, "Repl");
603     for (i = 0; i < n; i++)
604     {
605         fprintf(fplog, "%8d", (i+1));
606     }
607     fprintf(fplog, "\n");
608
609     for (i = 0; i < n; i++)
610     {
611         fprintf(fplog, "Repl");
612         for (j = 0; j < n; j++)
613         {
614             Tprint = 0.0;
615             if (nmoves[i][j] > 0)
616             {
617                 Tprint = nmoves[i][j]/(2.0*ntot);
618             }
619             fprintf(fplog, "%8.4f", Tprint);
620         }
621         fprintf(fplog, "%3d\n", i);
622     }
623 }
624
625 static void print_ind(FILE *fplog, const char *leg, int n, int *ind, const gmx_bool *bEx)
626 {
627     int i;
628
629     fprintf(fplog, "Repl %2s %2d", leg, ind[0]);
630     for (i = 1; i < n; i++)
631     {
632         fprintf(fplog, " %c %2d", (bEx != nullptr && bEx[i]) ? 'x' : ' ', ind[i]);
633     }
634     fprintf(fplog, "\n");
635 }
636
637 static void print_allswitchind(FILE *fplog, int n, int *pind, int *allswaps, int *tmpswap)
638 {
639     int i;
640
641     for (i = 0; i < n; i++)
642     {
643         tmpswap[i] = allswaps[i];
644     }
645     for (i = 0; i < n; i++)
646     {
647         allswaps[i] = tmpswap[pind[i]];
648     }
649
650     fprintf(fplog, "\nAccepted Exchanges:   ");
651     for (i = 0; i < n; i++)
652     {
653         fprintf(fplog, "%d ", pind[i]);
654     }
655     fprintf(fplog, "\n");
656
657     /* the "Order After Exchange" is the state label corresponding to the configuration that
658        started in state listed in order, i.e.
659
660        3 0 1 2
661
662        means that the:
663        configuration starting in simulation 3 is now in simulation 0,
664        configuration starting in simulation 0 is now in simulation 1,
665        configuration starting in simulation 1 is now in simulation 2,
666        configuration starting in simulation 2 is now in simulation 3
667      */
668     fprintf(fplog, "Order After Exchange: ");
669     for (i = 0; i < n; i++)
670     {
671         fprintf(fplog, "%d ", allswaps[i]);
672     }
673     fprintf(fplog, "\n\n");
674 }
675
676 static void print_prob(FILE *fplog, const char *leg, int n, real *prob)
677 {
678     int  i;
679     char buf[8];
680
681     fprintf(fplog, "Repl %2s ", leg);
682     for (i = 1; i < n; i++)
683     {
684         if (prob[i] >= 0)
685         {
686             sprintf(buf, "%4.2f", prob[i]);
687             fprintf(fplog, "  %3s", buf[0] == '1' ? "1.0" : buf+1);
688         }
689         else
690         {
691             fprintf(fplog, "     ");
692         }
693     }
694     fprintf(fplog, "\n");
695 }
696
697 static void print_count(FILE *fplog, const char *leg, int n, int *count)
698 {
699     int i;
700
701     fprintf(fplog, "Repl %2s ", leg);
702     for (i = 1; i < n; i++)
703     {
704         fprintf(fplog, " %4d", count[i]);
705     }
706     fprintf(fplog, "\n");
707 }
708
709 static real calc_delta(FILE *fplog, gmx_bool bPrint, struct gmx_repl_ex *re, int a, int b, int ap, int bp)
710 {
711
712     real   ediff, dpV, delta = 0;
713     real  *Epot = re->Epot;
714     real  *Vol  = re->Vol;
715     real **de   = re->de;
716     real  *beta = re->beta;
717
718     /* Two cases; we are permuted and not.  In all cases, setting ap = a and bp = b will reduce
719        to the non permuted case */
720
721     switch (re->type)
722     {
723         case ereTEMP:
724             /*
725              * Okabe et. al. Chem. Phys. Lett. 335 (2001) 435-439
726              */
727             ediff = Epot[b] - Epot[a];
728             delta = -(beta[bp] - beta[ap])*ediff;
729             break;
730         case ereLAMBDA:
731             /* two cases:  when we are permuted, and not.  */
732             /* non-permuted:
733                ediff =  E_new - E_old
734                      =  [H_b(x_a) + H_a(x_b)] - [H_b(x_b) + H_a(x_a)]
735                      =  [H_b(x_a) - H_a(x_a)] + [H_a(x_b) - H_b(x_b)]
736                      =  de[b][a] + de[a][b] */
737
738             /* permuted:
739                ediff =  E_new - E_old
740                      =  [H_bp(x_a) + H_ap(x_b)] - [H_bp(x_b) + H_ap(x_a)]
741                      =  [H_bp(x_a) - H_ap(x_a)] + [H_ap(x_b) - H_bp(x_b)]
742                      =  [H_bp(x_a) - H_a(x_a) + H_a(x_a) - H_ap(x_a)] + [H_ap(x_b) - H_b(x_b) + H_b(x_b) - H_bp(x_b)]
743                      =  [H_bp(x_a) - H_a(x_a)] - [H_ap(x_a) - H_a(x_a)] + [H_ap(x_b) - H_b(x_b)] - H_bp(x_b) - H_b(x_b)]
744                      =  (de[bp][a] - de[ap][a]) + (de[ap][b] - de[bp][b])    */
745             /* but, in the current code implementation, we flip configurations, not indices . . .
746                So let's examine that.
747                      =  [H_b(x_ap) - H_a(x_a)] - [H_a(x_ap) - H_a(x_a)] + [H_a(x_bp) - H_b(x_b)] - H_b(x_bp) - H_b(x_b)]
748                      =  [H_b(x_ap) - H_a(x_ap)]  + [H_a(x_bp) - H_b(x_pb)]
749                      = (de[b][ap] - de[a][ap]) + (de[a][bp] - de[b][bp]
750                      So, if we exchange b<=> bp and a<=> ap, we return to the same result.
751                      So the simple solution is to flip the
752                      position of perturbed and original indices in the tests.
753              */
754
755             ediff = (de[bp][a] - de[ap][a]) + (de[ap][b] - de[bp][b]);
756             delta = ediff*beta[a]; /* assume all same temperature in this case */
757             break;
758         case ereTL:
759             /* not permuted:  */
760             /* delta =  reduced E_new - reduced E_old
761                      =  [beta_b H_b(x_a) + beta_a H_a(x_b)] - [beta_b H_b(x_b) + beta_a H_a(x_a)]
762                      =  [beta_b H_b(x_a) - beta_a H_a(x_a)] + [beta_a H_a(x_b) - beta_b H_b(x_b)]
763                      =  [beta_b dH_b(x_a) + beta_b H_a(x_a) - beta_a H_a(x_a)] +
764                         [beta_a dH_a(x_b) + beta_a H_b(x_b) - beta_b H_b(x_b)]
765                      =  [beta_b dH_b(x_a) + [beta_a dH_a(x_b) +
766                         beta_b (H_a(x_a) - H_b(x_b)]) - beta_a (H_a(x_a) - H_b(x_b))
767                      =  beta_b dH_b(x_a) + beta_a dH_a(x_b) - (beta_b - beta_a)(H_b(x_b) - H_a(x_a) */
768             /* delta = beta[b]*de[b][a] + beta[a]*de[a][b] - (beta[b] - beta[a])*(Epot[b] - Epot[a]; */
769             /* permuted (big breath!) */
770             /*   delta =  reduced E_new - reduced E_old
771                      =  [beta_bp H_bp(x_a) + beta_ap H_ap(x_b)] - [beta_bp H_bp(x_b) + beta_ap H_ap(x_a)]
772                      =  [beta_bp H_bp(x_a) - beta_ap H_ap(x_a)] + [beta_ap H_ap(x_b) - beta_bp H_bp(x_b)]
773                      =  [beta_bp H_bp(x_a) - beta_ap H_ap(x_a)] + [beta_ap H_ap(x_b) - beta_bp H_bp(x_b)]
774                         - beta_pb H_a(x_a) + beta_ap H_a(x_a) + beta_pb H_a(x_a) - beta_ap H_a(x_a)
775                         - beta_ap H_b(x_b) + beta_bp H_b(x_b) + beta_ap H_b(x_b) - beta_bp H_b(x_b)
776                      =  [(beta_bp H_bp(x_a) - beta_bp H_a(x_a)) - (beta_ap H_ap(x_a) - beta_ap H_a(x_a))] +
777                         [(beta_ap H_ap(x_b)  - beta_ap H_b(x_b)) - (beta_bp H_bp(x_b) - beta_bp H_b(x_b))]
778              + beta_pb H_a(x_a) - beta_ap H_a(x_a) + beta_ap H_b(x_b) - beta_bp H_b(x_b)
779                      =  [beta_bp (H_bp(x_a) - H_a(x_a)) - beta_ap (H_ap(x_a) - H_a(x_a))] +
780                         [beta_ap (H_ap(x_b) - H_b(x_b)) - beta_bp (H_bp(x_b) - H_b(x_b))]
781              + beta_pb (H_a(x_a) - H_b(x_b))  - beta_ap (H_a(x_a) - H_b(x_b))
782                      =  ([beta_bp de[bp][a] - beta_ap de[ap][a]) + beta_ap de[ap][b]  - beta_bp de[bp][b])
783              + (beta_pb-beta_ap)(H_a(x_a) - H_b(x_b))  */
784             delta = beta[bp]*(de[bp][a] - de[bp][b]) + beta[ap]*(de[ap][b] - de[ap][a]) - (beta[bp]-beta[ap])*(Epot[b]-Epot[a]);
785             break;
786         default:
787             gmx_incons("Unknown replica exchange quantity");
788     }
789     if (bPrint)
790     {
791         fprintf(fplog, "Repl %d <-> %d  dE_term = %10.3e (kT)\n", a, b, delta);
792     }
793     if (re->bNPT)
794     {
795         /* revist the calculation for 5.0.  Might be some improvements. */
796         dpV = (beta[ap]*re->pres[ap]-beta[bp]*re->pres[bp])*(Vol[b]-Vol[a])/PRESFAC;
797         if (bPrint)
798         {
799             fprintf(fplog, "  dpV = %10.3e  d = %10.3e\n", dpV, delta + dpV);
800         }
801         delta += dpV;
802     }
803     return delta;
804 }
805
806 static void
807 test_for_replica_exchange(FILE                 *fplog,
808                           const gmx_multisim_t *ms,
809                           struct gmx_repl_ex   *re,
810                           const gmx_enerdata_t *enerd,
811                           real                  vol,
812                           gmx_int64_t           step,
813                           real                  time)
814 {
815     int                                  m, i, j, a, b, ap, bp, i0, i1, tmp;
816     real                                 delta = 0;
817     gmx_bool                             bPrint, bMultiEx;
818     gmx_bool                            *bEx      = re->bEx;
819     real                                *prob     = re->prob;
820     int                                 *pind     = re->destinations; /* permuted index */
821     gmx_bool                             bEpot    = FALSE;
822     gmx_bool                             bDLambda = FALSE;
823     gmx_bool                             bVol     = FALSE;
824     gmx::ThreeFry2x64<64>                rng(re->seed, gmx::RandomDomain::ReplicaExchange);
825     gmx::UniformRealDistribution<real>   uniformRealDist;
826     gmx::UniformIntDistribution<int>     uniformNreplDist(0, re->nrepl-1);
827
828     bMultiEx = (re->nex > 1);  /* multiple exchanges at each state */
829     fprintf(fplog, "Replica exchange at step %" GMX_PRId64 " time %.5f\n", step, time);
830
831     if (re->bNPT)
832     {
833         for (i = 0; i < re->nrepl; i++)
834         {
835             re->Vol[i] = 0;
836         }
837         bVol               = TRUE;
838         re->Vol[re->repl]  = vol;
839     }
840     if ((re->type == ereTEMP || re->type == ereTL))
841     {
842         for (i = 0; i < re->nrepl; i++)
843         {
844             re->Epot[i] = 0;
845         }
846         bEpot              = TRUE;
847         re->Epot[re->repl] = enerd->term[F_EPOT];
848         /* temperatures of different states*/
849         for (i = 0; i < re->nrepl; i++)
850         {
851             re->beta[i] = 1.0/(re->q[ereTEMP][i]*BOLTZ);
852         }
853     }
854     else
855     {
856         for (i = 0; i < re->nrepl; i++)
857         {
858             re->beta[i] = 1.0/(re->temp*BOLTZ);  /* we have a single temperature */
859         }
860     }
861     if (re->type == ereLAMBDA || re->type == ereTL)
862     {
863         bDLambda = TRUE;
864         /* lambda differences. */
865         /* de[i][j] is the energy of the jth simulation in the ith Hamiltonian
866            minus the energy of the jth simulation in the jth Hamiltonian */
867         for (i = 0; i < re->nrepl; i++)
868         {
869             for (j = 0; j < re->nrepl; j++)
870             {
871                 re->de[i][j] = 0;
872             }
873         }
874         for (i = 0; i < re->nrepl; i++)
875         {
876             re->de[i][re->repl] = (enerd->enerpart_lambda[(int)re->q[ereLAMBDA][i]+1]-enerd->enerpart_lambda[0]);
877         }
878     }
879
880     /* now actually do the communication */
881     if (bVol)
882     {
883         gmx_sum_sim(re->nrepl, re->Vol, ms);
884     }
885     if (bEpot)
886     {
887         gmx_sum_sim(re->nrepl, re->Epot, ms);
888     }
889     if (bDLambda)
890     {
891         for (i = 0; i < re->nrepl; i++)
892         {
893             gmx_sum_sim(re->nrepl, re->de[i], ms);
894         }
895     }
896
897     /* make a duplicate set of indices for shuffling */
898     for (i = 0; i < re->nrepl; i++)
899     {
900         pind[i] = re->ind[i];
901     }
902
903     rng.restart( step, 0 );
904
905     if (bMultiEx)
906     {
907         /* multiple random switch exchange */
908         int nself = 0;
909
910
911         for (i = 0; i < re->nex + nself; i++)
912         {
913             // For now this is superfluous, but just in case we ever add more
914             // calls in different branches it is safer to always reset the distribution.
915             uniformNreplDist.reset();
916
917             /* randomly select a pair  */
918             /* in theory, could reduce this by identifying only which switches had a nonneglibible
919                probability of occurring (log p > -100) and only operate on those switches */
920             /* find out which state it is from, and what label that state currently has. Likely
921                more work that useful. */
922             i0 = uniformNreplDist(rng);
923             i1 = uniformNreplDist(rng);
924             if (i0 == i1)
925             {
926                 nself++;
927                 continue;  /* self-exchange, back up and do it again */
928             }
929
930             a  = re->ind[i0]; /* what are the indices of these states? */
931             b  = re->ind[i1];
932             ap = pind[i0];
933             bp = pind[i1];
934
935             bPrint = FALSE; /* too noisy */
936             /* calculate the energy difference */
937             /* if the code changes to flip the STATES, rather than the configurations,
938                use the commented version of the code */
939             /* delta = calc_delta(fplog,bPrint,re,a,b,ap,bp); */
940             delta = calc_delta(fplog, bPrint, re, ap, bp, a, b);
941
942             /* we actually only use the first space in the prob and bEx array,
943                since there are actually many switches between pairs. */
944
945             if (delta <= 0)
946             {
947                 /* accepted */
948                 prob[0] = 1;
949                 bEx[0]  = TRUE;
950             }
951             else
952             {
953                 if (delta > PROBABILITYCUTOFF)
954                 {
955                     prob[0] = 0;
956                 }
957                 else
958                 {
959                     prob[0] = exp(-delta);
960                 }
961                 // roll a number to determine if accepted. For now it is superfluous to
962                 // reset, but just in case we ever add more calls in different branches
963                 // it is safer to always reset the distribution.
964                 uniformRealDist.reset();
965                 bEx[0] = uniformRealDist(rng) < prob[0];
966             }
967             re->prob_sum[0] += prob[0];
968
969             if (bEx[0])
970             {
971                 /* swap the states */
972                 tmp      = pind[i0];
973                 pind[i0] = pind[i1];
974                 pind[i1] = tmp;
975             }
976         }
977         re->nattempt[0]++;  /* keep track of total permutation trials here */
978         print_allswitchind(fplog, re->nrepl, pind, re->allswaps, re->tmpswap);
979     }
980     else
981     {
982         /* standard nearest neighbor replica exchange */
983
984         m = (step / re->nst) % 2;
985         for (i = 1; i < re->nrepl; i++)
986         {
987             a = re->ind[i-1];
988             b = re->ind[i];
989
990             bPrint = (re->repl == a || re->repl == b);
991             if (i % 2 == m)
992             {
993                 delta = calc_delta(fplog, bPrint, re, a, b, a, b);
994                 if (delta <= 0)
995                 {
996                     /* accepted */
997                     prob[i] = 1;
998                     bEx[i]  = TRUE;
999                 }
1000                 else
1001                 {
1002                     if (delta > PROBABILITYCUTOFF)
1003                     {
1004                         prob[i] = 0;
1005                     }
1006                     else
1007                     {
1008                         prob[i] = exp(-delta);
1009                     }
1010                     // roll a number to determine if accepted. For now it is superfluous to
1011                     // reset, but just in case we ever add more calls in different branches
1012                     // it is safer to always reset the distribution.
1013                     uniformRealDist.reset();
1014                     bEx[i] = uniformRealDist(rng) < prob[i];
1015                 }
1016                 re->prob_sum[i] += prob[i];
1017
1018                 if (bEx[i])
1019                 {
1020                     /* swap these two */
1021                     tmp       = pind[i-1];
1022                     pind[i-1] = pind[i];
1023                     pind[i]   = tmp;
1024                     re->nexchange[i]++;  /* statistics for back compatibility */
1025                 }
1026             }
1027             else
1028             {
1029                 prob[i] = -1;
1030                 bEx[i]  = FALSE;
1031             }
1032         }
1033         /* print some statistics */
1034         print_ind(fplog, "ex", re->nrepl, re->ind, bEx);
1035         print_prob(fplog, "pr", re->nrepl, prob);
1036         fprintf(fplog, "\n");
1037         re->nattempt[m]++;
1038     }
1039
1040     /* record which moves were made and accepted */
1041     for (i = 0; i < re->nrepl; i++)
1042     {
1043         re->nmoves[re->ind[i]][pind[i]] += 1;
1044         re->nmoves[pind[i]][re->ind[i]] += 1;
1045     }
1046     fflush(fplog); /* make sure we can see what the last exchange was */
1047 }
1048
1049 static void
1050 cyclic_decomposition(const int *destinations,
1051                      int      **cyclic,
1052                      gmx_bool  *incycle,
1053                      const int  nrepl,
1054                      int       *nswap)
1055 {
1056
1057     int i, j, c, p;
1058     int maxlen = 1;
1059     for (i = 0; i < nrepl; i++)
1060     {
1061         incycle[i] = FALSE;
1062     }
1063     for (i = 0; i < nrepl; i++)  /* one cycle for each replica */
1064     {
1065         if (incycle[i])
1066         {
1067             cyclic[i][0] = -1;
1068             continue;
1069         }
1070         cyclic[i][0] = i;
1071         incycle[i]   = TRUE;
1072         c            = 1;
1073         p            = i;
1074         for (j = 0; j < nrepl; j++) /* potentially all cycles are part, but we will break first */
1075         {
1076             p = destinations[p];    /* start permuting */
1077             if (p == i)
1078             {
1079                 cyclic[i][c] = -1;
1080                 if (c > maxlen)
1081                 {
1082                     maxlen = c;
1083                 }
1084                 break; /* we've reached the original element, the cycle is complete, and we marked the end. */
1085             }
1086             else
1087             {
1088                 cyclic[i][c] = p;  /* each permutation gives a new member of the cycle */
1089                 incycle[p]   = TRUE;
1090                 c++;
1091             }
1092         }
1093     }
1094     *nswap = maxlen - 1;
1095
1096     if (debug)
1097     {
1098         for (i = 0; i < nrepl; i++)
1099         {
1100             fprintf(debug, "Cycle %d:", i);
1101             for (j = 0; j < nrepl; j++)
1102             {
1103                 if (cyclic[i][j] < 0)
1104                 {
1105                     break;
1106                 }
1107                 fprintf(debug, "%2d", cyclic[i][j]);
1108             }
1109             fprintf(debug, "\n");
1110         }
1111         fflush(debug);
1112     }
1113 }
1114
1115 static void
1116 compute_exchange_order(int     **cyclic,
1117                        int     **order,
1118                        const int nrepl,
1119                        const int maxswap)
1120 {
1121     int i, j;
1122
1123     for (j = 0; j < maxswap; j++)
1124     {
1125         for (i = 0; i < nrepl; i++)
1126         {
1127             if (cyclic[i][j+1] >= 0)
1128             {
1129                 order[cyclic[i][j+1]][j] = cyclic[i][j];
1130                 order[cyclic[i][j]][j]   = cyclic[i][j+1];
1131             }
1132         }
1133         for (i = 0; i < nrepl; i++)
1134         {
1135             if (order[i][j] < 0)
1136             {
1137                 order[i][j] = i; /* if it's not exchanging, it should stay this round*/
1138             }
1139         }
1140     }
1141
1142     if (debug)
1143     {
1144         fprintf(debug, "Replica Exchange Order\n");
1145         for (i = 0; i < nrepl; i++)
1146         {
1147             fprintf(debug, "Replica %d:", i);
1148             for (j = 0; j < maxswap; j++)
1149             {
1150                 if (order[i][j] < 0)
1151                 {
1152                     break;
1153                 }
1154                 fprintf(debug, "%2d", order[i][j]);
1155             }
1156             fprintf(debug, "\n");
1157         }
1158         fflush(debug);
1159     }
1160 }
1161
1162 static void
1163 prepare_to_do_exchange(struct gmx_repl_ex *re,
1164                        const int           replica_id,
1165                        int                *maxswap,
1166                        gmx_bool           *bThisReplicaExchanged)
1167 {
1168     int i, j;
1169     /* Hold the cyclic decomposition of the (multiple) replica
1170      * exchange. */
1171     gmx_bool bAnyReplicaExchanged = FALSE;
1172     *bThisReplicaExchanged = FALSE;
1173
1174     for (i = 0; i < re->nrepl; i++)
1175     {
1176         if (re->destinations[i] != re->ind[i])
1177         {
1178             /* only mark as exchanged if the index has been shuffled */
1179             bAnyReplicaExchanged = TRUE;
1180             break;
1181         }
1182     }
1183     if (bAnyReplicaExchanged)
1184     {
1185         /* reinitialize the placeholder arrays */
1186         for (i = 0; i < re->nrepl; i++)
1187         {
1188             for (j = 0; j < re->nrepl; j++)
1189             {
1190                 re->cyclic[i][j] = -1;
1191                 re->order[i][j]  = -1;
1192             }
1193         }
1194
1195         /* Identify the cyclic decomposition of the permutation (very
1196          * fast if neighbor replica exchange). */
1197         cyclic_decomposition(re->destinations, re->cyclic, re->incycle, re->nrepl, maxswap);
1198
1199         /* Now translate the decomposition into a replica exchange
1200          * order at each step. */
1201         compute_exchange_order(re->cyclic, re->order, re->nrepl, *maxswap);
1202
1203         /* Did this replica do any exchange at any point? */
1204         for (j = 0; j < *maxswap; j++)
1205         {
1206             if (replica_id != re->order[replica_id][j])
1207             {
1208                 *bThisReplicaExchanged = TRUE;
1209                 break;
1210             }
1211         }
1212     }
1213 }
1214
1215 gmx_bool replica_exchange(FILE *fplog, const t_commrec *cr,
1216                           const gmx_multisim_t *ms, struct gmx_repl_ex *re,
1217                           t_state *state, const gmx_enerdata_t *enerd,
1218                           t_state *state_local, gmx_int64_t step, real time)
1219 {
1220     int j;
1221     int replica_id = 0;
1222     int exchange_partner;
1223     int maxswap = 0;
1224     /* Number of rounds of exchanges needed to deal with any multiple
1225      * exchanges. */
1226     /* Where each replica ends up after the exchange attempt(s). */
1227     /* The order in which multiple exchanges will occur. */
1228     gmx_bool bThisReplicaExchanged = FALSE;
1229
1230     if (MASTER(cr))
1231     {
1232         replica_id  = re->repl;
1233         test_for_replica_exchange(fplog, ms, re, enerd, det(state_local->box), step, time);
1234         prepare_to_do_exchange(re, replica_id, &maxswap, &bThisReplicaExchanged);
1235     }
1236     /* Do intra-simulation broadcast so all processors belonging to
1237      * each simulation know whether they need to participate in
1238      * collecting the state. Otherwise, they might as well get on with
1239      * the next thing to do. */
1240     if (DOMAINDECOMP(cr))
1241     {
1242 #if GMX_MPI
1243         MPI_Bcast(&bThisReplicaExchanged, sizeof(gmx_bool), MPI_BYTE, MASTERRANK(cr),
1244                   cr->mpi_comm_mygroup);
1245 #endif
1246     }
1247
1248     if (bThisReplicaExchanged)
1249     {
1250         /* Exchange the states */
1251         /* Collect the global state on the master node */
1252         if (DOMAINDECOMP(cr))
1253         {
1254             dd_collect_state(cr->dd, state_local, state);
1255         }
1256         else
1257         {
1258             copy_state_serial(state_local, state);
1259         }
1260
1261         if (MASTER(cr))
1262         {
1263             /* There will be only one swap cycle with standard replica
1264              * exchange, but there may be multiple swap cycles if we
1265              * allow multiple swaps. */
1266
1267             for (j = 0; j < maxswap; j++)
1268             {
1269                 exchange_partner = re->order[replica_id][j];
1270
1271                 if (exchange_partner != replica_id)
1272                 {
1273                     /* Exchange the global states between the master nodes */
1274                     if (debug)
1275                     {
1276                         fprintf(debug, "Exchanging %d with %d\n", replica_id, exchange_partner);
1277                     }
1278                     exchange_state(ms, exchange_partner, state);
1279                 }
1280             }
1281             /* For temperature-type replica exchange, we need to scale
1282              * the velocities. */
1283             if (re->type == ereTEMP || re->type == ereTL)
1284             {
1285                 scale_velocities(state, std::sqrt(re->q[ereTEMP][replica_id]/re->q[ereTEMP][re->destinations[replica_id]]));
1286             }
1287
1288         }
1289
1290         /* With domain decomposition the global state is distributed later */
1291         if (!DOMAINDECOMP(cr))
1292         {
1293             /* Copy the global state to the local state data structure */
1294             copy_state_serial(state, state_local);
1295         }
1296     }
1297
1298     return bThisReplicaExchanged;
1299 }
1300
1301 void print_replica_exchange_statistics(FILE *fplog, struct gmx_repl_ex *re)
1302 {
1303     int  i;
1304
1305     fprintf(fplog, "\nReplica exchange statistics\n");
1306
1307     if (re->nex == 0)
1308     {
1309         fprintf(fplog, "Repl  %d attempts, %d odd, %d even\n",
1310                 re->nattempt[0]+re->nattempt[1], re->nattempt[1], re->nattempt[0]);
1311
1312         fprintf(fplog, "Repl  average probabilities:\n");
1313         for (i = 1; i < re->nrepl; i++)
1314         {
1315             if (re->nattempt[i%2] == 0)
1316             {
1317                 re->prob[i] = 0;
1318             }
1319             else
1320             {
1321                 re->prob[i] =  re->prob_sum[i]/re->nattempt[i%2];
1322             }
1323         }
1324         print_ind(fplog, "", re->nrepl, re->ind, nullptr);
1325         print_prob(fplog, "", re->nrepl, re->prob);
1326
1327         fprintf(fplog, "Repl  number of exchanges:\n");
1328         print_ind(fplog, "", re->nrepl, re->ind, nullptr);
1329         print_count(fplog, "", re->nrepl, re->nexchange);
1330
1331         fprintf(fplog, "Repl  average number of exchanges:\n");
1332         for (i = 1; i < re->nrepl; i++)
1333         {
1334             if (re->nattempt[i%2] == 0)
1335             {
1336                 re->prob[i] = 0;
1337             }
1338             else
1339             {
1340                 re->prob[i] =  ((real)re->nexchange[i])/re->nattempt[i%2];
1341             }
1342         }
1343         print_ind(fplog, "", re->nrepl, re->ind, nullptr);
1344         print_prob(fplog, "", re->nrepl, re->prob);
1345
1346         fprintf(fplog, "\n");
1347     }
1348     /* print the transition matrix */
1349     print_transition_matrix(fplog, re->nrepl, re->nmoves, re->nattempt);
1350 }