Random cosmetic fixes
authorAndrey Alekseenko <al42and@gmail.com>
Tue, 17 Aug 2021 05:26:56 +0000 (05:26 +0000)
committerMark Abraham <mark.j.abraham@gmail.com>
Tue, 17 Aug 2021 05:26:56 +0000 (05:26 +0000)
22 files changed:
admin/iwyu.sh
api/legacy/include/gromacs/fileio/tpxio.h
docs/dev-manual/build-system.rst
docs/user-guide/mdp-options.rst
src/external/clFFT/src/library/plan.cpp
src/external/vmd_molfile/molfile_plugin.h
src/gromacs/ewald/pme_gpu_calculate_splines.cuh
src/gromacs/gmxpreprocess/hackblock.h
src/gromacs/hardware/device_information.h
src/gromacs/listed_forces/listed_internal.h
src/gromacs/mdlib/sim_util.cpp
src/gromacs/mdrun/legacymdrunoptions.cpp
src/gromacs/mdrun/runner.cpp
src/gromacs/mdtypes/forcebuffers.h
src/gromacs/mdtypes/simulation_workload.h
src/gromacs/mdtypes/state_propagator_data_gpu_impl.h
src/gromacs/nbnxm/kernel_file_generator/make_verlet_simd_kernel_files.py
src/gromacs/tables/forcetable.cpp
src/gromacs/taskassignment/decidegpuusage.cpp
src/gromacs/utility/futil.cpp
src/gromacs/utility/stringutil.h
src/gromacs/utility/template_mp.h

index 3d2fce665388388f69e722afb1ff22e2358e2931..2962c562edf9dce52da1165d23e776270d82647e 100755 (executable)
@@ -2,7 +2,7 @@
 #
 # This file is part of the GROMACS molecular simulation package.
 #
-# Copyright (c) 2014, by the GROMACS development team, led by
+# Copyright (c) 2014,2021, 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.
@@ -73,7 +73,7 @@ if [ "$filename" == "" ]; then
     exit 1
 fi
 
-# We cannot detect wether it is a C++ or C header. Should be fine to always use C++
+# We cannot detect whether it is a C++ or C header. Should be fine to always use C++
 if [ "${filename##*.}" == "h" ]; then
     cmd="$cmd -x c++"
 fi
index 96ff4f6ca532bcdf004ee6b85583b3cd3c34ccce..d58aaef91e7a7688ca7f07b76b264287b2cd9637 100644 (file)
@@ -124,7 +124,7 @@ struct PartialDeserializedTprFile
 /*
  * These routines handle reading and writing of preprocessed
  * topology files in any of the following formats:
- * TPR : topology in XDR format, portable accross platforms
+ * TPR : topology in XDR format, portable across platforms
  *
  * Files are written in the precision with which the source are compiled,
  * but double and single precision can be read by either.
index 9c848a342e15db96b9cf368e469685478dcaaa3c..7ad0ba958d83380bddf6e2249d29f03eceec7ff2 100644 (file)
@@ -336,7 +336,7 @@ Variables affecting the ``all`` target
   Any ``CMAKE_BUILD_TYPE`` which enables asserts (e.g. ASAN) works. Such a configured build will
   run both the compiler as well as clang-tidy when building. The name of the clang-tidy executable is set with
   ``-DCLANG_TIDY=...``, and the full path to it can be set with ``-DCLANG_TIDY_EXE=...``.
-  To apply the automatic fixes to the issue identified clang-tidy should be run seperately (running clang-tidy
+  To apply the automatic fixes to the issue identified clang-tidy should be run separately (running clang-tidy
   with ``-fix-errors`` as part of the build can corrupt header files). To fix a specific file run
   ``clang-tidy -fix-errors -header-filter '.*' {file}``, to fix all files in parallel
   ``run-clang-tidy.py -fix -header-filter '.*' '(?<!/selection/parser\.cpp|selection/scanner\.cpp)$'``,
index 667576a73d0575387c849c0e80df5256ffd73b75..beb3f2972be11326ce9ba294853b9a92556aa9fc 100644 (file)
@@ -849,10 +849,10 @@ Tables
 
    Currently unsupported.
    When user tables are used for electrostatics and/or VdW, here one
-   can give pairs of energy groups for which seperate user tables
+   can give pairs of energy groups for which separate user tables
    should be used. The two energy groups will be appended to the table
    file name, in order of their definition in :mdp:`energygrps`,
-   seperated by underscores. For example, if ``energygrps = Na Cl
+   separated by underscores. For example, if ``energygrps = Na Cl
    Sol`` and ``energygrp-table = Na Na Na Cl``, :ref:`gmx mdrun` will
    read ``table_Na_Na.xvg`` and ``table_Na_Cl.xvg`` in addition to the
    normal ``table.xvg`` which will be used for all other energy group
index 99cf97acb0e82f69abe00e8f9d55fd2fbba0ca3f..2b3990af86e1378dad20bae288ea99200c13f966 100644 (file)
@@ -2286,7 +2286,7 @@ clfftStatus       clfftBakePlan( clfftPlanHandle plHandle, cl_uint numQueues, cl_comma
                                                clLengths[1] = fftPlan->length[1];
 
                                                //NON_SQUARE_KERNEL_ORDER currKernelOrder;
-                                               // controling the transpose and swap kernel order
+                                               // controlling the transpose and swap kernel order
                                                // if leading dim is larger than the other dim it makes sense to swap and transpose
                                                if (clLengths[0] > clLengths[1])
                                                {
index 1a251c377838f741de6e778d1e84ddb2638fd522..c81f391798bc749f60556fd3f7e5ae1469e91792 100644 (file)
@@ -343,7 +343,7 @@ typedef struct {
   int memory;            /**< amount of memory used in Mbyte. XXX:? */ 
   int runtype;           /**< flag indicating the calculation method. */
   int scftype;           /**< SCF type: RHF, UHF, ROHF, GVB or MCSCF wfn. */
