clang-tidy: misc-suspicious-missing-comma
authorRoland Schulz <roland.schulz@intel.com>
Tue, 26 Jun 2018 07:21:08 +0000 (00:21 -0700)
committerMark Abraham <mark.j.abraham@gmail.com>
Fri, 29 Jun 2018 14:35:19 +0000 (16:35 +0200)
Fixes bug in src/gromacs/fileio/checkpoint.cpp
Manual changes (check has to auto-fix)

Change-Id: I0d9d26c115a240133e680c4cb3433780a3b398e3

19 files changed:
src/gromacs/CMakeLists.txt
src/gromacs/fileio/checkpoint.cpp
src/gromacs/gmxana/gmx_analyze.cpp
src/gromacs/gmxana/gmx_current.cpp
src/gromacs/gmxana/gmx_dos.cpp
src/gromacs/gmxana/gmx_dyecoupl.cpp
src/gromacs/gmxana/gmx_energy.cpp
src/gromacs/gmxana/gmx_hbond.cpp
src/gromacs/gmxana/gmx_hydorder.cpp
src/gromacs/gmxana/gmx_order.cpp
src/gromacs/gmxana/gmx_pme_error.cpp
src/gromacs/gmxana/gmx_rms.cpp
src/gromacs/gmxana/gmx_sans.cpp
src/gromacs/gmxana/gmx_tune_pme.cpp
src/gromacs/gmxana/gmx_velacc.cpp
src/gromacs/gmxana/gmx_wham.cpp
src/gromacs/gmxpreprocess/grompp.cpp
src/gromacs/selection/sm_insolidangle.cpp
src/gromacs/tools/check.cpp

index 188309aa70fa9f747a07379ea3f3057ac9d6ec9c..0a52fe7558390da9f7ac3644264f0f766857ac90 100644 (file)
@@ -283,7 +283,6 @@ if (GMX_CLANG_TIDY)
        -misc-misplaced-widening-cast,-readability-named-parameter,\
        -misc-suspicious-string-compare,\
        -performance-unnecessary-value-param,\
-       -misc-suspicious-missing-comma,\
        -misc-misplaced-const,\
        -misc-incorrect-roundings,-misc-macro-parentheses,-readability-function-size,-readability-else-after-return,\
        -readability-inconsistent-declaration-parameter-name,-misc-throw-by-value-catch-by-reference,\
index 80d3e4762eb61bb83671c90318df93ac52308ff7..8bf2c5e8dd6f9514afe0521cc16055b424e3a8ff 100644 (file)
@@ -112,7 +112,7 @@ const char *est_names[estNR] =
     "x", "v", "sdx-unsupported", "CGp", "LD-rng-unsupported", "LD-rng-i-unsupported",
     "disre_initf", "disre_rm3tav",
     "orire_initf", "orire_Dtav",
-    "svir_prev", "nosehoover-vxi", "v_eta", "vol0", "nhpres_xi", "nhpres_vxi", "fvir_prev", "fep_state", "MC-rng-unsupported", "MC-rng-i-unsupported"
+    "svir_prev", "nosehoover-vxi", "v_eta", "vol0", "nhpres_xi", "nhpres_vxi", "fvir_prev", "fep_state", "MC-rng-unsupported", "MC-rng-i-unsupported",
     "barostat-integral"
 };
 
index 7aef695bfba5884c616fd3f2c4f195af00988261..4cb6ecf364b03947d1d21d55267765166e263c5e 100644 (file)
@@ -1020,7 +1020,7 @@ int gmx_analyze(int argc, char *argv[])
 
         "Option [TT]-power[tt] fits the data to [MATH]b t^a[math], which is accomplished",
         "by fitting to [MATH]a t + b[math] on log-log scale. All points after the first",
-        "zero or with a negative value are ignored.[PAR]"
+        "zero or with a negative value are ignored.[PAR]",
 
         "Option [TT]-luzar[tt] performs a Luzar & Chandler kinetics analysis",
         "on output from [gmx-hbond]. The input file can be taken directly",
index 44be7f8111472468c8bbdd9d4f9e325273bfa10e..3c80befdc366ab5f572f2cff00cbdcd7c8900b9d 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2008,2009,2010,2011,2012,2013,2014,2015,2017, by the GROMACS development team, led by
+ * Copyright (c) 2008,2009,2010,2011,2012,2013,2014,2015,2017,2018, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
@@ -848,7 +848,7 @@ int gmx_current(int argc, char *argv[])
         "dielectric constant. To obtain a reasonable result, the index group has to be neutral.",
         "Furthermore, the routine is capable of extracting the static conductivity from the current ",
         "autocorrelation function, if velocities are given. Additionally, an Einstein-Helfand fit ",
