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