-  int status;            /**< indicates wether SCF and geometry optimization
+  int status;            /**< indicates whether SCF and geometry optimization
                           *   have converged properly. */
   int num_electrons;     /**< number of electrons.    XXX: can be fractional in some DFT codes */
   int totalcharge;       /**< total charge of system. XXX: can be fractional in some DFT codes */
index 6c85fff0ff581dd0409e652fea9f18ef333fed60..6e663175e0eefd05b04bed49d7616b6fecbd97f8 100644 (file)
@@ -173,7 +173,7 @@ __device__ __forceinline__ void pme_gpu_stage_atom_data(T* __restrict__ sm_desti
  * \tparam[in] atomsPerBlock        Number of atoms processed by a block - should be accounted for
  *                                  in the sizes of the shared memory arrays.
  * \tparam[in] atomsPerWarp         Number of atoms processed by a warp
- * \tparam[in] writeSmDtheta        Bool controling if the theta derivative should be written to shared memory. Enables calculation of dtheta if set.
+ * \tparam[in] writeSmDtheta        Bool controlling if the theta derivative should be written to shared memory. Enables calculation of dtheta if set.
  * \tparam[in] writeGlobal          A boolean which tells if the theta values and gridlines should be written to global memory. Enables calculation of dtheta if set.
  * \param[in]  kernelParams         Input PME CUDA data in constant memory.
  * \param[in]  atomIndexOffset      Starting atom index for the execution block w.r.t. global memory.
index 8e5e9c272295773664c698106aace6aee5d6b0c9..4469056a99f947a420efb7e5fc83ac1ec1706712 100644 (file)
@@ -177,7 +177,7 @@ struct MoleculePatch
     std::vector<t_atom> atom;
     //! Chargegroup number.
     int cgnr = NOTSET;
-    //! Type of attachement.
+    //! Type of attachment.
     int tp = 0;
     //! Number of control atoms.
     int nctl = 0;
index d23279e436a3f3aec5924829b664943913e4104d..079be8be458e6f312d9a85f8a0600b40e9afc087 100644 (file)
@@ -80,7 +80,7 @@ enum class DeviceStatus : int
     IncompatibleClusterSize = 3,
     //! There are known issues with OpenCL on NVIDIA Volta and newer.
     IncompatibleNvidiaVolta = 4,
-    /* \brief The device originates from non-recommended SYCL backend.
+    /*! \brief The device originates from non-recommended SYCL backend.
      * The device might work by itself, but to simplify device allocation, it is marked as incompatible.
      * */
     NotPreferredBackend = 5,
index 9366efcce139683271ec59368361f56457f8a39c..0689ba12634fd96b2299339b48170a5119eb5fcc 100644 (file)
@@ -145,7 +145,7 @@ struct bonded_threading_t
     int numAtomsForce = 0;
 
     /* There are two different ways to distribute the bonded force calculation
-     * over the threads. We dedice which to use based on the number of threads.
+     * over the threads. We decide which to use based on the number of threads.
      */
     //! Maximum thread count for uniform distribution of bondeds over threads
     int max_nthread_uniform = 0;
index 6bce5123f09a496716154e729d01831c6adf9bd8..8c4c86a52d750ca609fff405f8aed5f552daa5c8 100644 (file)
@@ -1093,7 +1093,7 @@ static void reduceAndUpdateMuTot(DipoleData*                   dipoleData,
     }
 }
 