-        "can be used to obtain the static conductivity."
+        "can be used to obtain the static conductivity.",
         "[PAR]",
         "The flag [TT]-caf[tt] is for the output of the current autocorrelation function and [TT]-mc[tt] writes the",
         "correlation of the rotational and translational part of the dipole moment in the corresponding",
index aaeae917be2bc67b2e1aac18bd9d784072fc6c57..abd09992d7380d86012dcea4757107eb89def341 100644 (file)
@@ -255,7 +255,7 @@ int gmx_dos(int argc, char *argv[])
         "in the trajecotry with sufficiently high frequency such as to cover",
         "all vibrations. For flexible systems that would be around a few fs",
         "between saving. Properties based on the DoS are printed on the",
-        "standard output."
+        "standard output.",
         "Note that the density of states is calculated from the mass-weighted",
         "autocorrelation, and by default only from the square of the real",
         "component rather than absolute value. This means the shape can differ",
index e9c28c71946f384d9c8b8de612bdfac2471d8567..09f12d6843be23102eb2f0fab03402aae3922038 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2012,2013,2014,2015,2017, by the GROMACS development team, led by
+ * Copyright (c) 2012,2013,2014,2015,2017,2018, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
@@ -66,7 +66,7 @@ int gmx_dyecoupl(int argc, char *argv[])
         "in the index file. The distance R is calculated on the basis of",
         "the COMs of the given atom pairs.",
         "The [TT]-pbcdist[tt] option calculates distances to the nearest periodic",
-        "image instead to the distance in the box. This works however only,"
+        "image instead to the distance in the box. This works however only,",
         "for periodic boundaries in all 3 dimensions.",
         "The [TT]-norm[tt] option (area-) normalizes the histograms."
     };
index 7b529e6403f7014a80bbc6b1da1ce99de9e0bc15..3ae3480feb838007d55f5cf466fbe7b915ba0f6b 100644 (file)
@@ -1619,7 +1619,7 @@ int gmx_energy(int argc, char *argv[])
         "",
         "You always need to set the number of molecules [TT]-nmol[tt].",
         "The C[SUB]p[sub]/C[SUB]v[sub] computations do [BB]not[bb] include any corrections",
-        "for quantum effects. Use the [gmx-dos] program if you need that (and you do).[PAR]"
+        "for quantum effects. Use the [gmx-dos] program if you need that (and you do).[PAR]",
 
         "Option [TT]-odh[tt] extracts and plots the free energy data",
         "(Hamiltoian differences and/or the Hamiltonian derivative dhdl)",
index 72f795a11ac95700ffa5e3ae4d189c935b9c2ddb..87b31fbdaea67c4c389200ede0bde58d58552d17 100644 (file)
@@ -2387,7 +2387,7 @@ int gmx_hbond(int argc, char *argv[])
         "n(t) can be defined as either all pairs that are not within contact distance r at time t",
         "(corresponding to leaving the -r2 option at the default value 0) or all pairs that",
         "are within distance r2 (corresponding to setting a second cut-off value with option -r2).",
