Extend task assignment code
[alexxy/gromacs.git] / src / gromacs / gmxana / gmx_tune_pme.cpp
1 /*
2  * This file is part of the GROMACS molecular simulation package.
3  *
4  * Copyright (c) 2009,2010,2011,2012,2013,2014,2015,2016,2017, by the GROMACS development team, led by
5  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
6  * and including many others, as listed in the AUTHORS file in the
7  * top-level source directory and at http://www.gromacs.org.
8  *
9  * GROMACS is free software; you can redistribute it and/or
10  * modify it under the terms of the GNU Lesser General Public License
11  * as published by the Free Software Foundation; either version 2.1
12  * of the License, or (at your option) any later version.
13  *
14  * GROMACS is distributed in the hope that it will be useful,
15  * but WITHOUT ANY WARRANTY; without even the implied warranty of
16  * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE.  See the GNU
17  * Lesser General Public License for more details.
18  *
19  * You should have received a copy of the GNU Lesser General Public
20  * License along with GROMACS; if not, see
21  * http://www.gnu.org/licenses, or write to the Free Software Foundation,
22  * Inc., 51 Franklin Street, Fifth Floor, Boston, MA  02110-1301  USA.
23  *
24  * If you want to redistribute modifications to GROMACS, please
25  * consider that scientific software is very special. Version
26  * control is crucial - bugs must be traceable. We will be happy to
27  * consider code for inclusion in the official distribution, but
28  * derived work must not be called official GROMACS. Details are found
29  * in the README & COPYING files - if they are missing, get the
30  * official version at http://www.gromacs.org.
31  *
32  * To help us fund GROMACS development, we humbly ask that you cite
33  * the research papers on the package. Check out http://www.gromacs.org.
34  */
35 #include "gmxpre.h"
36
37 #include "config.h"
38
39 #include <cmath>
40 #include <cstdlib>
41 #include <cstring>
42 #include <ctime>
43
44 #include <algorithm>
45 #include <string>
46
47 #ifdef HAVE_SYS_TIME_H
48 #include <sys/time.h>
49 #endif
50
51 #include "gromacs/commandline/pargs.h"
52 #include "gromacs/ewald/pme.h"
53 #include "gromacs/fft/calcgrid.h"
54 #include "gromacs/fileio/checkpoint.h"
55 #include "gromacs/fileio/tpxio.h"
56 #include "gromacs/gmxana/gmx_ana.h"
57 #include "gromacs/math/utilities.h"
58 #include "gromacs/math/vec.h"
59 #include "gromacs/mdlib/perf_est.h"
60 #include "gromacs/mdtypes/commrec.h"
61 #include "gromacs/mdtypes/inputrec.h"
62 #include "gromacs/mdtypes/md_enums.h"
63 #include "gromacs/mdtypes/state.h"
64 #include "gromacs/pbcutil/pbc.h"
65 #include "gromacs/taskassignment/usergpuids.h"
66 #include "gromacs/timing/walltime_accounting.h"
67 #include "gromacs/topology/topology.h"
68 #include "gromacs/utility/arraysize.h"
69 #include "gromacs/utility/baseversion.h"
70 #include "gromacs/utility/cstringutil.h"
71 #include "gromacs/utility/fatalerror.h"
72 #include "gromacs/utility/futil.h"
73 #include "gromacs/utility/gmxassert.h"
74 #include "gromacs/utility/smalloc.h"
75 #include "gromacs/utility/stringutil.h"
76
77 /* Enum for situations that can occur during log file parsing, the
78  * corresponding string entries can be found in do_the_tests() in
79  * const char* ParseLog[] */
80 /* TODO clean up CamelCasing of these enum names */
81 enum {
82     eParselogOK,
83     eParselogNotFound,
84     eParselogNoPerfData,
85     eParselogTerm,
86     eParselogResetProblem,
87     eParselogNoDDGrid,
88     eParselogTPXVersion,
89     eParselogNotParallel,
90     eParselogLargePrimeFactor,
91     eParselogMismatchOfNumberOfPPRanksAndAvailableGPUs,
92     eParselogGpuProblem,
93     eParselogFatal,
94     eParselogNr
95 };
96
97
98 typedef struct
99 {
100     int     nPMEnodes;    /* number of PME-only nodes used in this test */
101     int     nx, ny, nz;   /* DD grid */
102     int     guessPME;     /* if nPMEnodes == -1, this is the guessed number of PME nodes */
103     double *Gcycles;      /* This can contain more than one value if doing multiple tests */
104     double  Gcycles_Av;
105     float  *ns_per_day;
106     float   ns_per_day_Av;
107     float  *PME_f_load;     /* PME mesh/force load average*/
108     float   PME_f_load_Av;  /* Average average ;) ... */
109     char   *mdrun_cmd_line; /* Mdrun command line used for this test */
110 } t_perf;
111
112
113 typedef struct
114 {
115     int             nr_inputfiles;   /* The number of tpr and mdp input files */
116     gmx_int64_t     orig_sim_steps;  /* Number of steps to be done in the real simulation */
117     gmx_int64_t     orig_init_step;  /* Init step for the real simulation */
118     real           *rcoulomb;        /* The coulomb radii [0...nr_inputfiles] */
119     real           *rvdw;            /* The vdW radii */
120     real           *rlist;           /* Neighbourlist cutoff radius */
121     int            *nkx, *nky, *nkz;
122     real           *fsx, *fsy, *fsz; /* Fourierspacing in x,y,z dimension */
123 } t_inputinfo;
124
125
126 static void sep_line(FILE *fp)
127 {
128     fprintf(fp, "\n------------------------------------------------------------\n");
129 }
130
131
132 /* Wrapper for system calls */
133 static int gmx_system_call(char *command)
134 {
135     return ( system(command) );
136 }
137
138
139 /* Check if string starts with substring */
140 static gmx_bool str_starts(const char *string, const char *substring)
141 {
142     return ( std::strncmp(string, substring, std::strlen(substring)) == 0);
143 }
144
145
146 static void cleandata(t_perf *perfdata, int test_nr)
147 {
148     perfdata->Gcycles[test_nr]    = 0.0;
149     perfdata->ns_per_day[test_nr] = 0.0;
150     perfdata->PME_f_load[test_nr] = 0.0;
151
152     return;
153 }
154
155
156 static void remove_if_exists(const char *fn)
157 {
158     if (gmx_fexist(fn))
159     {
160         fprintf(stdout, "Deleting %s\n", fn);
161         remove(fn);
162     }
163 }
164
165
166 static void finalize(const char *fn_out)
167 {
168     char  buf[STRLEN];
169     FILE *fp;
170
171
172     fp = fopen(fn_out, "r");
173     fprintf(stdout, "\n\n");
174
175     while (fgets(buf, STRLEN-1, fp) != nullptr)
176     {
177         fprintf(stdout, "%s", buf);
178     }
179     fclose(fp);
180     fprintf(stdout, "\n\n");
181 }
182
183
184 enum {
185     eFoundNothing, eFoundDDStr, eFoundAccountingStr, eFoundCycleStr
186 };
187
188 static int parse_logfile(const char *logfile, const char *errfile,
189                          t_perf *perfdata, int test_nr, int presteps, gmx_int64_t cpt_steps,
190                          int nnodes)
191 {
192     FILE           *fp;
193     char            line[STRLEN], dumstring[STRLEN], dumstring2[STRLEN];
194     const char      matchstrdd[]  = "Domain decomposition grid";
195     const char      matchstrcr[]  = "resetting all time and cycle counters";
196     const char      matchstrbal[] = "Average PME mesh/force load:";
197     const char      matchstring[] = "R E A L   C Y C L E   A N D   T I M E   A C C O U N T I N G";
198     const char      errSIG[]      = "signal, stopping at the next";
199     int             iFound;
200     float           dum1, dum2, dum3, dum4;
201     int             ndum;
202     int             npme;
203     gmx_int64_t     resetsteps     = -1;
204     gmx_bool        bFoundResetStr = FALSE;
205     gmx_bool        bResetChecked  = FALSE;
206
207
208     if (!gmx_fexist(logfile))
209     {
210         fprintf(stderr, "WARNING: Could not find logfile %s.\n", logfile);
211         cleandata(perfdata, test_nr);
212         return eParselogNotFound;
213     }
214
215     fp = fopen(logfile, "r");
216     perfdata->PME_f_load[test_nr] = -1.0;
217     perfdata->guessPME            = -1;
218
219     iFound = eFoundNothing;
220     if (1 == nnodes)
221     {
222         iFound = eFoundDDStr; /* Skip some case statements */
223     }
224
225     while (fgets(line, STRLEN, fp) != nullptr)
226     {
227         /* Remove leading spaces */
228         ltrim(line);
229
230         /* Check for TERM and INT signals from user: */
231         if (std::strstr(line, errSIG) != nullptr)
232         {
233             fclose(fp);
234             cleandata(perfdata, test_nr);
235             return eParselogTerm;
236         }
237
238         /* Check whether cycle resetting  worked */
239         if (presteps > 0 && !bFoundResetStr)
240         {
241             if (std::strstr(line, matchstrcr) != nullptr)
242             {
243                 sprintf(dumstring, "step %s", "%" GMX_SCNd64);
244                 sscanf(line, dumstring, &resetsteps);
245                 bFoundResetStr = TRUE;
246                 if (resetsteps == presteps+cpt_steps)
247                 {
248                     bResetChecked = TRUE;
249                 }
250                 else
251                 {
252                     sprintf(dumstring, "%" GMX_PRId64, resetsteps);
253                     sprintf(dumstring2, "%" GMX_PRId64, presteps+cpt_steps);
254                     fprintf(stderr, "WARNING: Time step counters were reset at step %s,\n"
255                             "         though they were supposed to be reset at step %s!\n",
256                             dumstring, dumstring2);
257                 }
258             }
259         }
260
261         /* Look for strings that appear in a certain order in the log file: */
262         switch (iFound)
263         {
264             case eFoundNothing:
265                 /* Look for domain decomp grid and separate PME nodes: */
266                 if (str_starts(line, matchstrdd))
267                 {
268                     sscanf(line, "Domain decomposition grid %d x %d x %d, separate PME ranks %d",
269                            &(perfdata->nx), &(perfdata->ny), &(perfdata->nz), &npme);
270                     if (perfdata->nPMEnodes == -1)
271                     {
272                         perfdata->guessPME = npme;
273                     }
274                     else if (perfdata->nPMEnodes != npme)
275                     {
276                         gmx_fatal(FARGS, "PME ranks from command line and output file are not identical");
277                     }
278                     iFound = eFoundDDStr;
279                 }
280                 /* Catch a few errors that might have occurred: */
281                 else if (str_starts(line, "There is no domain decomposition for"))
282                 {
283                     fclose(fp);
284                     return eParselogNoDDGrid;
285                 }
286                 else if (str_starts(line, "The number of ranks you selected"))
287                 {
288                     fclose(fp);
289                     return eParselogLargePrimeFactor;
290                 }
291                 else if (str_starts(line, "reading tpx file"))
292                 {
293                     fclose(fp);
294                     return eParselogTPXVersion;
295                 }
296                 else if (str_starts(line, "The -dd or -npme option request a parallel simulation"))
297                 {
298                     fclose(fp);
299                     return eParselogNotParallel;
300                 }
301                 break;
302             case eFoundDDStr:
303                 /* Even after the "Domain decomposition grid" string was found,
304                  * it could be that mdrun had to quit due to some error. */
305                 if (str_starts(line, "Incorrect launch configuration: mismatching number of"))
306                 {
307                     fclose(fp);
308                     return eParselogMismatchOfNumberOfPPRanksAndAvailableGPUs;
309                 }
310                 else if (str_starts(line, "Some of the requested GPUs do not exist"))
311                 {
312                     fclose(fp);
313                     return eParselogGpuProblem;
314                 }
315                 /* Look for PME mesh/force balance (not necessarily present, though) */
316                 else if (str_starts(line, matchstrbal))
317                 {
318                     sscanf(&line[std::strlen(matchstrbal)], "%f", &(perfdata->PME_f_load[test_nr]));
319                 }
320                 /* Look for matchstring */
321                 else if (str_starts(line, matchstring))
322                 {
323                     iFound = eFoundAccountingStr;
324                 }
325                 break;
326             case eFoundAccountingStr:
327                 /* Already found matchstring - look for cycle data */
328                 if (str_starts(line, "Total  "))
329                 {
330                     sscanf(line, "Total %*f %lf", &(perfdata->Gcycles[test_nr]));
331                     iFound = eFoundCycleStr;
332                 }
333                 break;
334             case eFoundCycleStr:
335                 /* Already found cycle data - look for remaining performance info and return */
336                 if (str_starts(line, "Performance:"))
337                 {
338                     ndum = sscanf(line, "%s %f %f %f %f", dumstring, &dum1, &dum2, &dum3, &dum4);
339                     /* (ns/day) is the second last entry, depending on whether GMX_DETAILED_PERF_STATS was set in print_perf(), nrnb.c */
340                     perfdata->ns_per_day[test_nr] = (ndum == 5) ? dum3 : dum1;
341                     fclose(fp);
342                     if (bResetChecked || presteps == 0)
343                     {
344                         return eParselogOK;
345                     }
346                     else
347                     {
348                         return eParselogResetProblem;
349                     }
350                 }
351                 break;
352         }
353     } /* while */
354
355     /* Close the log file */
356     fclose(fp);
357
358     /* Check why there is no performance data in the log file.
359      * Did a fatal errors occur? */
360     if (gmx_fexist(errfile))
361     {
362         fp = fopen(errfile, "r");
363         while (fgets(line, STRLEN, fp) != nullptr)
364         {
365             if (str_starts(line, "Fatal error:") )
366             {
367                 if (fgets(line, STRLEN, fp) != nullptr)
368                 {
369                     fprintf(stderr, "\nWARNING: An error occurred during this benchmark:\n"
370                             "%s\n", line);
371                 }
372                 fclose(fp);
373                 cleandata(perfdata, test_nr);
374                 return eParselogFatal;
375             }
376         }
377         fclose(fp);
378     }
379     else
380     {
381         fprintf(stderr, "WARNING: Could not find stderr file %s.\n", errfile);
382     }
383
384     /* Giving up ... we could not find out why there is no performance data in
385      * the log file. */
386     fprintf(stdout, "No performance data in log file.\n");
387     cleandata(perfdata, test_nr);
388
389     return eParselogNoPerfData;
390 }
391
392
393 static gmx_bool analyze_data(
394         FILE         *fp,
395         const char   *fn,
396         t_perf      **perfdata,
397         int           nnodes,
398         int           ntprs,
399         int           ntests,
400         int           nrepeats,
401         t_inputinfo  *info,
402         int          *index_tpr,    /* OUT: Nr of mdp file with best settings */
403         int          *npme_optimal) /* OUT: Optimal number of PME nodes */
404 {
405     int      i, j, k;
406     int      line  = 0, line_win = -1;
407     int      k_win = -1, i_win = -1, winPME;
408     double   s     = 0.0; /* standard deviation */
409     t_perf  *pd;
410     char     strbuf[STRLEN];
411     char     str_PME_f_load[13];
412     gmx_bool bCanUseOrigTPR;
413     gmx_bool bRefinedCoul, bRefinedVdW, bRefinedGrid;
414
415
416     if (nrepeats > 1)
417     {
418         sep_line(fp);
419         fprintf(fp, "Summary of successful runs:\n");
420         fprintf(fp, "Line tpr PME ranks  Gcycles Av.     Std.dev.       ns/day        PME/f");
421         if (nnodes > 1)
422         {
423             fprintf(fp, "    DD grid");
424         }
425         fprintf(fp, "\n");
426     }
427
428
429     for (k = 0; k < ntprs; k++)
430     {
431         for (i = 0; i < ntests; i++)
432         {
433             /* Select the right dataset: */
434             pd = &(perfdata[k][i]);
435
436             pd->Gcycles_Av    = 0.0;
437             pd->PME_f_load_Av = 0.0;
438             pd->ns_per_day_Av = 0.0;
439
440             if (pd->nPMEnodes == -1)
441             {
442                 sprintf(strbuf, "(%3d)", pd->guessPME);
443             }
444             else
445             {
446                 sprintf(strbuf, "     ");
447             }
448
449             /* Get the average run time of a setting */
450             for (j = 0; j < nrepeats; j++)
451             {
452                 pd->Gcycles_Av    += pd->Gcycles[j];
453                 pd->PME_f_load_Av += pd->PME_f_load[j];
454             }
455             pd->Gcycles_Av    /= nrepeats;
456             pd->PME_f_load_Av /= nrepeats;
457
458             for (j = 0; j < nrepeats; j++)
459             {
460                 if (pd->ns_per_day[j] > 0.0)
461                 {
462                     pd->ns_per_day_Av += pd->ns_per_day[j];
463                 }
464                 else
465                 {
466                     /* Somehow the performance number was not aquired for this run,
467                      * therefor set the average to some negative value: */
468                     pd->ns_per_day_Av = -1.0f*nrepeats;
469                     break;
470                 }
471             }
472             pd->ns_per_day_Av /= nrepeats;
473
474             /* Nicer output: */
475             if (pd->PME_f_load_Av > 0.0)
476             {
477                 sprintf(str_PME_f_load, "%12.3f", pd->PME_f_load_Av);
478             }
479             else
480             {
481                 sprintf(str_PME_f_load, "%s", "         -  ");
482             }
483
484
485             /* We assume we had a successful run if both averages are positive */
486             if (pd->Gcycles_Av > 0.0 && pd->ns_per_day_Av > 0.0)
487             {
488                 /* Output statistics if repeats were done */
489                 if (nrepeats > 1)
490                 {
491                     /* Calculate the standard deviation */
492                     s = 0.0;
493                     for (j = 0; j < nrepeats; j++)
494                     {
495                         s += gmx::square( pd->Gcycles[j] - pd->Gcycles_Av );
496                     }
497                     s /= (nrepeats - 1);
498                     s  = std::sqrt(s);
499
500                     fprintf(fp, "%4d %3d %4d%s %12.3f %12.3f %12.3f %s",
501                             line, k, pd->nPMEnodes, strbuf, pd->Gcycles_Av, s,
502                             pd->ns_per_day_Av, str_PME_f_load);
503                     if (nnodes > 1)
504                     {
505                         fprintf(fp, "  %3d %3d %3d", pd->nx, pd->ny, pd->nz);
506                     }
507                     fprintf(fp, "\n");
508                 }
509                 /* Store the index of the best run found so far in 'winner': */
510                 if ( (k_win == -1) || (pd->Gcycles_Av < perfdata[k_win][i_win].Gcycles_Av) )
511                 {
512                     k_win    = k;
513                     i_win    = i;
514                     line_win = line;
515                 }
516                 line++;
517             }
518         }
519     }
520
521     if (k_win == -1)
522     {
523         gmx_fatal(FARGS, "None of the runs was successful! Check %s for problems.", fn);
524     }
525
526     sep_line(fp);
527
528     winPME = perfdata[k_win][i_win].nPMEnodes;
529
530     if (1 == ntests)
531     {
532         /* We stuck to a fixed number of PME-only nodes */
533         sprintf(strbuf, "settings No. %d", k_win);
534     }
535     else
536     {
537         /* We have optimized the number of PME-only nodes */
538         if (winPME == -1)
539         {
540             sprintf(strbuf, "%s", "the automatic number of PME ranks");
541         }
542         else
543         {
544             sprintf(strbuf, "%d PME ranks", winPME);
545         }
546     }
547     fprintf(fp, "Best performance was achieved with %s", strbuf);
548     if ((nrepeats > 1) && (ntests > 1))
549     {
550         fprintf(fp, " (see line %d)", line_win);
551     }
552     fprintf(fp, "\n");
553
554     /* Only mention settings if they were modified: */
555     bRefinedCoul = !gmx_within_tol(info->rcoulomb[k_win], info->rcoulomb[0], GMX_REAL_EPS);
556     bRefinedVdW  = !gmx_within_tol(info->rvdw[k_win], info->rvdw[0], GMX_REAL_EPS);
557     bRefinedGrid = !(info->nkx[k_win] == info->nkx[0] &&
558                      info->nky[k_win] == info->nky[0] &&
559                      info->nkz[k_win] == info->nkz[0]);
560
561     if (bRefinedCoul || bRefinedVdW || bRefinedGrid)
562     {
563         fprintf(fp, "Optimized PME settings:\n");
564         bCanUseOrigTPR = FALSE;
565     }
566     else
567     {
568         bCanUseOrigTPR = TRUE;
569     }
570
571     if (bRefinedCoul)
572     {
573         fprintf(fp, "   New Coulomb radius: %f nm (was %f nm)\n", info->rcoulomb[k_win], info->rcoulomb[0]);
574     }
575
576     if (bRefinedVdW)
577     {
578         fprintf(fp, "   New Van der Waals radius: %f nm (was %f nm)\n", info->rvdw[k_win], info->rvdw[0]);
579     }
580
581     if (bRefinedGrid)
582     {
583         fprintf(fp, "   New Fourier grid xyz: %d %d %d (was %d %d %d)\n", info->nkx[k_win], info->nky[k_win], info->nkz[k_win],
584                 info->nkx[0], info->nky[0], info->nkz[0]);
585     }
586
587     if (bCanUseOrigTPR && ntprs > 1)
588     {
589         fprintf(fp, "and original PME settings.\n");
590     }
591
592     fflush(fp);
593
594     /* Return the index of the mdp file that showed the highest performance
595      * and the optimal number of PME nodes */
596     *index_tpr    = k_win;
597     *npme_optimal = winPME;
598
599     return bCanUseOrigTPR;
600 }
601
602
603 /* Get the commands we need to set up the runs from environment variables */
604 static void get_program_paths(gmx_bool bThreads, char *cmd_mpirun[], char *cmd_mdrun[])
605 {
606     char      *cp;
607     const char def_mpirun[]   = "mpirun";
608
609     const char empty_mpirun[] = "";
610
611     /* Get the commands we need to set up the runs from environment variables */
612     if (!bThreads)
613     {
614         if ( (cp = getenv("MPIRUN")) != nullptr)
615         {
616             *cmd_mpirun = gmx_strdup(cp);
617         }
618         else
619         {
620             *cmd_mpirun = gmx_strdup(def_mpirun);
621         }
622     }
623     else
624     {
625         *cmd_mpirun = gmx_strdup(empty_mpirun);
626     }
627
628     if (*cmd_mdrun == nullptr)
629     {
630         /* The use of MDRUN is deprecated, but made available in 5.1
631            for backward compatibility. It may be removed in a future
632            version. */
633         if ( (cp = getenv("MDRUN" )) != nullptr)
634         {
635             *cmd_mdrun = gmx_strdup(cp);
636         }
637         else
638         {
639             gmx_fatal(FARGS, "The way to call mdrun must be set in the -mdrun command-line flag.");
640         }
641     }
642 }
643
644 /* Check that the commands will run mdrun (perhaps via mpirun) by
645  * running a very quick test simulation. Requires MPI environment or
646  * GPU support to be available if applicable. */
647 /* TODO implement feature to parse the log file to get the list of
648    compatible GPUs from mdrun, if the user of gmx tune-pme has not
649    given one. */
650 static void check_mdrun_works(gmx_bool    bThreads,
651                               const char *cmd_mpirun,
652                               const char *cmd_np,
653                               const char *cmd_mdrun,
654                               gmx_bool    bNeedGpuSupport)
655 {
656     char      *command = nullptr;
657     char      *cp;
658     char       line[STRLEN];
659     FILE      *fp;
660     const char filename[]     = "benchtest.log";
661
662     /* This string should always be identical to the one in copyrite.c,
663      * gmx_print_version_info() in the GMX_MPI section */
664     const char match_mpi[]     = "MPI library:        MPI";
665     const char match_mdrun[]   = "Executable: ";
666     const char match_nogpu[]   = "GPU support:        disabled";
667     gmx_bool   bMdrun          = FALSE;
668     gmx_bool   bMPI            = FALSE;
669     gmx_bool   bHaveGpuSupport = TRUE;
670
671     /* Run a small test to see whether mpirun + mdrun work  */
672     fprintf(stdout, "Making sure that mdrun can be executed. ");
673     if (bThreads)
674     {
675         snew(command, std::strlen(cmd_mdrun) + std::strlen(cmd_np) + std::strlen(filename) + 50);
676         sprintf(command, "%s%s -version -maxh 0.001 1> %s 2>&1", cmd_mdrun, cmd_np, filename);
677     }
678     else
679     {
680         snew(command, std::strlen(cmd_mpirun) + std::strlen(cmd_np) + std::strlen(cmd_mdrun) + std::strlen(filename) + 50);
681         sprintf(command, "%s%s%s -version -maxh 0.001 1> %s 2>&1", cmd_mpirun, cmd_np, cmd_mdrun, filename);
682     }
683     fprintf(stdout, "Trying '%s' ... ", command);
684     make_backup(filename);
685     gmx_system_call(command);
686
687     /* Check if we find the characteristic string in the output: */
688     if (!gmx_fexist(filename))
689     {
690         gmx_fatal(FARGS, "Output from test run could not be found.");
691     }
692
693     fp = fopen(filename, "r");
694     /* We need to scan the whole output file, since sometimes the queuing system
695      * also writes stuff to stdout/err */
696     while (!feof(fp) )
697     {
698         cp = fgets(line, STRLEN, fp);
699         if (cp != nullptr)
700         {
701             if (str_starts(line, match_mdrun) )
702             {
703                 bMdrun = TRUE;
704             }
705             if (str_starts(line, match_mpi) )
706             {
707                 bMPI = TRUE;
708             }
709             if (str_starts(line, match_nogpu) )
710             {
711                 bHaveGpuSupport = FALSE;
712             }
713         }
714     }
715     fclose(fp);
716
717     if (bThreads)
718     {
719         if (bMPI)
720         {
721             gmx_fatal(FARGS, "Need a threaded version of mdrun. This one\n"
722                       "(%s)\n"
723                       "seems to have been compiled with MPI instead.",
724                       cmd_mdrun);
725         }
726     }
727     else
728     {
729         if (bMdrun && !bMPI)
730         {
731             gmx_fatal(FARGS, "Need an MPI-enabled version of mdrun. This one\n"
732                       "(%s)\n"
733                       "seems to have been compiled without MPI support.",
734                       cmd_mdrun);
735         }
736     }
737
738     if (!bMdrun)
739     {
740         gmx_fatal(FARGS, "Cannot execute mdrun. Please check %s for problems!",
741                   filename);
742     }
743
744     if (bNeedGpuSupport && !bHaveGpuSupport)
745     {
746         gmx_fatal(FARGS, "The mdrun executable did not have the expected GPU support.");
747     }
748
749     fprintf(stdout, "passed.\n");
750
751     /* Clean up ... */
752     remove(filename);
753     sfree(command);
754 }
755
756 /* Handles the no-GPU case by emitting an empty string. */
757 static std::string make_gpu_id_command_line(const char *eligible_gpu_ids)
758 {
759     /* If the user has given no eligible GPU IDs, or we're trying the
760      * default behaviour, then there is nothing for tune_pme to give
761      * to mdrun -gpu_id */
762     if (eligible_gpu_ids != nullptr)
763     {
764         return gmx::formatString("-gpu_id %s", eligible_gpu_ids);
765     }
766
767
768     return std::string();
769 }
770
771 static void launch_simulation(
772         gmx_bool    bLaunch,          /* Should the simulation be launched? */
773         FILE       *fp,               /* General log file */
774         gmx_bool    bThreads,         /* whether to use threads */
775         char       *cmd_mpirun,       /* Command for mpirun */
776         char       *cmd_np,           /* Switch for -np or -ntmpi or empty */
777         char       *cmd_mdrun,        /* Command for mdrun */
778         char       *args_for_mdrun,   /* Arguments for mdrun */
779         const char *simulation_tpr,   /* This tpr will be simulated */
780         int         nPMEnodes,        /* Number of PME ranks to use */
781         const char *eligible_gpu_ids) /* Available GPU IDs for
782                                        * constructing mdrun command lines */
783 {
784     char  *command;
785
786
787     /* Make enough space for the system call command,
788      * (200 extra chars for -npme ... etc. options should suffice): */
789     snew(command, std::strlen(cmd_mpirun)+std::strlen(cmd_mdrun)+std::strlen(cmd_np)+std::strlen(args_for_mdrun)+std::strlen(simulation_tpr)+200);
790
791     auto cmd_gpu_ids = make_gpu_id_command_line(eligible_gpu_ids);
792
793     /* Note that the -passall options requires args_for_mdrun to be at the end
794      * of the command line string */
795     if (bThreads)
796     {
797         sprintf(command, "%s%s-npme %d -s %s %s %s",
798                 cmd_mdrun, cmd_np, nPMEnodes, simulation_tpr, args_for_mdrun, cmd_gpu_ids.c_str());
799     }
800     else
801     {
802         sprintf(command, "%s%s%s -npme %d -s %s %s %s",
803                 cmd_mpirun, cmd_np, cmd_mdrun, nPMEnodes, simulation_tpr, args_for_mdrun, cmd_gpu_ids.c_str());
804     }
805
806     fprintf(fp, "%s this command line to launch the simulation:\n\n%s", bLaunch ? "Using" : "Please use", command);
807     sep_line(fp);
808     fflush(fp);
809
810     /* Now the real thing! */
811     if (bLaunch)
812     {
813         fprintf(stdout, "\nLaunching simulation with best parameters now.\nExecuting '%s'", command);
814         sep_line(stdout);
815         fflush(stdout);
816         gmx_system_call(command);
817     }
818 }
819
820
821 static void modify_PMEsettings(
822         gmx_int64_t     simsteps,    /* Set this value as number of time steps */
823         gmx_int64_t     init_step,   /* Set this value as init_step */
824         const char     *fn_best_tpr, /* tpr file with the best performance */
825         const char     *fn_sim_tpr)  /* name of tpr file to be launched */
826 {
827     t_state        state;
828     gmx_mtop_t     mtop;
829     char           buf[200];
830
831     t_inputrec     irInstance;
832     t_inputrec    *ir = &irInstance;
833     read_tpx_state(fn_best_tpr, ir, &state, &mtop);
834
835     /* Reset nsteps and init_step to the value of the input .tpr file */
836     ir->nsteps    = simsteps;
837     ir->init_step = init_step;
838
839     /* Write the tpr file which will be launched */
840     sprintf(buf, "Writing optimized simulation file %s with nsteps=%s.\n", fn_sim_tpr, "%" GMX_PRId64);
841     fprintf(stdout, buf, ir->nsteps);
842     fflush(stdout);
843     write_tpx_state(fn_sim_tpr, ir, &state, &mtop);
844 }
845
846 static gmx_bool can_scale_rvdw(int vdwtype)
847 {
848     return (evdwCUT == vdwtype ||
849             evdwPME == vdwtype);
850 }
851
852 #define EPME_SWITCHED(e) ((e) == eelPMESWITCH || (e) == eelPMEUSERSWITCH)
853
854 /* Make additional TPR files with more computational load for the
855  * direct space processors: */
856 static void make_benchmark_tprs(
857         const char     *fn_sim_tpr,      /* READ : User-provided tpr file                 */
858         char           *fn_bench_tprs[], /* WRITE: Names of benchmark tpr files           */
859         gmx_int64_t     benchsteps,      /* Number of time steps for benchmark runs       */
860         gmx_int64_t     statesteps,      /* Step counter in checkpoint file               */
861         real            rmin,            /* Minimal Coulomb radius                        */
862         real            rmax,            /* Maximal Coulomb radius                        */
863         real            bScaleRvdw,      /* Scale rvdw along with rcoulomb                */
864         int            *ntprs,           /* No. of TPRs to write, each with a different
865                                             rcoulomb and fourierspacing                   */
866         t_inputinfo    *info,            /* Contains information about mdp file options   */
867         FILE           *fp)              /* Write the output here                         */
868 {
869     int           i, j, d;
870     t_state       state;
871     gmx_mtop_t    mtop;
872     real          nlist_buffer;     /* Thickness of the buffer regions for PME-switch potentials */
873     char          buf[200];
874     rvec          box_size;
875     gmx_bool      bNote = FALSE;
876     real          add;              /* Add this to rcoul for the next test    */
877     real          fac = 1.0;        /* Scaling factor for Coulomb radius      */
878     real          fourierspacing;   /* Basic fourierspacing from tpr          */
879
880
881     sprintf(buf, "Making benchmark tpr file%s with %s time step%s",
882             *ntprs > 1 ? "s" : "", "%" GMX_PRId64, benchsteps > 1 ? "s" : "");
883     fprintf(stdout, buf, benchsteps);
884     if (statesteps > 0)
885     {
886         sprintf(buf, " (adding %s steps from checkpoint file)", "%" GMX_PRId64);
887         fprintf(stdout, buf, statesteps);
888         benchsteps += statesteps;
889     }
890     fprintf(stdout, ".\n");
891
892     t_inputrec  irInstance;
893     t_inputrec *ir = &irInstance;
894     read_tpx_state(fn_sim_tpr, ir, &state, &mtop);
895
896     /* Check if some kind of PME was chosen */
897     if (EEL_PME(ir->coulombtype) == FALSE)
898     {
899         gmx_fatal(FARGS, "Can only do optimizations for simulations with %s electrostatics.",
900                   EELTYPE(eelPME));
901     }
902
903     /* Check if rcoulomb == rlist, which is necessary for plain PME. */
904     if (  (ir->cutoff_scheme != ecutsVERLET) &&
905           (eelPME == ir->coulombtype) && !(ir->rcoulomb == ir->rlist))
906     {
907         gmx_fatal(FARGS, "%s requires rcoulomb (%f) to be equal to rlist (%f).",
908                   EELTYPE(eelPME), ir->rcoulomb, ir->rlist);
909     }
910     /* For other PME types, rcoulomb is allowed to be smaller than rlist */
911     else if (ir->rcoulomb > ir->rlist)
912     {
913         gmx_fatal(FARGS, "%s requires rcoulomb (%f) to be equal to or smaller than rlist (%f)",
914                   EELTYPE(ir->coulombtype), ir->rcoulomb, ir->rlist);
915     }
916
917     if (bScaleRvdw && ir->rvdw != ir->rcoulomb)
918     {
919         fprintf(stdout, "NOTE: input rvdw != rcoulomb, will not scale rvdw\n");
920         bScaleRvdw = FALSE;
921     }
922
923     /* Reduce the number of steps for the benchmarks */
924     info->orig_sim_steps = ir->nsteps;
925     ir->nsteps           = benchsteps;
926     /* We must not use init_step from the input tpr file for the benchmarks */
927     info->orig_init_step = ir->init_step;
928     ir->init_step        = 0;
929
930     /* For PME-switch potentials, keep the radial distance of the buffer region */
931     nlist_buffer   = ir->rlist - ir->rcoulomb;
932
933     /* Determine length of triclinic box vectors */
934     for (d = 0; d < DIM; d++)
935     {
936         box_size[d] = 0;
937         for (i = 0; i < DIM; i++)
938         {
939             box_size[d] += state.box[d][i]*state.box[d][i];
940         }
941         box_size[d] = std::sqrt(box_size[d]);
942     }
943
944     if (ir->fourier_spacing > 0)
945     {
946         info->fsx[0] = ir->fourier_spacing;
947         info->fsy[0] = ir->fourier_spacing;
948         info->fsz[0] = ir->fourier_spacing;
949     }
950     else
951     {
952         /* Reconstruct fourierspacing per dimension from the number of grid points and box size */
953         info->fsx[0] = box_size[XX]/ir->nkx;
954         info->fsy[0] = box_size[YY]/ir->nky;
955         info->fsz[0] = box_size[ZZ]/ir->nkz;
956     }
957
958     /* If no value for the fourierspacing was provided on the command line, we
959      * use the reconstruction from the tpr file */
960     if (ir->fourier_spacing > 0)
961     {
962         /* Use the spacing from the tpr */
963         fourierspacing = ir->fourier_spacing;
964     }
965     else
966     {
967         /* Use the maximum observed spacing */
968         fourierspacing = std::max(std::max(info->fsx[0], info->fsy[0]), info->fsz[0]);
969     }
970
971     fprintf(stdout, "Calculating PME grid points on the basis of a fourierspacing of %f nm\n", fourierspacing);
972
973     /* For performance comparisons the number of particles is useful to have */
974     fprintf(fp, "   Number of particles  : %d\n", mtop.natoms);
975
976     /* Print information about settings of which some are potentially modified: */
977     fprintf(fp, "   Coulomb type         : %s\n", EELTYPE(ir->coulombtype));
978     fprintf(fp, "   Grid spacing x y z   : %f %f %f\n",
979             box_size[XX]/ir->nkx, box_size[YY]/ir->nky, box_size[ZZ]/ir->nkz);
980     fprintf(fp, "   Van der Waals type   : %s\n", EVDWTYPE(ir->vdwtype));
981     if (ir_vdw_switched(ir))
982     {
983         fprintf(fp, "   rvdw_switch          : %f nm\n", ir->rvdw_switch);
984     }
985     if (EPME_SWITCHED(ir->coulombtype))
986     {
987         fprintf(fp, "   rlist                : %f nm\n", ir->rlist);
988     }
989
990     /* Print a descriptive line about the tpr settings tested */
991     fprintf(fp, "\nWill try these real/reciprocal workload settings:\n");
992     fprintf(fp, " No.   scaling  rcoulomb");
993     fprintf(fp, "  nkx  nky  nkz");
994     fprintf(fp, "   spacing");
995     if (can_scale_rvdw(ir->vdwtype))
996     {
997         fprintf(fp, "      rvdw");
998     }
999     if (EPME_SWITCHED(ir->coulombtype))
1000     {
1001         fprintf(fp, "     rlist");
1002     }
1003     fprintf(fp, "  tpr file\n");
1004
1005     /* Loop to create the requested number of tpr input files */
1006     for (j = 0; j < *ntprs; j++)
1007     {
1008         /* The first .tpr is the provided one, just need to modify nsteps,
1009          * so skip the following block */
1010         if (j != 0)
1011         {
1012             /* Determine which Coulomb radii rc to use in the benchmarks */
1013             add = (rmax-rmin)/(*ntprs-1);
1014             if (gmx_within_tol(rmin, info->rcoulomb[0], GMX_REAL_EPS))
1015             {
1016                 ir->rcoulomb = rmin + j*add;
1017             }
1018             else if (gmx_within_tol(rmax, info->rcoulomb[0], GMX_REAL_EPS))
1019             {
1020                 ir->rcoulomb = rmin + (j-1)*add;
1021             }
1022             else
1023             {
1024                 /* rmin != rcoul != rmax, ergo test between rmin and rmax */
1025                 add          = (rmax-rmin)/(*ntprs-2);
1026                 ir->rcoulomb = rmin + (j-1)*add;
1027             }
1028
1029             /* Determine the scaling factor fac */
1030             fac = ir->rcoulomb/info->rcoulomb[0];
1031
1032             /* Scale the Fourier grid spacing */
1033             ir->nkx = ir->nky = ir->nkz = 0;
1034             calcFftGrid(nullptr, state.box, fourierspacing*fac, minimalPmeGridSize(ir->pme_order),
1035                         &ir->nkx, &ir->nky, &ir->nkz);
1036
1037             /* Adjust other radii since various conditions need to be fulfilled */
1038             if (eelPME == ir->coulombtype)
1039             {
1040                 /* plain PME, rcoulomb must be equal to rlist TODO only in the group scheme? */
1041                 ir->rlist = ir->rcoulomb;
1042             }
1043             else
1044             {
1045                 /* rlist must be >= rcoulomb, we keep the size of the buffer region */
1046                 ir->rlist = ir->rcoulomb + nlist_buffer;
1047             }
1048
1049             if (bScaleRvdw && can_scale_rvdw(ir->vdwtype))
1050             {
1051                 if (ecutsVERLET == ir->cutoff_scheme ||
1052                     evdwPME == ir->vdwtype)
1053                 {
1054                     /* With either the Verlet cutoff-scheme or LJ-PME,
1055                        the van der Waals radius must always equal the
1056                        Coulomb radius */
1057                     ir->rvdw = ir->rcoulomb;
1058                 }
1059                 else
1060                 {
1061                     /* For vdw cutoff, rvdw >= rlist */
1062                     ir->rvdw = std::max(info->rvdw[0], ir->rlist);
1063                 }
1064             }
1065         } /* end of "if (j != 0)" */
1066
1067         /* for j==0: Save the original settings
1068          * for j >0: Save modified radii and Fourier grids */
1069         info->rcoulomb[j]  = ir->rcoulomb;
1070         info->rvdw[j]      = ir->rvdw;
1071         info->nkx[j]       = ir->nkx;
1072         info->nky[j]       = ir->nky;
1073         info->nkz[j]       = ir->nkz;
1074         info->rlist[j]     = ir->rlist;
1075         info->fsx[j]       = fac*fourierspacing;
1076         info->fsy[j]       = fac*fourierspacing;
1077         info->fsz[j]       = fac*fourierspacing;
1078
1079         /* Write the benchmark tpr file */
1080         std::strncpy(fn_bench_tprs[j], fn_sim_tpr, std::strlen(fn_sim_tpr)-std::strlen(".tpr"));
1081         sprintf(buf, "_bench%.2d.tpr", j);
1082         std::strcat(fn_bench_tprs[j], buf);
1083         fprintf(stdout, "Writing benchmark tpr %s with nsteps=", fn_bench_tprs[j]);
1084         fprintf(stdout, "%" GMX_PRId64, ir->nsteps);
1085         if (j > 0)
1086         {
1087             fprintf(stdout, ", scaling factor %f\n", fac);
1088         }
1089         else
1090         {
1091             fprintf(stdout, ", unmodified settings\n");
1092         }
1093
1094         write_tpx_state(fn_bench_tprs[j], ir, &state, &mtop);
1095
1096         /* Write information about modified tpr settings to log file */
1097         fprintf(fp, "%4d%10f%10f", j, fac, ir->rcoulomb);
1098         fprintf(fp, "%5d%5d%5d", ir->nkx, ir->nky, ir->nkz);
1099         fprintf(fp, " %9f ", info->fsx[j]);
1100         if (can_scale_rvdw(ir->vdwtype))
1101         {
1102             fprintf(fp, "%10f", ir->rvdw);
1103         }
1104         if (EPME_SWITCHED(ir->coulombtype))
1105         {
1106             fprintf(fp, "%10f", ir->rlist);
1107         }
1108         fprintf(fp, "  %-14s\n", fn_bench_tprs[j]);
1109
1110         /* Make it clear to the user that some additional settings were modified */
1111         if (!gmx_within_tol(ir->rvdw, info->rvdw[0], GMX_REAL_EPS)
1112             || !gmx_within_tol(ir->rlist, info->rlist[0], GMX_REAL_EPS) )
1113         {
1114             bNote = TRUE;
1115         }
1116     }
1117     if (bNote)
1118     {
1119         fprintf(fp, "\nNote that in addition to the Coulomb radius and the Fourier grid\n"
1120                 "other input settings were also changed (see table above).\n"
1121                 "Please check if the modified settings are appropriate.\n");
1122     }
1123     fflush(stdout);
1124     fflush(fp);
1125 }
1126
1127
1128 /* Rename the files we want to keep to some meaningful filename and
1129  * delete the rest */
1130 static void cleanup(const t_filenm *fnm, int nfile, int k, int nnodes,
1131                     int nPMEnodes, int nr, gmx_bool bKeepStderr)
1132 {
1133     char        numstring[STRLEN];
1134     char        newfilename[STRLEN];
1135     const char *fn = nullptr;
1136     int         i;
1137     const char *opt;
1138
1139
1140     fprintf(stdout, "Cleaning up, deleting benchmark temp files ...\n");
1141
1142     for (i = 0; i < nfile; i++)
1143     {
1144         opt = (char *)fnm[i].opt;
1145         if (std::strcmp(opt, "-p") == 0)
1146         {
1147             /* do nothing; keep this file */
1148             ;
1149         }
1150         else if (std::strcmp(opt, "-bg") == 0)
1151         {
1152             /* Give the log file a nice name so one can later see which parameters were used */
1153             numstring[0] = '\0';
1154             if (nr > 0)
1155             {
1156                 sprintf(numstring, "_%d", nr);
1157             }
1158             sprintf(newfilename, "%s_no%d_np%d_npme%d%s", opt2fn("-bg", nfile, fnm), k, nnodes, nPMEnodes, numstring);
1159             if (gmx_fexist(opt2fn("-bg", nfile, fnm)))
1160             {
1161                 fprintf(stdout, "renaming log file to %s\n", newfilename);
1162                 make_backup(newfilename);
1163                 rename(opt2fn("-bg", nfile, fnm), newfilename);
1164             }
1165         }
1166         else if (std::strcmp(opt, "-err") == 0)
1167         {
1168             /* This file contains the output of stderr. We want to keep it in
1169              * cases where there have been problems. */
1170             fn           = opt2fn(opt, nfile, fnm);
1171             numstring[0] = '\0';
1172             if (nr > 0)
1173             {
1174                 sprintf(numstring, "_%d", nr);
1175             }
1176             sprintf(newfilename, "%s_no%d_np%d_npme%d%s", fn, k, nnodes, nPMEnodes, numstring);
1177             if (gmx_fexist(fn))
1178             {
1179                 if (bKeepStderr)
1180                 {
1181                     fprintf(stdout, "Saving stderr output in %s\n", newfilename);
1182                     make_backup(newfilename);
1183                     rename(fn, newfilename);
1184                 }
1185                 else
1186                 {
1187                     fprintf(stdout, "Deleting %s\n", fn);
1188                     remove(fn);
1189                 }
1190             }
1191         }
1192         /* Delete the files which are created for each benchmark run: (options -b*) */
1193         else if ( (0 == std::strncmp(opt, "-b", 2)) && (opt2bSet(opt, nfile, fnm) || !is_optional(&fnm[i])) )
1194         {
1195             remove_if_exists(opt2fn(opt, nfile, fnm));
1196         }
1197     }
1198 }
1199
1200
1201 enum {
1202     eNpmeAuto, eNpmeAll, eNpmeReduced, eNpmeSubset, eNpmeNr
1203 };
1204
1205 /* Create a list of numbers of PME nodes to test */
1206 static void make_npme_list(
1207         const char *npmevalues_opt, /* Make a complete list with all
1208                                      * possibilities or a short list that keeps only
1209                                      * reasonable numbers of PME nodes                  */
1210         int        *nentries,       /* Number of entries we put in the nPMEnodes list   */
1211         int        *nPMEnodes[],    /* Each entry contains the value for -npme          */
1212         int         nnodes,         /* Total number of nodes to do the tests on         */
1213         int         minPMEnodes,    /* Minimum number of PME nodes                      */
1214         int         maxPMEnodes)    /* Maximum number of PME nodes                      */
1215 {
1216     int i, npme, npp;
1217     int min_factor = 1;   /* We request that npp and npme have this minimal
1218                            * largest common factor (depends on npp)           */
1219     int nlistmax;         /* Max. list size                                   */
1220     int nlist;            /* Actual number of entries in list                 */
1221     int eNPME = 0;
1222
1223
1224     /* Do we need to check all possible values for -npme or is a reduced list enough? */
1225     if (!std::strcmp(npmevalues_opt, "all") )
1226     {
1227         eNPME = eNpmeAll;
1228     }
1229     else if (!std::strcmp(npmevalues_opt, "subset") )
1230     {
1231         eNPME = eNpmeSubset;
1232     }
1233     else /* "auto" or "range" */
1234     {
1235         if (nnodes <= 64)
1236         {
1237             eNPME = eNpmeAll;
1238         }
1239         else if (nnodes < 128)
1240         {
1241             eNPME = eNpmeReduced;
1242         }
1243         else
1244         {
1245             eNPME = eNpmeSubset;
1246         }
1247     }
1248
1249     /* Calculate how many entries we could possibly have (in case of -npme all) */
1250     if (nnodes > 2)
1251     {
1252         nlistmax = maxPMEnodes - minPMEnodes + 3;
1253         if (0 == minPMEnodes)
1254         {
1255             nlistmax--;
1256         }
1257     }
1258     else
1259     {
1260         nlistmax = 1;
1261     }
1262
1263     /* Now make the actual list which is at most of size nlist */
1264     snew(*nPMEnodes, nlistmax);
1265     nlist = 0; /* start counting again, now the real entries in the list */
1266     for (i = 0; i < nlistmax - 2; i++)
1267     {
1268         npme = maxPMEnodes - i;
1269         npp  = nnodes-npme;
1270         switch (eNPME)
1271         {
1272             case eNpmeAll:
1273                 min_factor = 1;
1274                 break;
1275             case eNpmeReduced:
1276                 min_factor = 2;
1277                 break;
1278             case eNpmeSubset:
1279                 /* For 2d PME we want a common largest factor of at least the cube
1280                  * root of the number of PP nodes */
1281                 min_factor = static_cast<int>(std::cbrt(npp));
1282                 break;
1283             default:
1284                 gmx_fatal(FARGS, "Unknown option for eNPME in make_npme_list");
1285                 break;
1286         }
1287         if (gmx_greatest_common_divisor(npp, npme) >= min_factor)
1288         {
1289             (*nPMEnodes)[nlist] = npme;
1290             nlist++;
1291         }
1292     }
1293     /* We always test 0 PME nodes and the automatic number */
1294     *nentries             = nlist + 2;
1295     (*nPMEnodes)[nlist  ] =  0;
1296     (*nPMEnodes)[nlist+1] = -1;
1297
1298     fprintf(stderr, "Will try the following %d different values for -npme:\n", *nentries);
1299     for (i = 0; i < *nentries-1; i++)
1300     {
1301         fprintf(stderr, "%d, ", (*nPMEnodes)[i]);
1302     }
1303     fprintf(stderr, "and %d (auto).\n", (*nPMEnodes)[*nentries-1]);
1304 }
1305
1306
1307 /* Allocate memory to store the performance data */
1308 static void init_perfdata(t_perf *perfdata[], int ntprs, int datasets, int repeats)
1309 {
1310     int i, j, k;
1311
1312
1313     for (k = 0; k < ntprs; k++)
1314     {
1315         snew(perfdata[k], datasets);
1316         for (i = 0; i < datasets; i++)
1317         {
1318             for (j = 0; j < repeats; j++)
1319             {
1320                 snew(perfdata[k][i].Gcycles, repeats);
1321                 snew(perfdata[k][i].ns_per_day, repeats);
1322                 snew(perfdata[k][i].PME_f_load, repeats);
1323             }
1324         }
1325     }
1326 }
1327
1328
1329 /* Check for errors on mdrun -h */
1330 static void make_sure_it_runs(char *mdrun_cmd_line, int length, FILE *fp,
1331                               const t_filenm *fnm, int nfile)
1332 {
1333     char       *command, *msg;
1334     int         ret;
1335
1336     snew(command, length +  15);
1337     snew(msg, length + 500);
1338
1339     fprintf(stdout, "Making sure the benchmarks can be executed by running just 1 step...\n");
1340     sprintf(command, "%s -nsteps 1 -quiet", mdrun_cmd_line);
1341     fprintf(stdout, "Executing '%s' ...\n", command);
1342     ret = gmx_system_call(command);
1343
1344     if (0 != ret)
1345     {
1346         /* To prevent confusion, do not again issue a gmx_fatal here since we already
1347          * get the error message from mdrun itself */
1348         sprintf(msg,
1349                 "Cannot run the first benchmark simulation! Please check the error message of\n"
1350                 "mdrun for the source of the problem. Did you provide a command line\n"
1351                 "argument that neither gmx tune_pme nor mdrun understands? If you're\n"
1352                 "sure your command line should work, you can bypass this check with \n"
1353                 "gmx tune_pme -nocheck. The failing command was:\n"
1354                 "\n%s\n\n", command);
1355
1356         fprintf(stderr, "%s", msg);
1357         sep_line(fp);
1358         fprintf(fp, "%s", msg);
1359
1360         exit(ret);
1361     }
1362     fprintf(stdout, "Benchmarks can be executed!\n");
1363
1364     /* Clean up the benchmark output files we just created */
1365     fprintf(stdout, "Cleaning up ...\n");
1366     remove_if_exists(opt2fn("-bc", nfile, fnm));
1367     remove_if_exists(opt2fn("-be", nfile, fnm));
1368     remove_if_exists(opt2fn("-bcpo", nfile, fnm));
1369     remove_if_exists(opt2fn("-bg", nfile, fnm));
1370     remove_if_exists(opt2fn("-bo", nfile, fnm));
1371     remove_if_exists(opt2fn("-bx", nfile, fnm));
1372
1373     sfree(command);
1374     sfree(msg    );
1375 }
1376
1377 static void do_the_tests(
1378         FILE           *fp,               /* General tune_pme output file           */
1379         char          **tpr_names,        /* Filenames of the input files to test   */
1380         int             maxPMEnodes,      /* Max fraction of nodes to use for PME   */
1381         int             minPMEnodes,      /* Min fraction of nodes to use for PME   */
1382         int             npme_fixed,       /* If >= -1, test fixed number of PME
1383                                            * nodes only                             */
1384         const char     *npmevalues_opt,   /* Which -npme values should be tested    */
1385         t_perf        **perfdata,         /* Here the performace data is stored     */
1386         int            *pmeentries,       /* Entries in the nPMEnodes list          */
1387         int             repeats,          /* Repeat each test this often            */
1388         int             nnodes,           /* Total number of nodes = nPP + nPME     */
1389         int             nr_tprs,          /* Total number of tpr files to test      */
1390         gmx_bool        bThreads,         /* Threads or MPI?                        */
1391         char           *cmd_mpirun,       /* mpirun command string                  */
1392         char           *cmd_np,           /* "-np", "-n", whatever mpirun needs     */
1393         char           *cmd_mdrun,        /* mdrun command string                   */
1394         char           *cmd_args_bench,   /* arguments for mdrun in a string        */
1395         const t_filenm *fnm,              /* List of filenames from command line    */
1396         int             nfile,            /* Number of files specified on the cmdl. */
1397         int             presteps,         /* DLB equilibration steps, is checked    */
1398         gmx_int64_t     cpt_steps,        /* Time step counter in the checkpoint    */
1399         gmx_bool        bCheck,           /* Check whether benchmark mdrun works    */
1400         const char     *eligible_gpu_ids) /* GPU IDs for
1401                                            * constructing mdrun command lines */
1402 {
1403     int      i, nr, k, ret, count = 0, totaltests;
1404     int     *nPMEnodes = nullptr;
1405     t_perf  *pd        = nullptr;
1406     int      cmdline_length;
1407     char    *command, *cmd_stub;
1408     char     buf[STRLEN];
1409     gmx_bool bResetProblem = FALSE;
1410     gmx_bool bFirst        = TRUE;
1411
1412     /* This string array corresponds to the eParselog enum type at the start
1413      * of this file */
1414     const char* ParseLog[] = {
1415         "OK.",
1416         "Logfile not found!",
1417         "No timings, logfile truncated?",
1418         "Run was terminated.",
1419         "Counters were not reset properly.",
1420         "No DD grid found for these settings.",
1421         "TPX version conflict!",
1422         "mdrun was not started in parallel!",
1423         "Number of PP ranks has a prime factor that is too large.",
1424         "The number of PP ranks did not suit the number of GPUs.",
1425         "Some GPUs were not detected or are incompatible.",
1426         "An error occurred."
1427     };
1428     char        str_PME_f_load[13];
1429
1430
1431     /* Allocate space for the mdrun command line. 100 extra characters should
1432        be more than enough for the -npme etcetera arguments */
1433     cmdline_length =  std::strlen(cmd_mpirun)
1434         + std::strlen(cmd_np)
1435         + std::strlen(cmd_mdrun)
1436         + std::strlen(cmd_args_bench)
1437         + std::strlen(tpr_names[0]) + 100;
1438     snew(command, cmdline_length);
1439     snew(cmd_stub, cmdline_length);
1440
1441     /* Construct the part of the command line that stays the same for all tests: */
1442     if (bThreads)
1443     {
1444         sprintf(cmd_stub, "%s%s", cmd_mdrun, cmd_np);
1445     }
1446     else
1447     {
1448         sprintf(cmd_stub, "%s%s%s ", cmd_mpirun, cmd_np, cmd_mdrun);
1449     }
1450
1451     /* Create a list of numbers of PME nodes to test */
1452     if (npme_fixed < -1)
1453     {
1454         make_npme_list(npmevalues_opt, pmeentries, &nPMEnodes,
1455                        nnodes, minPMEnodes, maxPMEnodes);
1456     }
1457     else
1458     {
1459         *pmeentries  = 1;
1460         snew(nPMEnodes, 1);
1461         nPMEnodes[0] = npme_fixed;
1462         fprintf(stderr, "Will use a fixed number of %d PME-only ranks.\n", nPMEnodes[0]);
1463     }
1464
1465     if (0 == repeats)
1466     {
1467         fprintf(fp, "\nNo benchmarks done since number of repeats (-r) is 0.\n");
1468         gmx_ffclose(fp);
1469         finalize(opt2fn("-p", nfile, fnm));
1470         exit(0);
1471     }
1472
1473     /* Allocate one dataset for each tpr input file: */
1474     init_perfdata(perfdata, nr_tprs, *pmeentries, repeats);
1475
1476     /*****************************************/
1477     /* Main loop over all tpr files to test: */
1478     /*****************************************/
1479     totaltests = nr_tprs*(*pmeentries)*repeats;
1480     for (k = 0; k < nr_tprs; k++)
1481     {
1482         fprintf(fp, "\nIndividual timings for input file %d (%s):\n", k, tpr_names[k]);
1483         fprintf(fp, "PME ranks      Gcycles       ns/day        PME/f    Remark\n");
1484         /* Loop over various numbers of PME nodes: */
1485         for (i = 0; i < *pmeentries; i++)
1486         {
1487             pd = &perfdata[k][i];
1488
1489             auto cmd_gpu_ids = make_gpu_id_command_line(eligible_gpu_ids);
1490
1491             /* Loop over the repeats for each scenario: */
1492             for (nr = 0; nr < repeats; nr++)
1493             {
1494                 pd->nPMEnodes = nPMEnodes[i];
1495
1496                 /* Add -npme and -s to the command line and save it. Note that
1497                  * the -passall (if set) options requires cmd_args_bench to be
1498                  * at the end of the command line string */
1499                 snew(pd->mdrun_cmd_line, cmdline_length);
1500                 sprintf(pd->mdrun_cmd_line, "%s-npme %d -s %s %s %s",
1501                         cmd_stub, pd->nPMEnodes, tpr_names[k], cmd_args_bench, cmd_gpu_ids.c_str());
1502
1503                 /* To prevent that all benchmarks fail due to a show-stopper argument
1504                  * on the mdrun command line, we make a quick check first.
1505                  * This check can be turned off in cases where the automatically chosen
1506                  * number of PME-only ranks leads to a number of PP ranks for which no
1507                  * decomposition can be found (e.g. for large prime numbers) */
1508                 if (bFirst && bCheck)
1509                 {
1510                     /* TODO This check is really for a functional
1511                      * .tpr, and if we need it, it should take place
1512                      * for every .tpr, and the logic for it should be
1513                      * immediately inside the loop over k, not in
1514                      * this inner loop. */
1515                     char *temporary_cmd_line;
1516
1517                     snew(temporary_cmd_line, cmdline_length);
1518                     /* TODO -npme 0 is more likely to succeed at low
1519                        parallelism than the default of -npme -1, but
1520                        is more likely to fail at the scaling limit
1521                        when the PP domains may be too small. "mpirun
1522                        -np 1 mdrun" is probably a reasonable thing to
1523                        do for this check, but it'll be easier to
1524                        implement that after some refactoring of how
1525                        the number of MPI ranks is managed. */
1526                     sprintf(temporary_cmd_line, "%s-npme 0 -nb cpu -s %s %s",
1527                             cmd_stub, tpr_names[k], cmd_args_bench);
1528                     make_sure_it_runs(temporary_cmd_line, cmdline_length, fp, fnm, nfile);
1529                 }
1530                 bFirst = FALSE;
1531
1532                 /* Do a benchmark simulation: */
1533                 if (repeats > 1)
1534                 {
1535                     sprintf(buf, ", pass %d/%d", nr+1, repeats);
1536                 }
1537                 else
1538                 {
1539                     buf[0] = '\0';
1540                 }
1541                 fprintf(stdout, "\n=== Progress %2.0f%%, tpr %d/%d, run %d/%d%s:\n",
1542                         (100.0*count)/totaltests,
1543                         k+1, nr_tprs, i+1, *pmeentries, buf);
1544                 make_backup(opt2fn("-err", nfile, fnm));
1545                 sprintf(command, "%s 1> /dev/null 2>%s", pd->mdrun_cmd_line, opt2fn("-err", nfile, fnm));
1546                 fprintf(stdout, "%s\n", pd->mdrun_cmd_line);
1547                 gmx_system_call(command);
1548
1549                 /* Collect the performance data from the log file; also check stderr
1550                  * for fatal errors */
1551                 ret = parse_logfile(opt2fn("-bg", nfile, fnm), opt2fn("-err", nfile, fnm),
1552                                     pd, nr, presteps, cpt_steps, nnodes);
1553                 if ((presteps > 0) && (ret == eParselogResetProblem))
1554                 {
1555                     bResetProblem = TRUE;
1556                 }
1557
1558                 if (-1 == pd->nPMEnodes)
1559                 {
1560                     sprintf(buf, "(%3d)", pd->guessPME);
1561                 }
1562                 else
1563                 {
1564                     sprintf(buf, "     ");
1565                 }
1566
1567                 /* Nicer output */
1568                 if (pd->PME_f_load[nr] > 0.0)
1569                 {
1570                     sprintf(str_PME_f_load, "%12.3f", pd->PME_f_load[nr]);
1571                 }
1572                 else
1573                 {
1574                     sprintf(str_PME_f_load, "%s", "         -  ");
1575                 }
1576
1577                 /* Write the data we got to disk */
1578                 fprintf(fp, "%4d%s %12.3f %12.3f %s    %s", pd->nPMEnodes,
1579                         buf, pd->Gcycles[nr], pd->ns_per_day[nr], str_PME_f_load, ParseLog[ret]);
1580                 if (!(ret == eParselogOK || ret == eParselogNoDDGrid || ret == eParselogNotFound) )
1581                 {
1582                     fprintf(fp, " Check %s file for problems.", ret == eParselogFatal ? "err" : "log");
1583                 }
1584                 fprintf(fp, "\n");
1585                 fflush(fp);
1586                 count++;
1587
1588                 /* Do some cleaning up and delete the files we do not need any more */
1589                 cleanup(fnm, nfile, k, nnodes, pd->nPMEnodes, nr, ret == eParselogFatal);
1590
1591                 /* If the first run with this number of processors already failed, do not try again: */
1592                 if (pd->Gcycles[0] <= 0.0 && repeats > 1)
1593                 {
1594                     fprintf(stdout, "Skipping remaining passes of unsuccessful setting, see log file for details.\n");
1595                     count += repeats-(nr+1);
1596                     break;
1597                 }
1598             } /* end of repeats loop */
1599         }     /* end of -npme loop */
1600     }         /* end of tpr file loop */
1601
1602     if (bResetProblem)
1603     {
1604         sep_line(fp);
1605         fprintf(fp, "WARNING: The cycle and time step counters could not be reset properly. ");
1606         sep_line(fp);
1607     }
1608     sfree(command);
1609     sfree(cmd_stub);
1610 }
1611
1612
1613 static void check_input(
1614         int             nnodes,
1615         int             repeats,
1616         int            *ntprs,
1617         real           *rmin,
1618         real            rcoulomb,
1619         real           *rmax,
1620         real            maxPMEfraction,
1621         real            minPMEfraction,
1622         int             npme_fixed,
1623         gmx_int64_t     bench_nsteps,
1624         const t_filenm *fnm,
1625         int             nfile,
1626         int             sim_part,
1627         int             presteps,
1628         int             npargs,
1629         t_pargs        *pa)
1630 {
1631     int old;
1632
1633
1634     /* Make sure the input file exists */
1635     if (!gmx_fexist(opt2fn("-s", nfile, fnm)))
1636     {
1637         gmx_fatal(FARGS, "File %s not found.", opt2fn("-s", nfile, fnm));
1638     }
1639
1640     /* Make sure that the checkpoint file is not overwritten during benchmarking */
1641     if ( (0 == std::strcmp(opt2fn("-cpi", nfile, fnm), opt2fn("-bcpo", nfile, fnm)) ) && (sim_part > 1) )
1642     {
1643         gmx_fatal(FARGS, "Checkpoint input (-cpi) and benchmark checkpoint output (-bcpo) files must not be identical.\n"
1644                   "The checkpoint input file must not be overwritten during the benchmarks.\n");
1645     }
1646
1647     /* Make sure that repeats is >= 0 (if == 0, only write tpr files) */
1648     if (repeats < 0)
1649     {
1650         gmx_fatal(FARGS, "Number of repeats < 0!");
1651     }
1652
1653     /* Check number of nodes */
1654     if (nnodes < 1)
1655     {
1656         gmx_fatal(FARGS, "Number of ranks/threads must be a positive integer.");
1657     }
1658
1659     /* Automatically choose -ntpr if not set */
1660     if (*ntprs < 1)
1661     {
1662         if (nnodes < 16)
1663         {
1664             *ntprs = 1;
1665         }
1666         else
1667         {
1668             *ntprs = 3;
1669             /* Set a reasonable scaling factor for rcoulomb */
1670             if (*rmax <= 0)
1671             {
1672                 *rmax = rcoulomb * 1.2;
1673             }
1674         }
1675         fprintf(stderr, "Will test %d tpr file%s.\n", *ntprs, *ntprs == 1 ? "" : "s");
1676     }
1677     else
1678     {
1679         if (1 == *ntprs)
1680         {
1681             fprintf(stderr, "Note: Choose ntpr>1 to shift PME load between real and reciprocal space.\n");
1682         }
1683     }
1684
1685     /* Make shure that rmin <= rcoulomb <= rmax */
1686     if (*rmin <= 0)
1687     {
1688         *rmin = rcoulomb;
1689     }
1690     if (*rmax <= 0)
1691     {
1692         *rmax = rcoulomb;
1693     }
1694     if (!(*rmin <= *rmax) )
1695     {
1696         gmx_fatal(FARGS, "Please choose the Coulomb radii such that rmin <= rmax.\n"
1697                   "rmin = %g, rmax = %g, actual rcoul from .tpr file = %g\n", *rmin, *rmax, rcoulomb);
1698     }
1699     /* Add test scenarios if rmin or rmax were set */
1700     if (*ntprs <= 2)
1701     {
1702         if (!gmx_within_tol(*rmin, rcoulomb, GMX_REAL_EPS) && (*ntprs == 1) )
1703         {
1704             (*ntprs)++;
1705             fprintf(stderr, "NOTE: Setting -rmin to %g changed -ntpr to %d\n",
1706                     *rmin, *ntprs);
1707         }
1708         if (!gmx_within_tol(*rmax, rcoulomb, GMX_REAL_EPS) && (*ntprs == 1) )
1709         {
1710             (*ntprs)++;
1711             fprintf(stderr, "NOTE: Setting -rmax to %g changed -ntpr to %d\n",
1712                     *rmax, *ntprs);
1713         }
1714     }
1715     old = *ntprs;
1716     /* If one of rmin, rmax is set, we need 2 tpr files at minimum */
1717     if (!gmx_within_tol(*rmax, rcoulomb, GMX_REAL_EPS) || !gmx_within_tol(*rmin, rcoulomb, GMX_REAL_EPS) )
1718     {
1719         *ntprs = std::max(*ntprs, 2);
1720     }
1721
1722     /* If both rmin, rmax are set, we need 3 tpr files at minimum */
1723     if (!gmx_within_tol(*rmax, rcoulomb, GMX_REAL_EPS) && !gmx_within_tol(*rmin, rcoulomb, GMX_REAL_EPS) )
1724     {
1725         *ntprs = std::max(*ntprs, 3);
1726     }
1727
1728     if (old != *ntprs)
1729     {
1730         fprintf(stderr, "NOTE: Your rmin, rmax setting changed -ntpr to %d\n", *ntprs);
1731     }
1732
1733     if (*ntprs > 1)
1734     {
1735         if (gmx_within_tol(*rmin, rcoulomb, GMX_REAL_EPS) && gmx_within_tol(rcoulomb, *rmax, GMX_REAL_EPS)) /* We have just a single rc */
1736         {
1737             fprintf(stderr, "WARNING: Resetting -ntpr to 1 since no Coulomb radius scaling is requested.\n"
1738                     "Please set rmin < rmax to test Coulomb radii in the [rmin, rmax] interval\n"
1739                     "with correspondingly adjusted PME grid settings\n");
1740             *ntprs = 1;
1741         }
1742     }
1743
1744     /* Check whether max and min fraction are within required values */
1745     if (maxPMEfraction > 0.5 || maxPMEfraction < 0)
1746     {
1747         gmx_fatal(FARGS, "-max must be between 0 and 0.5");
1748     }
1749     if (minPMEfraction > 0.5 || minPMEfraction < 0)
1750     {
1751         gmx_fatal(FARGS, "-min must be between 0 and 0.5");
1752     }
1753     if (maxPMEfraction < minPMEfraction)
1754     {
1755         gmx_fatal(FARGS, "-max must be larger or equal to -min");
1756     }
1757
1758     /* Check whether the number of steps - if it was set - has a reasonable value */
1759     if (bench_nsteps < 0)
1760     {
1761         gmx_fatal(FARGS, "Number of steps must be positive.");
1762     }
1763
1764     if (bench_nsteps > 10000 || bench_nsteps < 100)
1765     {
1766         fprintf(stderr, "WARNING: steps=");
1767         fprintf(stderr, "%" GMX_PRId64, bench_nsteps);
1768         fprintf(stderr, ". Are you sure you want to perform so %s steps for each benchmark?\n", (bench_nsteps < 100) ? "few" : "many");
1769     }
1770
1771     if (presteps < 0)
1772     {
1773         gmx_fatal(FARGS, "Cannot have a negative number of presteps.\n");
1774     }
1775
1776     /* Check for rcoulomb scaling if more than one .tpr file is tested */
1777     if (*ntprs > 1)
1778     {
1779         if (*rmin/rcoulomb < 0.75 || *rmax/rcoulomb > 1.25)
1780         {
1781             fprintf(stderr, "WARNING: Applying extreme scaling factor. I hope you know what you are doing.\n");
1782         }
1783     }
1784
1785     /* If a fixed number of PME nodes is set we do rcoulomb and PME gird tuning
1786      * only. We need to check whether the requested number of PME-only nodes
1787      * makes sense. */
1788     if (npme_fixed > -1)
1789     {
1790         /* No more than 50% of all nodes can be assigned as PME-only nodes. */
1791         if (2*npme_fixed > nnodes)
1792         {
1793             gmx_fatal(FARGS, "Cannot have more than %d PME-only ranks for a total of %d ranks (you chose %d).\n",
1794                       nnodes/2, nnodes, npme_fixed);
1795         }
1796         if ((npme_fixed > 0) && (5*npme_fixed < nnodes))
1797         {
1798             fprintf(stderr, "WARNING: Only %g percent of the ranks are assigned as PME-only ranks.\n",
1799                     (100.0*npme_fixed)/nnodes);
1800         }
1801         if (opt2parg_bSet("-min", npargs, pa) || opt2parg_bSet("-max", npargs, pa))
1802         {
1803             fprintf(stderr, "NOTE: The -min, -max, and -npme options have no effect when a\n"
1804                     "      fixed number of PME-only ranks is requested with -fix.\n");
1805         }
1806     }
1807 }
1808
1809
1810 /* Returns TRUE when "opt" is needed at launch time */
1811 static gmx_bool is_launch_file(char *opt, gmx_bool bSet)
1812 {
1813     if (0 == std::strncmp(opt, "-swap", 5))
1814     {
1815         return bSet;
1816     }
1817
1818     /* Apart from the input .tpr and the output log files we need all options that
1819      * were set on the command line and that do not start with -b */
1820     if    (0 == std::strncmp(opt, "-b", 2) || 0 == std::strncmp(opt, "-s", 2)
1821            || 0 == std::strncmp(opt, "-err", 4) || 0 == std::strncmp(opt, "-p", 2) )
1822     {
1823         return FALSE;
1824     }
1825
1826     return bSet;
1827 }
1828
1829
1830 /* Returns TRUE when "opt" defines a file which is needed for the benchmarks runs */
1831 static gmx_bool is_bench_file(char *opt, gmx_bool bSet, gmx_bool bOptional, gmx_bool bIsOutput)
1832 {
1833     /* Apart from the input .tpr, all files starting with "-b" are for
1834      * _b_enchmark files exclusively */
1835     if (0 == std::strncmp(opt, "-s", 2))
1836     {
1837         return FALSE;
1838     }
1839
1840     if (0 == std::strncmp(opt, "-b", 2) || 0 == std::strncmp(opt, "-s", 2))
1841     {
1842         if (!bOptional || bSet)
1843         {
1844             return TRUE;
1845         }
1846         else
1847         {
1848             return FALSE;
1849         }
1850     }
1851     else
1852     {
1853         if (bIsOutput)
1854         {
1855             return FALSE;
1856         }
1857         else
1858         {
1859             if (bSet) /* These are additional input files like -cpi -ei */
1860             {
1861                 return TRUE;
1862             }
1863             else
1864             {
1865                 return FALSE;
1866             }
1867         }
1868     }
1869 }
1870
1871
1872 /* Adds 'buf' to 'str' */
1873 static void add_to_string(char **str, const char *buf)
1874 {
1875     int len;
1876
1877
1878     len = std::strlen(*str) + std::strlen(buf) + 1;
1879     srenew(*str, len);
1880     std::strcat(*str, buf);
1881 }
1882
1883
1884 /* Create the command line for the benchmark as well as for the real run */
1885 static void create_command_line_snippets(
1886         gmx_bool  bAppendFiles,
1887         gmx_bool  bKeepAndNumCPT,
1888         gmx_bool  bResetHWay,
1889         int       presteps,
1890         int       nfile,
1891         t_filenm  fnm[],
1892         char     *cmd_args_bench[],  /* command line arguments for benchmark runs */
1893         char     *cmd_args_launch[], /* command line arguments for simulation run */
1894         char      extra_args[],      /* Add this to the end of the command line */
1895         char     *deffnm)            /* Default file names, or NULL if not set */
1896 {
1897     int         i;
1898     char       *opt;
1899     const char *name;
1900     char        strbuf[STRLEN];
1901
1902
1903     /* strlen needs at least '\0' as a string: */
1904     snew(*cmd_args_bench, 1);
1905     snew(*cmd_args_launch, 1);
1906     *cmd_args_launch[0] = '\0';
1907     *cmd_args_bench[0]  = '\0';
1908
1909
1910     /*******************************************/
1911     /* 1. Process other command line arguments */
1912     /*******************************************/
1913     if (presteps > 0)
1914     {
1915         /* Add equilibration steps to benchmark options */
1916         sprintf(strbuf, "-resetstep %d ", presteps);
1917         add_to_string(cmd_args_bench, strbuf);
1918     }
1919     /* These switches take effect only at launch time */
1920     if (deffnm)
1921     {
1922         sprintf(strbuf, "-deffnm %s ", deffnm);
1923         add_to_string(cmd_args_launch, strbuf);
1924     }
1925     if (FALSE == bAppendFiles)
1926     {
1927         add_to_string(cmd_args_launch, "-noappend ");
1928     }
1929     if (bKeepAndNumCPT)
1930     {
1931         add_to_string(cmd_args_launch, "-cpnum ");
1932     }
1933     if (bResetHWay)
1934     {
1935         add_to_string(cmd_args_launch, "-resethway ");
1936     }
1937
1938     /********************/
1939     /* 2. Process files */
1940     /********************/
1941     for (i = 0; i < nfile; i++)
1942     {
1943         opt  = (char *)fnm[i].opt;
1944         name = opt2fn(opt, nfile, fnm);
1945
1946         /* Strbuf contains the options, now let's sort out where we need that */
1947         sprintf(strbuf, "%s %s ", opt, name);
1948
1949         if (is_bench_file(opt, opt2bSet(opt, nfile, fnm), is_optional(&fnm[i]), is_output(&fnm[i])) )
1950         {
1951             /* All options starting with -b* need the 'b' removed,
1952              * therefore overwrite strbuf */
1953             if (0 == std::strncmp(opt, "-b", 2))
1954             {
1955                 sprintf(strbuf, "-%s %s ", &opt[2], name);
1956             }
1957
1958             add_to_string(cmd_args_bench, strbuf);
1959         }
1960
1961         if (is_launch_file(opt, opt2bSet(opt, nfile, fnm)) )
1962         {
1963             add_to_string(cmd_args_launch, strbuf);
1964         }
1965     }
1966
1967     add_to_string(cmd_args_bench, extra_args);
1968     add_to_string(cmd_args_launch, extra_args);
1969 }
1970
1971
1972 /* Set option opt */
1973 static void setopt(const char *opt, int nfile, t_filenm fnm[])
1974 {
1975     int i;
1976
1977     for (i = 0; (i < nfile); i++)
1978     {
1979         if (std::strcmp(opt, fnm[i].opt) == 0)
1980         {
1981             fnm[i].flag |= ffSET;
1982         }
1983     }
1984 }
1985
1986
1987 /* This routine inspects the tpr file and ...
1988  * 1. checks for output files that get triggered by a tpr option. These output
1989  *    files are marked as 'set' to allow for a proper cleanup after each
1990  *    tuning run.
1991  * 2. returns the PME:PP load ratio
1992  * 3. returns rcoulomb from the tpr */
1993 static float inspect_tpr(int nfile, t_filenm fnm[], real *rcoulomb)
1994 {
1995     gmx_bool     bTpi;      /* Is test particle insertion requested?          */
1996     gmx_bool     bFree;     /* Is a free energy simulation requested?         */
1997     gmx_bool     bNM;       /* Is a normal mode analysis requested?           */
1998     gmx_bool     bSwap;     /* Is water/ion position swapping requested?      */
1999     t_state      state;
2000     gmx_mtop_t   mtop;
2001
2002
2003     /* Check tpr file for options that trigger extra output files */
2004     t_inputrec  irInstance;
2005     t_inputrec *ir = &irInstance;
2006     read_tpx_state(opt2fn("-s", nfile, fnm), ir, &state, &mtop);
2007     bFree = (efepNO  != ir->efep );
2008     bNM   = (eiNM    == ir->eI   );
2009     bSwap = (eswapNO != ir->eSwapCoords);
2010     bTpi  = EI_TPI(ir->eI);
2011
2012     /* Set these output files on the tuning command-line */
2013     if (ir->bPull)
2014     {
2015         setopt("-pf", nfile, fnm);
2016         setopt("-px", nfile, fnm);
2017     }
2018     if (bFree)
2019     {
2020         setopt("-dhdl", nfile, fnm);
2021     }
2022     if (bTpi)
2023     {
2024         setopt("-tpi", nfile, fnm);
2025         setopt("-tpid", nfile, fnm);
2026     }
2027     if (bNM)
2028     {
2029         setopt("-mtx", nfile, fnm);
2030     }
2031     if (bSwap)
2032     {
2033         setopt("-swap", nfile, fnm);
2034     }
2035
2036     *rcoulomb = ir->rcoulomb;
2037
2038     /* Return the estimate for the number of PME nodes */
2039     float npme = pme_load_estimate(&mtop, ir, state.box);
2040     return npme;
2041 }
2042
2043
2044 static void couple_files_options(int nfile, t_filenm fnm[])
2045 {
2046     int      i;
2047     gmx_bool bSet, bBench;
2048     char    *opt;
2049     char     buf[20];
2050
2051
2052     for (i = 0; i < nfile; i++)
2053     {
2054         opt    = (char *)fnm[i].opt;
2055         bSet   = ((fnm[i].flag & ffSET) != 0);
2056         bBench = (0 == std::strncmp(opt, "-b", 2));
2057
2058         /* Check optional files */
2059         /* If e.g. -eo is set, then -beo also needs to be set */
2060         if (is_optional(&fnm[i]) && bSet && !bBench)
2061         {
2062             sprintf(buf, "-b%s", &opt[1]);
2063             setopt(buf, nfile, fnm);
2064         }
2065         /* If -beo is set, then -eo also needs to be! */
2066         if (is_optional(&fnm[i]) && bSet && bBench)
2067         {
2068             sprintf(buf, "-%s", &opt[2]);
2069             setopt(buf, nfile, fnm);
2070         }
2071     }
2072 }
2073
2074
2075 #define BENCHSTEPS (1000)
2076
2077 int gmx_tune_pme(int argc, char *argv[])
2078 {
2079     const char     *desc[] = {
2080         "For a given number [TT]-np[tt] or [TT]-ntmpi[tt] of ranks, [THISMODULE] systematically",
2081         "times [gmx-mdrun] with various numbers of PME-only ranks and determines",
2082         "which setting is fastest. It will also test whether performance can",
2083         "be enhanced by shifting load from the reciprocal to the real space",
2084         "part of the Ewald sum. ",
2085         "Simply pass your [REF].tpr[ref] file to [THISMODULE] together with other options",
2086         "for [gmx-mdrun] as needed.[PAR]",
2087         "[THISMODULE] needs to call [gmx-mdrun] and so requires that you",
2088         "specify how to call mdrun with the argument to the [TT]-mdrun[tt]",
2089         "parameter. Depending how you have built GROMACS, values such as",
2090         "'gmx mdrun', 'gmx_d mdrun', or 'mdrun_mpi' might be needed.[PAR]",
2091         "The program that runs MPI programs can be set in the environment variable",
2092         "MPIRUN (defaults to 'mpirun'). Note that for certain MPI frameworks,",
2093         "you need to provide a machine- or hostfile. This can also be passed",
2094         "via the MPIRUN variable, e.g.[PAR]",
2095         "[TT]export MPIRUN=\"/usr/local/mpirun -machinefile hosts\"[tt]",
2096         "Note that in such cases it is normally necessary to compile",
2097         "and/or run [THISMODULE] without MPI support, so that it can call",
2098         "the MPIRUN program.[PAR]",
2099         "Before doing the actual benchmark runs, [THISMODULE] will do a quick",
2100         "check whether [gmx-mdrun] works as expected with the provided parallel settings",
2101         "if the [TT]-check[tt] option is activated (the default).",
2102         "Please call [THISMODULE] with the normal options you would pass to",
2103         "[gmx-mdrun] and add [TT]-np[tt] for the number of ranks to perform the",
2104         "tests on, or [TT]-ntmpi[tt] for the number of threads. You can also add [TT]-r[tt]",
2105         "to repeat each test several times to get better statistics. [PAR]",
2106         "[THISMODULE] can test various real space / reciprocal space workloads",
2107         "for you. With [TT]-ntpr[tt] you control how many extra [REF].tpr[ref] files will be",
2108         "written with enlarged cutoffs and smaller Fourier grids respectively.",
2109         "Typically, the first test (number 0) will be with the settings from the input",
2110         "[REF].tpr[ref] file; the last test (number [TT]ntpr[tt]) will have the Coulomb cutoff",
2111         "specified by [TT]-rmax[tt] with a somewhat smaller PME grid at the same time. ",
2112         "In this last test, the Fourier spacing is multiplied with [TT]rmax[tt]/rcoulomb. ",
2113         "The remaining [REF].tpr[ref] files will have equally-spaced Coulomb radii (and Fourier "
2114         "spacings) between these extremes. [BB]Note[bb] that you can set [TT]-ntpr[tt] to 1",
2115         "if you just seek the optimal number of PME-only ranks; in that case",
2116         "your input [REF].tpr[ref] file will remain unchanged.[PAR]",
2117         "For the benchmark runs, the default of 1000 time steps should suffice for most",
2118         "MD systems. The dynamic load balancing needs about 100 time steps",
2119         "to adapt to local load imbalances, therefore the time step counters",
2120         "are by default reset after 100 steps. For large systems (>1M atoms), as well as ",
2121         "for a higher accuracy of the measurements, you should set [TT]-resetstep[tt] to a higher value.",
2122         "From the 'DD' load imbalance entries in the md.log output file you",
2123         "can tell after how many steps the load is sufficiently balanced. Example call:[PAR]"
2124         "[TT]gmx tune_pme -np 64 -s protein.tpr -launch[tt][PAR]",
2125         "After calling [gmx-mdrun] several times, detailed performance information",
2126         "is available in the output file [TT]perf.out[tt].",
2127         "[BB]Note[bb] that during the benchmarks, a couple of temporary files are written",
2128         "(options [TT]-b*[tt]), these will be automatically deleted after each test.[PAR]",
2129         "If you want the simulation to be started automatically with the",
2130         "optimized parameters, use the command line option [TT]-launch[tt].[PAR]",
2131         "Basic support for GPU-enabled [TT]mdrun[tt] exists. Give a string containing the IDs",
2132         "of the GPUs that you wish to use in the optimization in the [TT]-gpu_id[tt]",
2133         "command-line argument. This works exactly like [TT]mdrun -gpu_id[tt], does not imply a mapping,",
2134         "and merely declares the eligible set of GPU devices. [TT]gmx-tune_pme[tt] will construct calls to",
2135         "mdrun that use this set appropriately. [TT]gmx-tune_pme[tt] does not support",
2136         "[TT]-gputasks[tt].[PAR]",
2137     };
2138
2139     int             nnodes         = 1;
2140     int             repeats        = 2;
2141     int             pmeentries     = 0; /* How many values for -npme do we actually test for each tpr file */
2142     real            maxPMEfraction = 0.50;
2143     real            minPMEfraction = 0.25;
2144     int             maxPMEnodes, minPMEnodes;
2145     float           guessPMEratio;                    /* guessed PME:PP ratio based on the tpr file */
2146     float           guessPMEnodes;
2147     int             npme_fixed     = -2;              /* If >= -1, use only this number
2148                                                        * of PME-only nodes                */
2149     int             ntprs          = 0;
2150     real            rmin           = 0.0, rmax = 0.0; /* min and max value for rcoulomb if scaling is requested */
2151     real            rcoulomb       = -1.0;            /* Coulomb radius as set in .tpr file */
2152     gmx_bool        bScaleRvdw     = TRUE;
2153     gmx_int64_t     bench_nsteps   = BENCHSTEPS;
2154     gmx_int64_t     new_sim_nsteps = -1;   /* -1 indicates: not set by the user */
2155     gmx_int64_t     cpt_steps      = 0;    /* Step counter in .cpt input file   */
2156     int             presteps       = 1500; /* Do a full cycle reset after presteps steps */
2157     gmx_bool        bOverwrite     = FALSE, bKeepTPR;
2158     gmx_bool        bLaunch        = FALSE;
2159     char           *ExtraArgs      = nullptr;
2160     char          **tpr_names      = nullptr;
2161     const char     *simulation_tpr = nullptr;
2162     char           *deffnm         = nullptr;
2163     int             best_npme, best_tpr;
2164     int             sim_part = 1; /* For benchmarks with checkpoint files */
2165     char            bbuf[STRLEN];
2166
2167
2168     /* Default program names if nothing else is found */
2169     char               *cmd_mpirun = nullptr, *cmd_mdrun = nullptr;
2170     char               *cmd_args_bench, *cmd_args_launch;
2171     char               *cmd_np           = nullptr;
2172
2173     /* IDs of GPUs that are eligible for computation */
2174     char               *eligible_gpu_ids = nullptr;
2175
2176     t_perf            **perfdata = nullptr;
2177     t_inputinfo        *info;
2178     int                 i;
2179     FILE               *fp;
2180
2181     /* Print out how long the tuning took */
2182     double          seconds;
2183
2184     static t_filenm fnm[] = {
2185         /* tune_pme */
2186         { efOUT, "-p",      "perf",     ffWRITE },
2187         { efLOG, "-err",    "bencherr", ffWRITE },
2188         { efTPR, "-so",     "tuned",    ffWRITE },
2189         /* mdrun: */
2190         { efTPR, nullptr,      nullptr,       ffREAD },
2191         { efTRN, "-o",      nullptr,       ffWRITE },
2192         { efCOMPRESSED, "-x", nullptr,     ffOPTWR },
2193         { efCPT, "-cpi",    nullptr,       ffOPTRD },
2194         { efCPT, "-cpo",    nullptr,       ffOPTWR },
2195         { efSTO, "-c",      "confout",  ffWRITE },
2196         { efEDR, "-e",      "ener",     ffWRITE },
2197         { efLOG, "-g",      "md",       ffWRITE },
2198         { efXVG, "-dhdl",   "dhdl",     ffOPTWR },
2199         { efXVG, "-field",  "field",    ffOPTWR },
2200         { efXVG, "-table",  "table",    ffOPTRD },
2201         { efXVG, "-tablep", "tablep",   ffOPTRD },
2202         { efXVG, "-tableb", "table",    ffOPTRD },
2203         { efTRX, "-rerun",  "rerun",    ffOPTRD },
2204         { efXVG, "-tpi",    "tpi",      ffOPTWR },
2205         { efXVG, "-tpid",   "tpidist",  ffOPTWR },
2206         { efEDI, "-ei",     "sam",      ffOPTRD },
2207         { efXVG, "-eo",     "edsam",    ffOPTWR },
2208         { efXVG, "-devout", "deviatie", ffOPTWR },
2209         { efXVG, "-runav",  "runaver",  ffOPTWR },
2210         { efXVG, "-px",     "pullx",    ffOPTWR },
2211         { efXVG, "-pf",     "pullf",    ffOPTWR },
2212         { efXVG, "-ro",     "rotation", ffOPTWR },
2213         { efLOG, "-ra",     "rotangles", ffOPTWR },
2214         { efLOG, "-rs",     "rotslabs", ffOPTWR },
2215         { efLOG, "-rt",     "rottorque", ffOPTWR },
2216         { efMTX, "-mtx",    "nm",       ffOPTWR },
2217         { efXVG, "-swap",   "swapions", ffOPTWR },
2218         /* Output files that are deleted after each benchmark run */
2219         { efTRN, "-bo",     "bench",    ffWRITE },
2220         { efXTC, "-bx",     "bench",    ffWRITE },
2221         { efCPT, "-bcpo",   "bench",    ffWRITE },
2222         { efSTO, "-bc",     "bench",    ffWRITE },
2223         { efEDR, "-be",     "bench",    ffWRITE },
2224         { efLOG, "-bg",     "bench",    ffWRITE },
2225         { efXVG, "-beo",    "benchedo", ffOPTWR },
2226         { efXVG, "-bdhdl",  "benchdhdl", ffOPTWR },
2227         { efXVG, "-bfield", "benchfld", ffOPTWR },
2228         { efXVG, "-btpi",   "benchtpi", ffOPTWR },
2229         { efXVG, "-btpid",  "benchtpid", ffOPTWR },
2230         { efXVG, "-bdevout", "benchdev", ffOPTWR },
2231         { efXVG, "-brunav", "benchrnav", ffOPTWR },
2232         { efXVG, "-bpx",    "benchpx",  ffOPTWR },
2233         { efXVG, "-bpf",    "benchpf",  ffOPTWR },
2234         { efXVG, "-bro",    "benchrot", ffOPTWR },
2235         { efLOG, "-bra",    "benchrota", ffOPTWR },
2236         { efLOG, "-brs",    "benchrots", ffOPTWR },
2237         { efLOG, "-brt",    "benchrott", ffOPTWR },
2238         { efMTX, "-bmtx",   "benchn",   ffOPTWR },
2239         { efNDX, "-bdn",    "bench",    ffOPTWR },
2240         { efXVG, "-bswap",  "benchswp", ffOPTWR }
2241     };
2242
2243     gmx_bool        bThreads     = FALSE;
2244
2245     int             nthreads = 1;
2246
2247     const char     *procstring[] =
2248     { nullptr, "np", "n", "none", nullptr };
2249     const char     *npmevalues_opt[] =
2250     { nullptr, "auto", "all", "subset", nullptr };
2251
2252     gmx_bool          bAppendFiles          = TRUE;
2253     gmx_bool          bKeepAndNumCPT        = FALSE;
2254     gmx_bool          bResetCountersHalfWay = FALSE;
2255     gmx_bool          bBenchmark            = TRUE;
2256     gmx_bool          bCheck                = TRUE;
2257
2258     gmx_output_env_t *oenv = nullptr;
2259
2260     t_pargs           pa[] = {
2261         /***********************/
2262         /* tune_pme options: */
2263         /***********************/
2264         { "-mdrun",    FALSE, etSTR,  {&cmd_mdrun},
2265           "Command line to run a simulation, e.g. 'gmx mdrun' or 'mdrun_mpi'" },
2266         { "-np",       FALSE, etINT,  {&nnodes},
2267           "Number of ranks to run the tests on (must be > 2 for separate PME ranks)" },
2268         { "-npstring", FALSE, etENUM, {procstring},
2269           "Name of the [TT]$MPIRUN[tt] option that specifies the number of ranks to use ('np', or 'n'; use 'none' if there is no such option)" },
2270         { "-ntmpi",    FALSE, etINT,  {&nthreads},
2271           "Number of MPI-threads to run the tests on (turns MPI & mpirun off)"},
2272         { "-r",        FALSE, etINT,  {&repeats},
2273           "Repeat each test this often" },
2274         { "-max",      FALSE, etREAL, {&maxPMEfraction},
2275           "Max fraction of PME ranks to test with" },
2276         { "-min",      FALSE, etREAL, {&minPMEfraction},
2277           "Min fraction of PME ranks to test with" },
2278         { "-npme",     FALSE, etENUM, {npmevalues_opt},
2279           "Within -min and -max, benchmark all possible values for [TT]-npme[tt], or just a reasonable subset. "
2280           "Auto neglects -min and -max and chooses reasonable values around a guess for npme derived from the .tpr"},
2281         { "-fix",      FALSE, etINT,  {&npme_fixed},
2282           "If >= -1, do not vary the number of PME-only ranks, instead use this fixed value and only vary rcoulomb and the PME grid spacing."},
2283         { "-rmax",     FALSE, etREAL, {&rmax},
2284           "If >0, maximal rcoulomb for -ntpr>1 (rcoulomb upscaling results in fourier grid downscaling)" },
2285         { "-rmin",     FALSE, etREAL, {&rmin},
2286           "If >0, minimal rcoulomb for -ntpr>1" },
2287         { "-scalevdw",  FALSE, etBOOL, {&bScaleRvdw},
2288           "Scale rvdw along with rcoulomb"},
2289         { "-ntpr",     FALSE, etINT,  {&ntprs},
2290           "Number of [REF].tpr[ref] files to benchmark. Create this many files with different rcoulomb scaling factors depending on -rmin and -rmax. "
2291           "If < 1, automatically choose the number of [REF].tpr[ref] files to test" },
2292         { "-steps",    FALSE, etINT64, {&bench_nsteps},
2293           "Take timings for this many steps in the benchmark runs" },
2294         { "-resetstep", FALSE, etINT,  {&presteps},
2295           "Let dlb equilibrate this many steps before timings are taken (reset cycle counters after this many steps)" },
2296         { "-nsteps",   FALSE, etINT64, {&new_sim_nsteps},
2297           "If non-negative, perform this many steps in the real run (overwrites nsteps from [REF].tpr[ref], add [REF].cpt[ref] steps)" },
2298         { "-launch",   FALSE, etBOOL, {&bLaunch},
2299           "Launch the real simulation after optimization" },
2300         { "-bench",    FALSE, etBOOL, {&bBenchmark},
2301           "Run the benchmarks or just create the input [REF].tpr[ref] files?" },
2302         { "-check",    FALSE, etBOOL, {&bCheck},
2303           "Before the benchmark runs, check whether mdrun works in parallel" },
2304         { "-gpu_id",   FALSE, etSTR,  {&eligible_gpu_ids},
2305           "List of unique GPU device IDs that are eligible for use" },
2306         /******************/
2307         /* mdrun options: */
2308         /******************/
2309         /* We let tune_pme parse and understand these options, because we need to
2310          * prevent that they appear on the mdrun command line for the benchmarks */
2311         { "-append",   FALSE, etBOOL, {&bAppendFiles},
2312           "Append to previous output files when continuing from checkpoint instead of adding the simulation part number to all file names (for launch only)" },
2313         { "-cpnum",    FALSE, etBOOL, {&bKeepAndNumCPT},
2314           "Keep and number checkpoint files (launch only)" },
2315         { "-deffnm",   FALSE, etSTR,  {&deffnm},
2316           "Set the default filenames (launch only)" },
2317         { "-resethway", FALSE, etBOOL, {&bResetCountersHalfWay},
2318           "HIDDENReset the cycle counters after half the number of steps or halfway [TT]-maxh[tt] (launch only)" }
2319     };
2320
2321 #define NFILE asize(fnm)
2322
2323     seconds = gmx_gettime();
2324
2325     if (!parse_common_args(&argc, argv, PCA_NOEXIT_ON_ARGS,
2326                            NFILE, fnm, asize(pa), pa, asize(desc), desc,
2327                            0, nullptr, &oenv))
2328     {
2329         return 0;
2330     }
2331
2332     // procstring[0] is used inside two different conditionals further down
2333     GMX_RELEASE_ASSERT(procstring[0] != nullptr, "Options inconsistency; procstring[0] is NULL");
2334
2335     /* Store the remaining unparsed command line entries in a string which
2336      * is then attached to the mdrun command line */
2337     snew(ExtraArgs, 1);
2338     ExtraArgs[0] = '\0';
2339     for (i = 1; i < argc; i++) /* argc will now be 1 if everything was understood */
2340     {
2341         add_to_string(&ExtraArgs, argv[i]);
2342         add_to_string(&ExtraArgs, " ");
2343     }
2344
2345     if (opt2parg_bSet("-ntmpi", asize(pa), pa))
2346     {
2347         bThreads = TRUE;
2348         if (opt2parg_bSet("-npstring", asize(pa), pa))
2349         {
2350             fprintf(stderr, "WARNING: -npstring has no effect when using threads.\n");
2351         }
2352
2353         if (nnodes > 1)
2354         {
2355             gmx_fatal(FARGS, "Can't run multi-threaded MPI simulation yet!");
2356         }
2357         /* and now we just set this; a bit of an ugly hack*/
2358         nnodes = nthreads;
2359     }
2360     /* Check for PME:PP ratio and whether tpr triggers additional output files */
2361     guessPMEratio = inspect_tpr(NFILE, fnm, &rcoulomb);
2362
2363     /* Automatically set -beo options if -eo is set etc. */
2364     couple_files_options(NFILE, fnm);
2365
2366     /* Construct the command line arguments for benchmark runs
2367      * as well as for the simulation run */
2368     if (bThreads)
2369     {
2370         sprintf(bbuf, " -ntmpi %d ", nthreads);
2371     }
2372     else
2373     {
2374         /* This string will be used for MPI runs and will appear after the
2375          * mpirun command. */
2376         if (std::strcmp(procstring[0], "none") != 0)
2377         {
2378             sprintf(bbuf, " -%s %d ", procstring[0], nnodes);
2379         }
2380         else
2381         {
2382             sprintf(bbuf, " ");
2383         }
2384     }
2385
2386     cmd_np = bbuf;
2387
2388     create_command_line_snippets(bAppendFiles, bKeepAndNumCPT, bResetCountersHalfWay, presteps,
2389                                  NFILE, fnm, &cmd_args_bench, &cmd_args_launch, ExtraArgs, deffnm);
2390
2391     /* Prepare to use checkpoint file if requested */
2392     sim_part = 1;
2393     if (opt2bSet("-cpi", NFILE, fnm))
2394     {
2395         const char *filename = opt2fn("-cpi", NFILE, fnm);
2396         int         cpt_sim_part;
2397         read_checkpoint_part_and_step(filename,
2398                                       &cpt_sim_part, &cpt_steps);
2399         if (cpt_sim_part == 0)
2400         {
2401             gmx_fatal(FARGS, "Checkpoint file %s could not be read!", filename);
2402         }
2403         /* tune_pme will run the next part of the simulation */
2404         sim_part = cpt_sim_part + 1;
2405     }
2406
2407     /* Open performance output file and write header info */
2408     fp = gmx_ffopen(opt2fn("-p", NFILE, fnm), "w");
2409
2410     /* Make a quick consistency check of command line parameters */
2411     check_input(nnodes, repeats, &ntprs, &rmin, rcoulomb, &rmax,
2412                 maxPMEfraction, minPMEfraction, npme_fixed,
2413                 bench_nsteps, fnm, NFILE, sim_part, presteps,
2414                 asize(pa), pa);
2415
2416     /* Determine the maximum and minimum number of PME nodes to test,
2417      * the actual list of settings is build in do_the_tests(). */
2418     if ((nnodes > 2) && (npme_fixed < -1))
2419     {
2420         if (0 == std::strcmp(npmevalues_opt[0], "auto"))
2421         {
2422             /* Determine the npme range automatically based on the PME:PP load guess */
2423             if (guessPMEratio > 1.0)
2424             {
2425                 /* More PME than PP work, probably we do not need separate PME nodes at all! */
2426                 maxPMEnodes = nnodes/2;
2427                 minPMEnodes = nnodes/2;
2428             }
2429             else
2430             {
2431                 /* PME : PP load is in the range 0..1, let's test around the guess */
2432                 guessPMEnodes = static_cast<int>(nnodes/(1.0 + 1.0/guessPMEratio));
2433                 minPMEnodes   = static_cast<int>(std::floor(0.7*guessPMEnodes));
2434                 maxPMEnodes   = static_cast<int>(std::ceil(1.6*guessPMEnodes));
2435                 maxPMEnodes   = std::min(maxPMEnodes, nnodes/2);
2436             }
2437         }
2438         else
2439         {
2440             /* Determine the npme range based on user input */
2441             maxPMEnodes = static_cast<int>(std::floor(maxPMEfraction*nnodes));
2442             minPMEnodes = std::max(static_cast<int>(std::floor(minPMEfraction*nnodes)), 0);
2443             fprintf(stdout, "Will try runs with %d ", minPMEnodes);
2444             if (maxPMEnodes != minPMEnodes)
2445             {
2446                 fprintf(stdout, "- %d ", maxPMEnodes);
2447             }
2448             fprintf(stdout, "PME-only ranks.\n  Note that the automatic number of PME-only ranks and no separate PME ranks are always tested.\n");
2449         }
2450     }
2451     else
2452     {
2453         maxPMEnodes = 0;
2454         minPMEnodes = 0;
2455     }
2456
2457     /* Get the commands we need to set up the runs from environment variables */
2458     get_program_paths(bThreads, &cmd_mpirun, &cmd_mdrun);
2459     if (bBenchmark && repeats > 0)
2460     {
2461         check_mdrun_works(bThreads, cmd_mpirun, cmd_np, cmd_mdrun, nullptr != eligible_gpu_ids);
2462     }
2463
2464     /* Print some header info to file */
2465     sep_line(fp);
2466     fprintf(fp, "\n      P E R F O R M A N C E   R E S U L T S\n");
2467     sep_line(fp);
2468     fprintf(fp, "%s for GROMACS %s\n", output_env_get_program_display_name(oenv),
2469             gmx_version());
2470     if (!bThreads)
2471     {
2472         fprintf(fp, "Number of ranks         : %d\n", nnodes);
2473         fprintf(fp, "The mpirun command is   : %s\n", cmd_mpirun);
2474         if (std::strcmp(procstring[0], "none") != 0)
2475         {
2476             fprintf(fp, "Passing # of ranks via  : -%s\n", procstring[0]);
2477         }
2478         else
2479         {
2480             fprintf(fp, "Not setting number of ranks in system call\n");
2481         }
2482     }
2483     else
2484     {
2485         fprintf(fp, "Number of threads       : %d\n", nnodes);
2486     }
2487
2488     fprintf(fp, "The mdrun  command is   : %s\n", cmd_mdrun);
2489     fprintf(fp, "mdrun args benchmarks   : %s\n", cmd_args_bench);
2490     fprintf(fp, "Benchmark steps         : ");
2491     fprintf(fp, "%" GMX_PRId64, bench_nsteps);
2492     fprintf(fp, "\n");
2493     fprintf(fp, "dlb equilibration steps : %d\n", presteps);
2494     if (sim_part > 1)
2495     {
2496         fprintf(fp, "Checkpoint time step    : ");
2497         fprintf(fp, "%" GMX_PRId64, cpt_steps);
2498         fprintf(fp, "\n");
2499     }
2500     fprintf(fp, "mdrun args at launchtime: %s\n", cmd_args_launch);
2501
2502     if (new_sim_nsteps >= 0)
2503     {
2504         bOverwrite = TRUE;
2505         fprintf(stderr, "Note: Simulation input file %s will have ", opt2fn("-so", NFILE, fnm));
2506         fprintf(stderr, "%" GMX_PRId64, new_sim_nsteps+cpt_steps);
2507         fprintf(stderr, " steps.\n");
2508         fprintf(fp, "Simulation steps        : ");
2509         fprintf(fp, "%" GMX_PRId64, new_sim_nsteps);
2510         fprintf(fp, "\n");
2511     }
2512     if (repeats > 1)
2513     {
2514         fprintf(fp, "Repeats for each test   : %d\n", repeats);
2515     }
2516
2517     if (npme_fixed >= -1)
2518     {
2519         fprintf(fp, "Fixing -npme at         : %d\n", npme_fixed);
2520     }
2521
2522     fprintf(fp, "Input file              : %s\n", opt2fn("-s", NFILE, fnm));
2523     fprintf(fp, "   PME/PP load estimate : %g\n", guessPMEratio);
2524
2525     /* Allocate memory for the inputinfo struct: */
2526     snew(info, 1);
2527     info->nr_inputfiles = ntprs;
2528     for (i = 0; i < ntprs; i++)
2529     {
2530         snew(info->rcoulomb, ntprs);
2531         snew(info->rvdw, ntprs);
2532         snew(info->rlist, ntprs);
2533         snew(info->nkx, ntprs);
2534         snew(info->nky, ntprs);
2535         snew(info->nkz, ntprs);
2536         snew(info->fsx, ntprs);
2537         snew(info->fsy, ntprs);
2538         snew(info->fsz, ntprs);
2539     }
2540     /* Make alternative tpr files to test: */
2541     snew(tpr_names, ntprs);
2542     for (i = 0; i < ntprs; i++)
2543     {
2544         snew(tpr_names[i], STRLEN);
2545     }
2546
2547     /* It can be that ntprs is reduced by make_benchmark_tprs if not enough
2548      * different grids could be found. */
2549     make_benchmark_tprs(opt2fn("-s", NFILE, fnm), tpr_names, bench_nsteps+presteps,
2550                         cpt_steps, rmin, rmax, bScaleRvdw, &ntprs, info, fp);
2551
2552     /********************************************************************************/
2553     /* Main loop over all scenarios we need to test: tpr files, PME nodes, repeats  */
2554     /********************************************************************************/
2555     snew(perfdata, ntprs);
2556     if (bBenchmark)
2557     {
2558         GMX_RELEASE_ASSERT(npmevalues_opt[0] != nullptr, "Options inconsistency; npmevalues_opt[0] is NULL");
2559         do_the_tests(fp, tpr_names, maxPMEnodes, minPMEnodes, npme_fixed, npmevalues_opt[0], perfdata, &pmeentries,
2560                      repeats, nnodes, ntprs, bThreads, cmd_mpirun, cmd_np, cmd_mdrun,
2561                      cmd_args_bench, fnm, NFILE, presteps, cpt_steps, bCheck, eligible_gpu_ids);
2562
2563         fprintf(fp, "\nTuning took%8.1f minutes.\n", (gmx_gettime()-seconds)/60.0);
2564
2565         /* Analyse the results and give a suggestion for optimal settings: */
2566         bKeepTPR = analyze_data(fp, opt2fn("-p", NFILE, fnm), perfdata, nnodes, ntprs, pmeentries,
2567                                 repeats, info, &best_tpr, &best_npme);
2568
2569         /* Take the best-performing tpr file and enlarge nsteps to original value */
2570         if (bKeepTPR && !bOverwrite)
2571         {
2572             simulation_tpr = opt2fn("-s", NFILE, fnm);
2573         }
2574         else
2575         {
2576             simulation_tpr = opt2fn("-so", NFILE, fnm);
2577             modify_PMEsettings(bOverwrite ? (new_sim_nsteps+cpt_steps) : info->orig_sim_steps,
2578                                info->orig_init_step, tpr_names[best_tpr], simulation_tpr);
2579         }
2580
2581         /* Let's get rid of the temporary benchmark input files */
2582         for (i = 0; i < ntprs; i++)
2583         {
2584             fprintf(stdout, "Deleting temporary benchmark input file %s\n", tpr_names[i]);
2585             remove(tpr_names[i]);
2586         }
2587
2588         /* Now start the real simulation if the user requested it ... */
2589         launch_simulation(bLaunch, fp, bThreads, cmd_mpirun, cmd_np, cmd_mdrun,
2590                           cmd_args_launch, simulation_tpr, best_npme, eligible_gpu_ids);
2591     }
2592     gmx_ffclose(fp);
2593
2594     /* ... or simply print the performance results to screen: */
2595     if (!bLaunch)
2596     {
2597         finalize(opt2fn("-p", NFILE, fnm));
2598     }
2599
2600     return 0;
2601 }