-/*! \brief Combines MTS level0 and level1 force buffes into a full and MTS-combined force buffer.
+/*! \brief Combines MTS level0 and level1 force buffers into a full and MTS-combined force buffer.
  *
  * \param[in]     numAtoms        The number of atoms to combine forces for
  * \param[in,out] forceMtsLevel0  Input: F_level0, output: F_level0 + F_level1
index c78f448792c1d8c54a66069444947cce51035f7f..478339c61ec9a25a341e945159c07d1abca4b8c3 100644 (file)
@@ -110,7 +110,7 @@ int LegacyMdrunOptions::updateFromCommandLine(int argc, char** argv, ArrayRef<co
         // TODO Argument parsing can't handle std::string. We should
         // fix that by changing the parsing, once more of the roles of
         // handling, validating and implementing defaults for user
-        // command-line options have been seperated.
+        // command-line options have been separated.
         hw_opt.devicesSelectedByUser = devicesSelectedByUser;
         hw_opt.userGpuTaskAssignment = userGpuTaskAssignment;
 
index f7d2bc24f16abee6947b2c24e2f1d31135970515..ec71586d46c8f53936fceaf9d0d5b35a32d836f1 100644 (file)
@@ -1391,7 +1391,7 @@ int Mdrunner::mdrunner()
     }
 
     // The GPU update is decided here because we need to know whether the constraints or
-    // SETTLEs can span accross the domain borders (i.e. whether or not update groups are
+    // SETTLEs can span across the domain borders (i.e. whether or not update groups are
     // defined). This is only known after DD is initialized, hence decision on using GPU
     // update is done so late.
     try
index caacedbc31169ee04c48e715cb7471c2295b1230..86d52d57ac3213af825072918dda1024baf7167c 100644 (file)
@@ -129,7 +129,7 @@ private:
     // while clang requires it to avoid -Wunused
 #pragma GCC diagnostic push
 #pragma GCC diagnostic ignored "-Wattributes"
-    //! Wether we use forceMtsCombined_
+    //! Whether we use forceMtsCombined_
     gmx_used_in_debug bool useForceMtsCombined_;
 #pragma GCC diagnostic pop
 };
@@ -192,7 +192,7 @@ private:
     PaddedHostVector<RVec> forceMtsCombined_;
     //! The view to the force buffer
     ForceBuffersView view_;
-    //! Wether we use forceMtsCombined_
+    //! Whether we use forceMtsCombined_
     bool useForceMtsCombined_;
 };
 
index 66efe112ac6d00f72da0ad5e72bf54a14dbae9a4..0d7ffe82255d5cf03a7187a92ce9adaf7999a73b 100644 (file)
@@ -160,7 +160,7 @@ class SimulationWorkload
 public:
     //! Whether to compute nonbonded pair interactions
     bool computeNonbonded = false;
-    //! Wether nonbonded pair forces are to be computed at slow MTS steps only
+    //! Whether nonbonded pair forces are to be computed at slow MTS steps only
     bool computeNonbondedAtMtsLevel1 = false;
     //! Whether total dipole needs to be computed
     bool computeMuTot = false;
index ca319810ccfa4ec88cead2072298056d939a334c..026eff554cf9bb8444bad907e1b67ed41eb0ebc9 100644 (file)
@@ -318,7 +318,7 @@ private:
     const DeviceStream* localStream_;
     //! GPU NBNXM non-local stream.
     const DeviceStream* nonLocalStream_;
-    //! GPU Update-constreaints stream.
+    //! GPU Update-constraints stream.
     const DeviceStream* updateStream_;
 
     // Streams to use for coordinates H2D and D2H copies (one event for each atom locality)
index 85fcc5d964fe4f17f5e974bec1551508e7c1ce4c..383001f3c37b6a7342dc228e9739fb8d34cf9a46 100755 (executable)
@@ -3,7 +3,7 @@
 # This file is part of the GROMACS molecular simulation package.
 #
 # Copyright (c) 2013,2014,2015,2017,2018 by the GROMACS development team.
-# Copyright (c) 2019,2020, by the GROMACS development team, led by
+# Copyright (c) 2019,2020,2021, 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.
@@ -47,7 +47,7 @@
 #
 #   Many C kernel files, each defining a single kernel function. These
 #   functions can take a noticeable time to compile, and should tend
-#   to be in seperate files to take advantage of make-time
+#   to be in separate files to take advantage of make-time
 #   parallelism.
 #
 # This script should be run from the directory in which it is
index d8ad10e2cc5d85854f1402b013453d46b814a211..8099078baf5159fc546a211c55765c10f09c6c5d 100644 (file)
@@ -153,7 +153,7 @@ EwaldCorrectionTables generateEwaldCorrectionTables(const int    numPoints,
     double   x_r0;
 
     /* This function is called using either v_ewald_lr or v_lj_ewald_lr as a function argument
-     * depending on wether we should create electrostatic or Lennard-Jones Ewald tables.
+     * depending on whether we should create electrostatic or Lennard-Jones Ewald tables.
      */
 
     if (numPoints < 2)