-        "See mentioned literature for more details and definitions."
+        "See mentioned literature for more details and definitions.",
         "[PAR]",
 
         /*    "It is also possible to analyse specific hydrogen bonds with",
index bb461db399dc4f429cc1387a8ea4133f00ea4d31..e5554dbafc96b1eeb6c8d6dd44bf178f6ab54664 100644 (file)
@@ -563,7 +563,7 @@ int gmx_hydorder(int argc, char *argv[])
         "[THISMODULE] computes the tetrahedrality order parameters around a ",
         "given atom. Both angle an distance order parameters are calculated. See",
         "P.-L. Chau and A.J. Hardwick, Mol. Phys., 93, (1998), 511-518.",
-        "for more details.[PAR]"
+        "for more details.[PAR]",
         "[THISMODULE] calculates the order parameter in a 3d-mesh in the box, and",
         "with 2 phases in the box gives the user the option to define a 2D interface in time",
         "separating the faces by specifying parameters [TT]-sgang1[tt] and",
index 674046c64ea69a5a14a21aa7c925593e07e961f3..3316f3e0f8c9666e01cb8f0b16262f64203d2433 100644 (file)
@@ -3,7 +3,7 @@
  *
  * Copyright (c) 1991-2000, University of Groningen, The Netherlands.
  * Copyright (c) 2001-2004, The GROMACS development team.
- * Copyright (c) 2013,2014,2015,2016,2017, by the GROMACS development team, led by
+ * Copyright (c) 2013,2014,2015,2016,2017,2018, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
@@ -906,7 +906,7 @@ int gmx_order(int argc, char *argv[])
         "order tensor component (specified by the [TT]-d[tt] option) is given and the",
         "order parameter per slice is calculated as well. If [TT]-szonly[tt] is not",
         "selected, all diagonal elements and the deuterium order parameter is",
-        "given.[PAR]"
+        "given.[PAR]",
         "The tetrahedrality order parameters can be determined",
         "around an atom. Both angle an distance order parameters are calculated. See",
         "P.-L. Chau and A.J. Hardwick, Mol. Phys., 93, (1998), 511-518.",
index 255508ced2718b3e035ee6c1b404260d5974be51..9a50a498ca64e4ff3e7e21d0fda1526d29288117 100644 (file)
@@ -1077,7 +1077,7 @@ int gmx_pme_error(int argc, char *argv[])
         "if using the sPME algorithm. The flag [TT]-tune[tt] will determine",
         "the splitting parameter such that the error is equally",
         "distributed over the real and reciprocal space part.",
-        "The part of the error that stems from self interaction of the particles "
+        "The part of the error that stems from self interaction of the particles ",
         "is computationally demanding. However, a good a approximation is to",
         "just use a fraction of the particles for this term which can be",
         "indicated by the flag [TT]-self[tt].[PAR]",
index f28f331ce20be400b3c5b6ea782e5065f115133d..487df83eb4fef6b2f4082f4519794ab9ada6d614 100644 (file)
@@ -105,7 +105,7 @@ int gmx_rms(int argc, char *argv[])
         "deviation (RMSD), the size-independent [GRK]rho[grk] similarity parameter",
         "([TT]rho[tt]) or the scaled [GRK]rho[grk] ([TT]rhosc[tt]), ",
         "see Maiorov & Crippen, Proteins [BB]22[bb], 273 (1995).",
-        "This is selected by [TT]-what[tt].[PAR]"
+        "This is selected by [TT]-what[tt].[PAR]",
 
         "Each structure from a trajectory ([TT]-f[tt]) is compared to a",
         "reference structure. The reference structure",
index 7f48db6afddf3e69625a8259834f3135e6b8c649..b08c5dc36f2b3fbb622cb520d484412dfeb146ce 100644 (file)
@@ -65,7 +65,7 @@ int gmx_sans(int argc, char *argv[])
         "[THISMODULE] computes SANS spectra using Debye formula.",
         "It currently uses topology file (since it need to assigne element for each atom).",
         "[PAR]",
-        "Parameters:[PAR]"
+        "Parameters:[PAR]",
         "[TT]-pr[tt] Computes normalized g(r) function averaged over trajectory[PAR]",
         "[TT]-prframe[tt] Computes normalized g(r) function for each frame[PAR]",
         "[TT]-sq[tt] Computes SANS intensity curve averaged over trajectory[PAR]",
index 8a63789489a8ce9eb78646d65d35d4257641ad93..9947077818c4fe4f292ead1eb9180198d8f9bb10 100644 (file)
@@ -2108,7 +2108,7 @@ int gmx_tune_pme(int argc, char *argv[])
         "[REF].tpr[ref] file; the last test (number [TT]ntpr[tt]) will have the Coulomb cutoff",
         "specified by [TT]-rmax[tt] with a somewhat smaller PME grid at the same time. ",
         "In this last test, the Fourier spacing is multiplied with [TT]rmax[tt]/rcoulomb. ",
-        "The remaining [REF].tpr[ref] files will have equally-spaced Coulomb radii (and Fourier "
+        "The remaining [REF].tpr[ref] files will have equally-spaced Coulomb radii (and Fourier ",
         "spacings) between these extremes. [BB]Note[bb] that you can set [TT]-ntpr[tt] to 1",
         "if you just seek the optimal number of PME-only ranks; in that case",
         "your input [REF].tpr[ref] file will remain unchanged.[PAR]",
@@ -2118,7 +2118,7 @@ int gmx_tune_pme(int argc, char *argv[])
         "are by default reset after 100 steps. For large systems (>1M atoms), as well as ",
         "for a higher accuracy of the measurements, you should set [TT]-resetstep[tt] to a higher value.",
         "From the 'DD' load imbalance entries in the md.log output file you",
-        "can tell after how many steps the load is sufficiently balanced. Example call:[PAR]"
+        "can tell after how many steps the load is sufficiently balanced. Example call:[PAR]",
         "[TT]gmx tune_pme -np 64 -s protein.tpr -launch[tt][PAR]",
         "After calling [gmx-mdrun] several times, detailed performance information",
         "is available in the output file [TT]perf.out[tt].",
index a13e358a98d5253b6fdaa1c90bc8bb355c6231ca..5cbd55bb47c9c24e9a1dd0c43c7051f616ecf007 100644 (file)
@@ -3,7 +3,7 @@
  *
  * Copyright (c) 1991-2000, University of Groningen, The Netherlands.
  * Copyright (c) 2001-2004, The GROMACS development team.
- * Copyright (c) 2013,2014,2015,2016,2017, by the GROMACS development team, led by
+ * Copyright (c) 2013,2014,2015,2016,2017,2018, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
@@ -187,7 +187,7 @@ int gmx_velacc(int argc, char *argv[])
         "of molecule numbers instead of atom numbers.[PAR]",
         "By using option [TT]-os[tt] you can also extract the estimated",
         "(vibrational) power spectrum, which is the Fourier transform of the",
-        "velocity autocorrelation function."
+        "velocity autocorrelation function.",
         "Be sure that your trajectory contains frames with velocity information",
         "(i.e. [TT]nstvout[tt] was set in your original [REF].mdp[ref] file),",
         "and that the time interval between data collection points is",
index 334995fe7d1dc9f1b6be9007ff33527dc7297da2..fda99b596a74ed74f207429485543f8c4e012750 100644 (file)
@@ -3,7 +3,7 @@
  *
  * Copyright (c) 1991-2000, University of Groningen, The Netherlands.
  * Copyright (c) 2001-2004, The GROMACS development team.
- * Copyright (c) 2013,2014,2015,2016,2017, by the GROMACS development team, led by
+ * Copyright (c) 2013,2014,2015,2016,2017,2018, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
@@ -3255,7 +3255,7 @@ int gmx_wham(int argc, char *argv[])
         "  From the pull force the position in the umbrella potential is",
         "  computed. This does not work with tabulated umbrella potentials.",
         "* With option [TT]-ip[tt], the user provides file names of (gzipped) [REF].pdo[ref] files, i.e.",
-        "  the GROMACS 3.3 umbrella output files. If you have some unusual"
+        "  the GROMACS 3.3 umbrella output files. If you have some unusual",
         "  reaction coordinate you may also generate your own [REF].pdo[ref] files and",
         "  feed them with the [TT]-ip[tt] option into to [THISMODULE]. The [REF].pdo[ref] file header",
         "  must be similar to the following::",
index 619efe5466dcc0688ad331656592f1da8f10a7d7..3307448b1b978626873a67cdbebd42a273f8c0ef 100644 (file)
@@ -1664,7 +1664,7 @@ int gmx_grompp(int argc, char *argv[])
         "interactions can be kept by turning off [TT]-rmvsbds[tt]. Additionally,",
         "all constraints for distances which will be constant anyway because",
         "of virtual site constructions will be removed. If any constraints remain",
-        "which involve virtual sites, a fatal error will result.[PAR]"
+        "which involve virtual sites, a fatal error will result.[PAR]",
 
         "To verify your run input file, please take note of all warnings",
         "on the screen, and correct where necessary. Do also look at the contents",
@@ -1674,7 +1674,7 @@ int gmx_grompp(int argc, char *argv[])
         "in a file called [TT]grompp.log[tt] (along with real debug info). You",
         "can see the contents of the run input file with the [gmx-dump]",
         "program. [gmx-check] can be used to compare the contents of two",
-        "run input files.[PAR]"
+        "run input files.[PAR]",
 
         "The [TT]-maxwarn[tt] option can be used to override warnings printed",
         "by [THISMODULE] that otherwise halt output. In some cases, warnings are",
index 933cc0ce928dc7a32ca0d251fedf482f5687bba5..3801b8dd2361f0d9eee1f026a6f5256a53693cb9 100644 (file)
@@ -342,7 +342,7 @@ static const char *const help_insolidangle[] = {
     "(default=5) of any position in [TT]POS_EXPR[tt] as seen from [TT]POS[tt]",
     "a position expression that evaluates to a single position), i.e., atoms",
     "in the solid angle spanned by the positions in [TT]POS_EXPR[tt] and",
-    "centered at [TT]POS[tt].[PAR]"
+    "centered at [TT]POS[tt].[PAR]",
 
     "Technically, the solid angle is constructed as a union of small cones",
     "whose tip is at [TT]POS[tt] and the axis goes through a point in",
index f6a7063756719adff1702ef2337b9e28b23877ee..8bb686a9946c3cd88a51387bb886308a6e189345 100644 (file)
@@ -836,7 +836,7 @@ int gmx_check(int argc, char *argv[])
         "run input files this way, the default relative tolerance is reduced",
         "to 0.000001 and the absolute tolerance set to zero to find any differences",
         "not due to minor compiler optimization differences, although you can",
-        "of course still set any other tolerances through the options."
+        "of course still set any other tolerances through the options.",
         "Similarly a pair of trajectory files can be compared (using the [TT]-f2[tt]",
         "option), or a pair of energy files (using the [TT]-e2[tt] option).[PAR]",
         "For free energy simulations the A and B state topology from one",