index 25bf5f9bc142c3f63767bd076d9a0df4b38fbe68..36c4650f0649311fe23d213ec27e7a66f737e389 100644 (file)
@@ -527,7 +527,7 @@ bool decideWhetherToUseGpusForBonded(bool              useGpuForNonbonded,
     // is busy, for which we currently only check PME or Ewald.
     // (It would be better to dynamically assign bondeds based on timings)
     // Note that here we assume that the auto setting of PME ranks will not
-    // choose seperate PME ranks when nonBonded are assigned to the GPU.
+    // choose separate PME ranks when nonBonded are assigned to the GPU.
     bool usingOurCpuForPmeOrEwald =
             (EVDW_PME(inputrec.vdwtype)
              || (EEL_PME_EWALD(inputrec.coulombtype) && !useGpuForPme && numPmeRanksPerSimulation <= 0));
index befd2d34bb701eb16e807e374e7863781fbae28b..d1ae16a6962434d8600b352ae284ac9a2e189897 100644 (file)
@@ -342,7 +342,7 @@ gmx_bool gmx_fexist(const std::string& fname)
     FILE* test = fopen(fname.c_str(), "r");
     if (test == nullptr)
     {
-/*Windows doesn't allow fopen of directory - so we need to check this seperately */
+/*Windows doesn't allow fopen of directory - so we need to check this separately */
 #if GMX_NATIVE_WINDOWS
         DWORD attr = GetFileAttributes(fname.c_str());
         return (attr != INVALID_FILE_ATTRIBUTES) && (attr & FILE_ATTRIBUTE_DIRECTORY);
index 5bc06b842b01cda77e9f866749898883f7d15561..a1da4501d8058ffc6a772dcaf3dc6209a94c717f 100644 (file)
@@ -2,7 +2,7 @@
  * This file is part of the GROMACS molecular simulation package.
  *
  * Copyright (c) 2011-2018, The GROMACS development team.
- * Copyright (c) 2019, by the GROMACS development team, led by
+ * Copyright (c) 2019,2021, 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.
@@ -394,7 +394,7 @@ std::vector<std::string> splitAndTrimDelimitedString(const std::string& str, cha
  * \p input, each match of \p from is replaced with \p to, and the search for
  * the next match begins after the end of the previous match.
  *
- * Compexity is O(N), where N is length of output.
+ * Complexity is O(N), where N is length of output.
  *
  * \see replaceAllWords()
  */
index 8eda416476c0036c64ef82424dae389045591600..acd3744f022d5acd94e452e4eed5ba60c88b5dac 100644 (file)
@@ -60,7 +60,8 @@ auto dispatchTemplatedFunction(Function&& f)
     return std::forward<Function>(f)();
 }
 
-/** \internal \brief Helper function to select appropriate template based on runtime values.
+/*! \internal \brief
+ * Helper function to select appropriate template based on runtime values.
  *
  * Can use enums or booleans for template parameters.
  * These enums must have a member \c Count indicating the total number of valid values.