clang-tidy: google tests applicable
authorRoland Schulz <roland.schulz@intel.com>
Thu, 2 Aug 2018 02:48:12 +0000 (19:48 -0700)
committerRoland Schulz <roland.schulz@intel.com>
Sat, 18 Aug 2018 05:30:23 +0000 (22:30 -0700)
Change-Id: I32e5dd6226348a162750d272c20c49e116bb94a4

162 files changed:
docs/dev-manual/formatting.rst
src/.clang-tidy
src/gromacs/awh/biaswriter.cpp
src/gromacs/awh/tests/bias.cpp
src/gromacs/awh/tests/biasstate.cpp
src/gromacs/awh/tests/grid.cpp
src/gromacs/commandline/cmdlinehelpmodule.cpp
src/gromacs/compat/make_unique.h
src/gromacs/correlationfunctions/tests/autocorr.cpp
src/gromacs/correlationfunctions/tests/expfit.cpp
src/gromacs/correlationfunctions/tests/manyautocorrelation.cpp
src/gromacs/essentialdynamics/edsam.cpp
src/gromacs/ewald/tests/pmebsplinetest.cpp
src/gromacs/ewald/tests/pmegathertest.cpp
src/gromacs/ewald/tests/pmesolvetest.cpp
src/gromacs/ewald/tests/pmesplinespreadtest.cpp
src/gromacs/ewald/tests/pmetestcommon.cpp
src/gromacs/ewald/tests/pmetestcommon.h
src/gromacs/ewald/tests/testhardwarecontexts.cpp
src/gromacs/ewald/tests/testhardwarecontexts.h
src/gromacs/fileio/tests/readinp.cpp
src/gromacs/gmxpreprocess/tests/pdb2gmx.cpp
src/gromacs/gmxpreprocess/tests/readir.cpp
src/gromacs/gpu_utils/clfftinitializer.cpp
src/gromacs/gpu_utils/clfftinitializer.h
src/gromacs/gpu_utils/tests/gputest.cpp
src/gromacs/gpu_utils/tests/gputest.h
src/gromacs/gpu_utils/tests/hostallocator.cpp
src/gromacs/hardware/cpuinfo.cpp
src/gromacs/hardware/hardwaretopology.cpp
src/gromacs/hardware/hardwaretopology.h
src/gromacs/hardware/identifyavx512fmaunits.cpp
src/gromacs/listed-forces/tests/bonded.cpp
src/gromacs/math/invertmatrix.cpp
src/gromacs/math/paddedvector.h
src/gromacs/mdlib/boxdeformation.cpp
src/gromacs/mdlib/boxdeformation.h
src/gromacs/mdlib/constr.cpp
src/gromacs/mdlib/constr.h
src/gromacs/mdlib/constraintrange.cpp
src/gromacs/mdlib/lincs.cpp
src/gromacs/mdlib/lincs.h
src/gromacs/mdlib/makeconstraints.h
src/gromacs/mdlib/mdatoms.cpp
src/gromacs/mdlib/mdatoms.h
src/gromacs/mdlib/settle.cpp
src/gromacs/mdlib/settle.h
src/gromacs/mdlib/shake.cpp
src/gromacs/mdlib/shake.h
src/gromacs/mdlib/simulationsignal.cpp
src/gromacs/mdlib/simulationsignal.h
src/gromacs/mdlib/tests/calc_verletbuf.cpp
src/gromacs/mdlib/tests/mdebin.cpp
src/gromacs/mdlib/tests/settle.cpp
src/gromacs/mdlib/tests/shake.cpp
src/gromacs/mdlib/tests/simulationsignal.cpp
src/gromacs/mdlib/update.h
src/gromacs/mdrun/integrator.cpp
src/gromacs/mdrun/runner.cpp
src/gromacs/mdtypes/forceoutput.h
src/gromacs/onlinehelp/rstparser.h
src/gromacs/options/behaviorcollection.h
src/gromacs/options/ioptionsbehavior.h
src/gromacs/options/ioptionscontainer.h
src/gromacs/options/ioptionscontainerwithsections.h
src/gromacs/options/optionsvisitor.cpp
src/gromacs/pulling/pull_rotation.cpp
src/gromacs/pulling/pull_rotation.h
src/gromacs/pulling/tests/pull.cpp
src/gromacs/random/seed.cpp
src/gromacs/random/tabulatednormaldistribution.cpp
src/gromacs/random/tests/exponentialdistribution.cpp
src/gromacs/random/tests/gammadistribution.cpp
src/gromacs/random/tests/normaldistribution.cpp
src/gromacs/random/tests/seed.cpp
src/gromacs/random/tests/tabulatednormaldistribution.cpp
src/gromacs/random/tests/threefry.cpp
src/gromacs/random/tests/uniformintdistribution.cpp
src/gromacs/random/tests/uniformrealdistribution.cpp
src/gromacs/random/threefry.h
src/gromacs/selection/selectionenums.h
src/gromacs/simd/simd.h
src/gromacs/simd/support.cpp
src/gromacs/simd/tests/base.cpp
src/gromacs/simd/tests/base.h
src/gromacs/simd/tests/scalar.cpp
src/gromacs/simd/tests/scalar_math.cpp
src/gromacs/simd/tests/scalar_util.cpp
src/gromacs/simd/tests/simd.cpp
src/gromacs/simd/tests/simd.h
src/gromacs/simd/tests/simd4.cpp
src/gromacs/simd/tests/simd4.h
src/gromacs/simd/tests/simd4_floatingpoint.cpp
src/gromacs/simd/tests/simd4_math.cpp
src/gromacs/simd/tests/simd4_vector_operations.cpp
src/gromacs/simd/tests/simd_floatingpoint.cpp
src/gromacs/simd/tests/simd_floatingpoint_util.cpp
src/gromacs/simd/tests/simd_integer.cpp
src/gromacs/simd/tests/simd_math.cpp
src/gromacs/simd/tests/simd_vector_operations.cpp
src/gromacs/tables/cubicsplinetable.cpp
src/gromacs/tables/quadraticsplinetable.cpp
src/gromacs/tables/tableinput.h
src/gromacs/taskassignment/decidegpuusage.cpp
src/gromacs/taskassignment/decidegpuusage.h
src/gromacs/taskassignment/findallgputasks.cpp
src/gromacs/taskassignment/findallgputasks.h
src/gromacs/taskassignment/reportgpuusage.cpp
src/gromacs/taskassignment/reportgpuusage.h
src/gromacs/taskassignment/resourcedivision.cpp
src/gromacs/taskassignment/resourcedivision.h
src/gromacs/taskassignment/taskassignment.cpp
src/gromacs/taskassignment/taskassignment.h
src/gromacs/taskassignment/tests/usergpuids.cpp
src/gromacs/taskassignment/usergpuids.cpp
src/gromacs/taskassignment/usergpuids.h
src/gromacs/topology/block.h
src/gromacs/trajectory/energyframe.cpp
src/gromacs/trajectory/energyframe.h
src/gromacs/trajectoryanalysis/modules/angle.h
src/gromacs/trajectoryanalysis/tests/clustsize.cpp
src/gromacs/trajectoryanalysis/tests/test_selection.cpp
src/gromacs/utility/coolstuff.cpp
src/gromacs/utility/niceheader.cpp
src/gromacs/utility/niceheader.h
src/gromacs/utility/physicalnodecommunicator.cpp
src/gromacs/utility/physicalnodecommunicator.h
src/gromacs/utility/tests/alignedallocator-impl.h
src/gromacs/utility/tests/alignedallocator.cpp
src/gromacs/utility/tests/arrayref.cpp
src/gromacs/utility/tests/gmxregex.cpp
src/gromacs/utility/tests/mutex.cpp
src/gromacs/utility/tests/physicalnodecommunicator-mpi.cpp
src/gromacs/utility/tests/physicalnodecommunicator.cpp
src/gromacs/utility/tests/stringutil.cpp
src/gromacs/utility/tests/textreader.cpp
src/gromacs/utility/tests/typetraits.cpp
src/programs/mdrun/mdrun.cpp
src/programs/mdrun/tests/energycomparison.cpp
src/programs/mdrun/tests/energycomparison.h
src/programs/mdrun/tests/energyreader.cpp
src/programs/mdrun/tests/energyreader.h
src/programs/mdrun/tests/initialconstraints.cpp
src/programs/mdrun/tests/moduletest.cpp
src/programs/mdrun/tests/multisim.cpp
src/programs/mdrun/tests/multisimtest.cpp
src/programs/mdrun/tests/multisimtest.h
src/programs/mdrun/tests/pmetest.cpp
src/programs/mdrun/tests/replicaexchange.cpp
src/programs/mdrun/tests/tabulated_bonded_interactions.cpp
src/programs/mdrun/tests/termination.cpp
src/programs/mdrun/tests/terminationhelper.cpp
src/programs/mdrun/tests/terminationhelper.h
src/programs/mdrun/tests/tpitest.cpp
src/programs/mdrun/tests/trajectorycomparison.cpp
src/programs/mdrun/tests/trajectorycomparison.h
src/programs/mdrun/tests/trajectoryreader.cpp
src/programs/mdrun/tests/trajectoryreader.h
src/testutils/testasserts.cpp
src/testutils/testasserts.h
src/testutils/testmatchers.cpp
src/testutils/testmatchers.h

index d742d97440b30c0ba2fb107ba6c699d1dd8649c8..e8f0659232d9f270d8775c9bfd81c8d9b1fb2a42 100644 (file)
@@ -21,7 +21,8 @@ The following list provides the general formatting/indentation rules for
   functions in C++ classes, which can be put on a single line.
 * Use spaces liberally.
 * ``extern "C"`` and ``namespace`` blocks are not indented, but all others
-  (including ``class`` and ``switch`` bodies) are.
+  (including ``class`` and ``switch`` bodies) are. Namespace blocks have
+  to have a closing comment with the name of it.
 
 Additionally:
 
index 75da6d7eca088425e19255a3a51c056ae83a1778..05659288012239eaa48b4c8b8c3bd16353b10a3f 100644 (file)
@@ -4,9 +4,10 @@ Checks:  clang-diagnostic-*,clang-analyzer-*,-clang-analyzer-security.insecureAP
          -readability-function-size,-readability-else-after-return,
          modernize-use-nullptr,modernize-use-emplace,
          modernize-make-unique,modernize-make-shared,
-         google-readability-casting,
          cppcoreguidelines-*,-cppcoreguidelines-pro-*,-cppcoreguidelines-owning-memory,
-         -cppcoreguidelines-no-malloc,-cppcoreguidelines-special-member-functions
+         -cppcoreguidelines-no-malloc,-cppcoreguidelines-special-member-functions,
+         google-*,-google-build-using-namespace,-google-explicit-constructor,
+         -google-readability-function-size,-google-readability-todo,-google-runtime-int
 
 CheckOptions:
   - key:           cppcoreguidelines-special-member-functions.AllowSoleDefaultDtor
index 6eb5ccadd36db669337a587a29bfba329ac8c57a..57a635e03e8df40aedd4fad2c74853a43391ee30 100644 (file)
@@ -407,4 +407,4 @@ int BiasWriter::writeToEnergySubblocks(const Bias    &bias,
     return block_.size();
 }
 
-} // namepace gmx
+}  // namespace gmx
index 86e28c0cf0974978d208314f75d42e6d9c08eb61..1c9928adfd32ac6116007efa218664ad7e5f876c 100644 (file)
@@ -340,5 +340,5 @@ TEST(BiasTest, DetectsCovering)
     }
 }
 
-} // namespace
-} // namespace
+}  // namespace test
+}  // namespace gmx
index 1ba40d7c542d07268af6403bd47761d8689bbc16..c7d2080306e92678dcebfb0f2e6e0c6e2f846fdc 100644 (file)
@@ -176,5 +176,5 @@ INSTANTIATE_TEST_CASE_P(WithParameters, BiasStateTest,
                             ::testing::Values("pmf_target_format0.xvg",
                                               "pmf_target_format1.xvg"));
 
-} // namespace
-} // namespace
+}  // namespace test
+}  // namespace gmx
index e1a883746c9d083a9eb369dae19d49b9011f2821..772490e0a1480c485a4104828d5a57b07ae24e36 100644 (file)
@@ -181,5 +181,5 @@ TEST(gridTest, neighborhood)
     EXPECT_TRUE(haveCorrectNumNeighbors);
 }
 
-} // namespace
-} // namespace
+}  // namespace test
+}  // namespace gmx
index cf006c3908edccae6ba7d02c003b9e9fc60c2c03..47110d0ac95ab375a6aa4c4ddefcaf77b152922b 100644 (file)
@@ -538,7 +538,7 @@ class HelpExportReStructuredText : public IHelpExport
 
     private:
         IFileOutputRedirector          *outputRedirector_;
-        const std::string              &binaryName_;
+        const std::string              &binaryName_; //NOLINT(google-runtime-member-string-references)
         HelpLinks                       links_;
         // These never release ownership.
         std::unique_ptr<TextWriter>     indexFile_;
index 2d89df503dec69f08d22e633ef0229ac34ef65b0..72242b048b9bc134cf9135ed649edcd8d78543d3 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2017, by the GROMACS development team, led by
+ * Copyright (c) 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.
@@ -112,7 +112,7 @@ make_unique(Args && ...) = delete;
 
 ///\endcond
 
-}      // namespace gmx::compat
+}      // namespace compat
 }      // namespace gmx
 
 #endif // header guard
index f5b5f2733a6e4d1c23898ee63e3c2e957c0c6fab..0cf1b4af141824e735f35545b5dadcdc67f877ac 100644 (file)
@@ -230,6 +230,6 @@ TEST_F (AutocorrTest, EacP4)
 }
 
 
-}
+}  // namespace
 
-}
+}  // namespace gmx
index 4f365f0a35f224f5e49eb68fdcbd19c268c0cbd1..55e49863c0e8e2ee20effecae0e2ec3bebf8f109 100644 (file)
@@ -209,6 +209,6 @@ TEST_F (ExpfitTest, EffnPRES) {
 
 #endif
 
-}
+}  // namespace
 
-}
+}  // namespace gmx
index 92a8e8534bfccb40691bd3f976484ddc93759557..a634322371afd290d01cb821d94e8fe219348895 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2014,2015,2016, by the GROMACS development team, led by
+ * Copyright (c) 2014,2015,2016,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.
@@ -81,6 +81,6 @@ TEST_F (ManyAutocorrelationTest, DifferentLength)
 }
 #endif
 
-}
+}  // namespace
 
-}
+}  // namespace gmx
index 8b3edbf7b4ca2b7b0285c1d8de94ff8b946d3a30..f242839feb36f63fbde9ea3c1f359f2fbe3a2812 100644 (file)
@@ -294,7 +294,7 @@ bool bNeedDoEdsam(const t_edpar &edi)
            || edi.vecs.radacc.neig
            || edi.vecs.radcon.neig;
 }
-}
+}  // namespace
 
 
 /* Multiple ED groups will be labeled with letters instead of numbers
@@ -433,7 +433,7 @@ real calc_radius(const t_eigvec &vec)
 
     return rad = sqrt(rad);
 }
-}
+}  // namespace
 
 struct t_do_edfit {
     double **omega;
@@ -1533,7 +1533,7 @@ void setup_edvec(t_eigvec *tvec)
     snew(tvec->fproj, tvec->neig);
     snew(tvec->refproj, tvec->neig);
 }
-}
+}  // namespace
 
 
 /* Check if the same atom indices are used for reference and average positions */
index 7549d1aa23c9753216cc5b215ed7c46f6b1822fc..b4c41798ffc71bbd223b25dac6c1ca838875f836 100644 (file)
@@ -191,6 +191,6 @@ INSTANTIATE_TEST_CASE_P(SaneInput1, PmeBSplineModuliCorrectnessTest, ::testing::
                                     ::testing::Range(3, 8 + 1),
                                     ::testing::Values(ModuliType::PME, ModuliType::P3M)
                                 ));
-}
-}
-}
+}  // namespace
+}  // namespace test
+}  // namespace gmx
index 34219cb84569bb008002afff944053d06f232c2e..2d86d12feb2fac3b9d0f22eff285f0f555194fe6 100644 (file)
@@ -455,6 +455,6 @@ INSTANTIATE_TEST_CASE_P(SaneInput, PmeGatherTest, ::testing::Combine(::testing::
                                                                          ::testing::Values(PmeForceOutputHandling::Set, PmeForceOutputHandling::ReduceWithInput),
                                                                          ::testing::ValuesIn(atomCounts)));
 
-}
-}
-}
+}  // namespace
+}  // namespace test
+}  // namespace gmx
index 32a296e2ce7229635d372698e093ff321ec3bbde..148d27ba3b789e26395692ca0a6cd6b172e06922 100644 (file)
@@ -375,6 +375,6 @@ INSTANTIATE_TEST_CASE_P(DifferentEpsilonR, PmeSolveTest, ::testing::Combine(c_in
                                                                             testing::Values(1.9), c_inputEwaldCoeff_q, c_inputEwaldCoeff_lj,
                                                                             c_inputMethods));
 
-}
-}
-}
+}  // namespace
+}  // namespace test
+}  // namespace gmx
index aca761a393c92f3ddccd7ebb4af70320ca245f65..105f2ca37a280589820dd55f27719f26dbe0bffb 100644 (file)
@@ -353,6 +353,6 @@ INSTANTIATE_TEST_CASE_P(SaneInput13, PmeSplineAndSpreadTest, ::testing::Combine(
                                                                                     ::testing::Values(c_sampleCoordinates13),
                                                                                     ::testing::Values(c_sampleCharges13)
                                                                                 ));
-}
-}
-}
+}  // namespace
+}  // namespace test
+}  // namespace gmx
index 9bcd6e1704694a9d78ef67a17b5bb9a5cf258a4b..bb82470c011ce578b911e65bc1e9ff2326fec408 100644 (file)
@@ -207,8 +207,8 @@ static real *pmeGetRealGridInternal(const gmx_pme_t *pme)
 //! Getting local PME real grid dimensions
 static void pmeGetRealGridSizesInternal(const gmx_pme_t      *pme,
                                         CodePath              mode,
-                                        IVec                 &gridSize,
-                                        IVec                 &paddedGridSize)
+                                        IVec                 &gridSize,       //NOLINT(google-runtime-references)
+                                        IVec                 &paddedGridSize) //NOLINT(google-runtime-references)
 {
     const size_t gridIndex = 0;
     IVec         gridOffsetUnused;
@@ -236,8 +236,8 @@ static t_complex *pmeGetComplexGridInternal(const gmx_pme_t *pme)
 
 //! Getting local PME complex grid dimensions
 static void pmeGetComplexGridSizesInternal(const gmx_pme_t      *pme,
-                                           IVec                 &gridSize,
-                                           IVec                 &paddedGridSize)
+                                           IVec                 &gridSize,       //NOLINT(google-runtime-references)
+                                           IVec                 &paddedGridSize) //NOLINT(google-runtime-references)
 {
     const size_t gridIndex = 0;
     IVec         gridOffsetUnused, complexOrderUnused;
@@ -245,7 +245,7 @@ static void pmeGetComplexGridSizesInternal(const gmx_pme_t      *pme,
 }
 
 //! Getting the PME grid memory buffer and its sizes - template definition
-template<typename ValueType> static void pmeGetGridAndSizesInternal(const gmx_pme_t * /*unused*/, CodePath /*unused*/, ValueType * & /*unused*/, IVec & /*unused*/, IVec & /*unused*/)
+template<typename ValueType> static void pmeGetGridAndSizesInternal(const gmx_pme_t * /*unused*/, CodePath /*unused*/, ValueType * & /*unused*/, IVec & /*unused*/, IVec & /*unused*/) //NOLINT(google-runtime-references)
 {
     GMX_THROW(InternalError("Deleted function call"));
     // explicitly deleting general template does not compile in clang/icc, see https://llvm.org/bugs/show_bug.cgi?id=17537
@@ -721,5 +721,5 @@ PmeSolveOutput pmeGetReciprocalEnergyAndVirial(const gmx_pme_t *pme, CodePath mo
     return std::make_tuple(energy, virial);
 }
 
-}
-}
+}  // namespace test
+}  // namespace gmx
index 5396cbb13eba7a847f2e799b55e2619bb908fdf8..cc516f621c4c5c5dfb82db84eb7d255a81ff5301 100644 (file)
@@ -142,7 +142,7 @@ void pmePerformSolve(const gmx_pme_t *pme, CodePath mode,
                      GridOrdering gridOrdering, bool computeEnergyAndVirial);
 //! PME force gathering
 void pmePerformGather(gmx_pme_t *pme, CodePath mode,
-                      PmeForceOutputHandling inputTreatment, ForcesVector &forces);
+                      PmeForceOutputHandling inputTreatment, ForcesVector &forces); //NOLINT(google-runtime-references)
 //! PME test finalization before fetching the outputs
 void pmeFinalizeTest(const gmx_pme_t *pme, CodePath mode);
 
@@ -175,7 +175,7 @@ SparseComplexGridValuesOutput pmeGetComplexGrid(const gmx_pme_t *pme, CodePath m
 //! Getting the reciprocal energy and virial
 PmeSolveOutput pmeGetReciprocalEnergyAndVirial(const gmx_pme_t *pme, CodePath mode,
                                                PmeSolveAlgorithm method);
-}
-}
+}  // namespace test
+}  // namespace gmx
 
 #endif
index ddea88771270399a94bf9cb0111920a6a1c0a4bb..ab7fcb038ecfbead3a4e39cccb44e6f423c5e760 100644 (file)
@@ -138,5 +138,5 @@ void PmeTestEnvironment::TearDown()
     gmx_hardware_info_free();
 }
 
-}
-}
+}  // namespace test
+}  // namespace gmx
index 6d5afe0548986fb46b1f72e899feb7fbf1cc3589..88f45342b929ae5993f6516be5cf7907817ce781 100644 (file)
@@ -127,6 +127,6 @@ const PmeTestEnvironment *getPmeTestEnv();
  * unit test so that they can use the hardware context. */
 void callAddGlobalTestEnvironment();
 
-}
-}
+}  // namespace test
+}  // namespace gmx
 #endif
index 9206ac34932708f3ccac25c812fd2a96388c3484..6d23b9b525626564451322f0bf32da128566edd2 100644 (file)
@@ -132,5 +132,5 @@ TEST_F(ReadTest, get_ereal_WarnsAboutString)
     ASSERT_TRUE(warning_errors_exist(wi_));
 }
 
-} // namespace
-} // namespace
+}  // namespace testing
+}  // namespace gmx
index 412938e3ab39a50c164042bf166571d90168f219..a81d29a6a39a5b95c03ad73e8b69e40ac6f29611 100644 (file)
@@ -177,5 +177,5 @@ INSTANTIATE_TEST_CASE_P(ChainSep, Pdb2gmxTest,
 
 
 } // namespace
-} // namespace
-} // namespace
+} // namespace test
+} // namespace gmx
index b6a721a36d2c30a4009b9ca9f6c841aadb95e0f8..e9c7f0fa9fdb1c25f94c187e07cb02cf51950d32 100644 (file)
@@ -209,5 +209,5 @@ TEST_F(GetIrTest, ImplicitSolventYesWorks)
     EXPECT_DEATH_IF_SUPPORTED(runTest(inputMdpFile), "Invalid enum");
 }
 
-} // namespace
-} // namespace
+}  // namespace test
+}  // namespace gmx
index fab5285ab5d63bdb698339c111101109ce6e45b0..f4ccdda7030f7f9adbf2b6ae27335a009963ffc0 100644 (file)
@@ -86,4 +86,4 @@ std::unique_ptr<ClfftInitializer> initializeClfftLibrary()
     return compat::make_unique<ClfftInitializer>();
 }
 
-}
+}  // namespace gmx
index 80c48f4bc9fc8f3709aabfc6c9c642229e212d53..18c63eb5823c5bac2d4eea669f8a93047011d699 100644 (file)
@@ -94,6 +94,6 @@ class ClfftInitializer
  */
 std::unique_ptr<ClfftInitializer> initializeClfftLibrary();
 
-}
+}  // namespace gmx
 
 #endif
index 7d7a7536a00df99ab49c0d68d36e2fc59c38a023..6308a5424692209bc916fd4ddbea1d2cb26f4489 100644 (file)
@@ -74,5 +74,5 @@ bool GpuTest::haveValidGpus() const
     return gpuInfo_->n_dev_compatible > 0;
 }
 
-} // namespace
-} // namespace
+}  // namespace test
+}  // namespace gmx
index eafae6a8baa90bd64301ce40615ad5ba8a2c1f0c..ec592cb7df1baf28060e836653f12e2895eb8717 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2017, by the GROMACS development team, led by
+ * Copyright (c) 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 @@ class GpuTest : public ::testing::Test
         bool haveValidGpus() const;
 };
 
-} // namespace
-} // namespace
+}  // namespace test
+}  // namespace gmx
 
 #endif
index 7aa7803d4a83eec747ec583b23ee6627f9adcb0c..72b1e21bcbde0b4854e84fe983eaec571561e7a4 100644 (file)
@@ -345,7 +345,7 @@ using AllocatorTypesToTest = ::testing::Types<HostAllocator<real>,
 TYPED_TEST_CASE(AllocatorTest, AllocatorTypesToTest);
 
 } // namespace
-} // namespace
+} // namespace gmx
 
 // Includes tests common to all allocation policies.
 #include "gromacs/utility/tests/alignedallocator-impl.h"
index 87d32d2a1373f3eb6648cc7dc5a301805a685ff1..ee9955457a9508cca9dca7c925e594762c362b60 100644 (file)
@@ -946,7 +946,7 @@ detectProcCpuInfo(CpuInfo::Vendor *              vendor,
     }
 }
 /*! \endcond */
-}   // namespace anonymous
+}   // namespace
 
 
 // static
index 014ae654cee60be68db6db4f8f266d76f97e3461..9fb24b97e47f61901c93bf3745c0c3372046589c 100644 (file)
@@ -688,7 +688,7 @@ detectLogicalProcessorCount()
     return count;
 }
 
-}   // namespace anonymous
+}   // namespace
 
 // static
 HardwareTopology HardwareTopology::detect()
index b2dcf352cb8fe65511f50cc06babb039e7216567..66abb682def3b2bd38ddf98e9186fda758b40ed9 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2015,2016, by the GROMACS development team, led by
+ * Copyright (c) 2015,2016,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.
@@ -264,6 +264,6 @@ class HardwareTopology
         bool                isThisSystem_; //!< Machine map is real (vs. cached/synthetic)
 };
 
-}
+}      // namespace gmx
 
 #endif // GMX_HARDWARE_HARDWARETOPOLOGY_H
index e8f18ae6a8c834a24ca253d744c0e494427a0ae7..705dcea8a7f8f3f36cb7fada3dd6e4521f296d74 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2017, by the GROMACS development team, led by
+ * Copyright (c) 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.
@@ -254,7 +254,7 @@ checkDualAvx512FmaUnits()
  */
 std::mutex initMutex;
 
-}      // namespace anonymous
+}   // namespace
 
 int
 identifyAvx512FmaUnits()
index d3d80bd1585a94d7e0043f2c1fd601dd0d36c19d..973d01bd5648a1eccafacc2bea5bb6f46b4079ce 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2016,2017, by the GROMACS development team, led by
+ * Copyright (c) 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.
@@ -273,6 +273,6 @@ TEST_F (BondedTest, IfuncProperDihedralsPbcXyz)
     testIfunc(F_PDIHS, iatoms, &iparams, epbcXYZ);
 }
 
-}
+}  // namespace
 
-}
+}  // namespace gmx
index 5c181f672e48e26477821f18f68985622d6df84e..b03ce46489e5a0de8eabb4a943dda31d677e969a 100644 (file)
@@ -97,4 +97,4 @@ void invertMatrix(const matrix src, matrix dest)
     dest[ZZ][ZZ] = c*(src[XX][XX]*src[YY][YY]-src[YY][XX]*src[XX][YY]);
 }
 
-} // namespace
+}  // namespace gmx
index 9f6da9418c124b708d674cecc6bbadd67c923af9..e38e805346b40fd5e59a038c0514983316e0462e 100644 (file)
@@ -105,6 +105,6 @@ using PaddedArrayRef = ArrayRef<T>;
 // TODO These are hacks to avoid littering gmx:: all over code that is
 // almost all destined to move into the gmx namespace at some point.
 // An alternative would be about 20 files with using statements.
-using gmx::PaddedRVecVector;
+using gmx::PaddedRVecVector; //NOLINT(google-global-names-in-headers)
 
 #endif
index e55ca702fb61c364cc7ae6b4a9e23b36cbb6e1fc..cf84470f92ff5ef2edc7d848edbef7ddb7703bac 100644 (file)
@@ -156,4 +156,4 @@ BoxDeformation::apply(ArrayRef<RVec> x,
     }
 }
 
-} // namespace
+}  // namespace gmx
index ba5bcbe19a93efe177e78ebec2925ed38eafd182..fe1351ee9cbce16d622e6248b071596422d2a8a4 100644 (file)
@@ -98,6 +98,6 @@ prepareBoxDeformation(const matrix     &initialBox,
                       t_commrec        *cr,
                       const t_inputrec &inputrec);
 
-} // namespace
+}  // namespace gmx
 
 #endif
index 8d761ad7bdbd1d6013b3b36670175a0b5ced0b48..5e085c375a690b61109ae24ec4cd05a3fb605381 100644 (file)
@@ -1209,4 +1209,4 @@ bool inter_charge_group_settles(const gmx_mtop_t &mtop)
     return bInterCG;
 }
 
-} // namespace
+}  // namespace gmx
index 6579ba96744f22dafba6334dccf7972592749a17..c887bc27545faa4a6e68d5f7dcd6b5482b9c62d6 100644 (file)
@@ -259,6 +259,6 @@ bool inter_charge_group_constraints(const gmx_mtop_t &mtop);
 /*! \brief Returns whether there are inter charge group settles */
 bool inter_charge_group_settles(const gmx_mtop_t &mtop);
 
-} // namespace
+}  // namespace gmx
 
 #endif
index 95cf473a8ce2acad822eb309f33424c37ad641dc..a28b9554614c92f5cddffdba2e8691fd0fe29943 100644 (file)
@@ -240,4 +240,4 @@ real constr_r_max(FILE *fplog, const gmx_mtop_t *mtop, const t_inputrec *ir)
     return rmax;
 }
 
-} // namespace
+}  // namespace gmx
index 681cf142b404d29e6d2f63d224d2c3fd4368d961..a5171a3daa268dfe8d889c86ce39ab05b3ca41b0 100644 (file)
@@ -2639,4 +2639,4 @@ bool constrain_lincs(bool computeRmsd,
     return bOK;
 }
 
-} // namespace
+}  // namespace gmx
index 096b8e24c957316529fc70e825511af25aae35c1..fe172a4746fc4d9a1209c4b5839d499def5e1502 100644 (file)
@@ -107,6 +107,6 @@ constrain_lincs(bool computeRmsd,
                 t_nrnb *nrnb,
                 int maxwarn, int *warncount);
 
-} // namespace
+}  // namespace gmx
 
 #endif
index 500fbfef0f6a362439eea6bb8c6dfadc7305952c..65246ecb7bf0420b0e70de73528b405bada6191c 100644 (file)
@@ -116,6 +116,6 @@ std::unique_ptr<Constraints> makeConstraints(const gmx_mtop_t &mtop,
                (mtop, ir, std::forward<Args>(args) ..., numConstraints, numSettles);
 }
 
-} // namespace
+}  // namespace gmx
 
 #endif
index 8df527670fadd3791b0377910ecfc5ddf3063a32..d0d2c82d674966fac0e2b2499b3952f1f2f113d6 100644 (file)
@@ -198,7 +198,7 @@ makeMDAtoms(FILE *fp, const gmx_mtop_t &mtop, const t_inputrec &ir,
     return mdAtoms;
 }
 
-} // namespace
+}  // namespace gmx
 
 void atoms2md(const gmx_mtop_t *mtop, const t_inputrec *ir,
               int nindex, const int *index,
index b8ecf61345ad1119ad0fb731143325434012ec0a..a77a043f4934069c1f157b6cc04ff74b91625523 100644 (file)
@@ -102,7 +102,7 @@ std::unique_ptr<MDAtoms>
 makeMDAtoms(FILE *fp, const gmx_mtop_t &mtop, const t_inputrec &ir,
             bool useGpuForPme);
 
-} // namespace
+}  // namespace gmx
 
 void atoms2md(const gmx_mtop_t *mtop, const t_inputrec *ir,
               int nindex, const int *index,
index a5a1bec6353a5ef628c497f37bb02fff2e691a61..fb68c73d72637881c31b331f944384273044610d 100644 (file)
@@ -901,4 +901,4 @@ void csettle(settledata *settled,
     }
 }
 
-} // namespace
+}  // namespace gmx
index 7c7473d4b561e03db71eb795e1b882c4cb7a8bfd..c5ba5fec36c31bce7ed2003afd9459b6057dc0c7 100644 (file)
@@ -97,6 +97,6 @@ void settle_proj(settledata *settled, ConstraintVariable econq,
                  rvec *der, rvec *derp,
                  int CalcVirAtomEnd, tensor vir_r_m_dder);
 
-} // namespace
+}  // namespace gmx
 
 #endif
index c168e041763d0c8db6a357a6d5b122544443b4d7..8f4b9c3d0686ca9f05c82a738c9ad4ca829c28e0 100644 (file)
@@ -857,4 +857,4 @@ constrain_shake(FILE              *log,
     return bOK;
 }
 
-} // namespace
+}  // namespace gmx
index 40ef291724b34021185e008f5fe435b09475bf15..62698ce61888839aa4be5840d492bedf65abd302 100644 (file)
@@ -107,6 +107,6 @@ void cshake(const int iatom[], int ncon, int *nnit, int maxnit,
             const real dist2[], real xp[], const real rij[], const real m2[], real omega,
             const real invmass[], const real tt[], real lagr[], int *nerror);
 
-} // namespace
+}  // namespace gmx
 
 #endif
index aa0a63f137b39747d18f9db8681a640722e0deeb..57cd0043fd5619a71b7bcbb8c21f8d1d33571b22 100644 (file)
@@ -148,4 +148,4 @@ void SimulationSignaller::finalizeSignals()
     setSignals();
 }
 
-} // namespace
+}  // namespace gmx
index 5dc1138fabf099f0e02c4cb70ff4147ab19780b8..4d7ba8bc461f9ccd798da2a16d2377de7ed154ca 100644 (file)
@@ -159,6 +159,6 @@ class SimulationSignaller
         std::array<real, eglsNR> mpiBuffer_;
 };
 
-} // namespace
+}  // namespace gmx
 
 #endif
index 9fb809ef95d2109323dfa9601dc7a4e5682612e9..da90ace13c259c91fc0e8b3f70a5293663f5d84d 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2017, by the GROMACS development team, led by
+ * Copyright (c) 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.
@@ -135,6 +135,6 @@ TEST_F(VerletBufferConstraintTest, EqualMasses)
     GMX_RELEASE_ASSERT(numPointsBeforeMax >= 20 && numPointsAfterMax >= 20, "This test only provides full coverage when we test a sufficient number of points before and after the location of the maximum value for the exact formula.");
 }
 
-}      // namespace anonymous
+}  // namespace
 
-}      // namespace gmx
+}  // namespace gmx
index 7cae684b628eb81415b8cdb7ee07bf671bb08ded..58a6ba1d2b1f640729d1db7471289d0f65a89c05 100644 (file)
@@ -154,6 +154,6 @@ TEST_F(PrintEbin, pr_ebin_HandlesEmptyAverages)
     checker_.checkString(TextReader::readFileToString(logFilename_), "log");
 }
 
-}      // namespace
-}      // namespace
-}      // namespace
+}  // namespace
+}  // namespace test
+}  // namespace gmx
index 24ee0acdc49c387340503b5cc25e54ee45b437a0..ef9dc06c7fa7b3281b87ddea3abaa119bc8a45a4 100644 (file)
@@ -315,5 +315,5 @@ INSTANTIATE_TEST_CASE_P(WithParameters, SettleTest,
                                                    ::testing::Bool(),
                                                    ::testing::Bool()));
 
-} // namespace
-} // namespace
+}  // namespace test
+}  // namespace gmx
index f1fb6c2c999e910c8d0b0252424eaa704e7b76bd..294dd7b3e0ece4edc7280b0785001f8642a35552 100644 (file)
@@ -359,4 +359,4 @@ TEST_F(ShakeTest, ConstrainsThreeBondsWithCommonAtoms)
 }
 
 } // namespace
-} // namespace
+} // namespace gmx
index 591a701d9f89d3f1524b589a3a47d6a778286e4b..408c511d425b056c0e13ceff0ca2bd65374c8063 100644 (file)
@@ -173,5 +173,5 @@ TEST_F(SignalTest, NonLocalSignalPropagatesWhenBothTakePlace)
     EXPECT_EQ(0, signals_[2].set);
 }
 
-} // namespace
-} // namespace
+}  // namespace test
+}  // namespace gmx
index d5d41b062d8e50813e81d1b0695228e1f8b3f6d5..bf83237c17a60157a3681b9aec08b4e37d41562a 100644 (file)
@@ -213,7 +213,7 @@ restore_ekinstate_from_state(const t_commrec *cr,
                              gmx_ekindata_t *ekind, const ekinstate_t *ekinstate);
 
 void berendsen_tcoupl(const t_inputrec *ir, const gmx_ekindata_t *ekind, real dt,
-                      std::vector<double> &therm_integral);
+                      std::vector<double> &therm_integral); //NOLINT(google-runtime-references)
 
 void andersen_tcoupl(t_inputrec *ir, int64_t step,
                      const t_commrec *cr, const t_mdatoms *md, t_state *state, real rate, const gmx_bool *randomize, const real *boltzfac);
index f5158bcae7493bb2b21e90512c8ee3b9f0745583..658a379a982359dcffbbcd2e36b7b375b62f5318 100644 (file)
@@ -92,4 +92,4 @@ void Integrator::run(unsigned int ei)
     }
 }
 
-} // namespace
+}  // namespace gmx
index 0c0797239c936287b100576b72982a3782adcb46..4cf190406a8cd5bbbacd6dc53a01843d4b542e69 100644 (file)
@@ -215,7 +215,7 @@ t_commrec *Mdrunner::spawnThreads(int numThreadsToLaunch) const
     return reinitialize_commrec_for_this_thread(cr);
 }
 
-}      // namespace
+}  // namespace gmx
 
 /*! \brief Initialize variables for Verlet scheme simulation */
 static void prepare_verlet_scheme(FILE                           *fplog,
index 60752d7c7ed1345c960fc503212f1f3371ae7f13..781392a18707147f29c06c93275546cdd573a090 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2017, by the GROMACS development team, led by
+ * Copyright (c) 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.
@@ -139,6 +139,6 @@ class ForceWithVirial
         matrix               virial_;        //!< Virial accumulation buffer
 };
 
-}
+}  // namespace gmx
 
 #endif
index c250209166363f3a948a244bb04e36c28cdf581b..3bf1b3c734c9878e25054a5d055ac6edcccd1127 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2015, by the GROMACS development team, led by
+ * Copyright (c) 2015,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.
@@ -113,7 +113,7 @@ class RstParagraphIterator
         };
 
         //! The text to iterate over.
-        const std::string &text_;
+        const std::string &text_; //NOLINT(google-runtime-member-string-references)
 
         //! Start of the current paragraph.
         size_t             begin_;
index 8652aa963b228ab9eebe938f7fff7cabca6ef0cc..2d22ad0857cbb065496bf6702f6c55be93ccd754 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2015, by the GROMACS development team, led by
+ * Copyright (c) 2015,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.
@@ -96,6 +96,6 @@ class OptionsBehaviorCollection
         GMX_DISALLOW_COPY_AND_ASSIGN(OptionsBehaviorCollection);
 };
 
-} // namespace
+}  // namespace gmx
 
 #endif
index 087525e445f28bf68fef50f33902c371969a4827..09bc9d20d0fdf50a80675db9f897ecb3b9cc3f3f 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2015, by the GROMACS development team, led by
+ * Copyright (c) 2015,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.
@@ -96,6 +96,6 @@ class IOptionsBehavior
         virtual void optionsFinished() = 0;
 };
 
-} // namespace
+}  // namespace gmx
 
 #endif
index 3cdaafc0210a4253255816dcf63301ff4401be8a..d988f4c3fd68fbb327cad2fa165fee42eb5ab5e9 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2015,2016, by the GROMACS development team, led by
+ * Copyright (c) 2015,2016,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.
@@ -145,6 +145,6 @@ class IOptionsContainer
         GMX_DEFAULT_CONSTRUCTORS(IOptionsContainer);
 };
 
-} // namespace
+}  // namespace gmx
 
 #endif
index 198e0caf8080887030e571665ef4310167992838..29d8f9754cef906e2c859d3877a64620f91fbdb2 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2016, by the GROMACS development team, led by
+ * Copyright (c) 2016,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.
@@ -109,6 +109,6 @@ class IOptionsContainerWithSections : public IOptionsContainer
         GMX_DEFAULT_CONSTRUCTORS(IOptionsContainerWithSections);
 };
 
-} // namespace
+}  // namespace gmx
 
 #endif
index a665803f9f6961820bdec463433c5f3f35260e25..c628d3a5a1c951b5896fa8e52e5b890dbb090274 100644 (file)
@@ -56,12 +56,12 @@ namespace
 {
 
 //! Helper function to call visitOptions() and handle correct indirection.
-void visitOption(OptionsVisitor *visitor, OptionInfo &optionInfo)
+void visitOption(OptionsVisitor *visitor, OptionInfo &optionInfo) //NOLINT(google-runtime-references)
 {
     visitor->visitOption(optionInfo);
 }
 //! Helper function to call visitOptions() and handle correct indirection.
-void visitOption(OptionsModifyingVisitor *visitor, OptionInfo &optionInfo)
+void visitOption(OptionsModifyingVisitor *visitor, OptionInfo &optionInfo) //NOLINT(google-runtime-references)
 {
     visitor->visitOption(&optionInfo);
 }
index 1e7b3f4838556d62d4e986873806f5e576eee00b..74fb143114d3b2a1ef1ef5e608fe37f27ca7a2b9 100644 (file)
@@ -316,7 +316,7 @@ gmx_enfrot *EnforcedRotation::getLegacyEnfrot()
     return &impl_->enforcedRotation_;
 }
 
-} // namespace
+}  // namespace gmx
 
 /* Activate output of forces for correctness checks */
 /* #define PRINT_FORCES */
index 4e02ddc85f6b1da4829367f867c2f767c6abddcc..fe313c39068b3cd95625618eeeb49a42a37a8c25 100644 (file)
@@ -87,7 +87,7 @@ class EnforcedRotation
         PrivateImplPointer<Impl> impl_;
 };
 
-} // namespace
+}  // namespace gmx
 
 /*! \brief Initializes the enforced rotation groups.
  *
index 77ab1a13ad5685a54ce024995999c6aa087f3a4a..b56fad0b88d7e049122dfeda906ae879d89936a9 100644 (file)
@@ -196,6 +196,6 @@ TEST_F (PullTest, MaxPullDistanceXySkewedBox)
     test(epbcXY, box);
 }
 
-}
+}  // namespace
 
-}
+}  // namespace gmx
index 2b5c855cc81db456385c9497e24d11f65047e080..94a3f83e4d549fadaed39011a48c9f0c0bb20a70 100644 (file)
@@ -60,4 +60,4 @@ makeRandomSeed()
     return result;
 }
 
-}
+}  // namespace gmx
index 59c01d98a5e136fe1180863fc2335feabe543234..e595975f348296bedc1f4f11daf1a5a2cd733372 100644 (file)
@@ -55,4 +55,4 @@ TabulatedNormalDistribution<>::c_table_ = TabulatedNormalDistribution<>::makeTab
 void TabulatedNormalDistributionDummy(){}
 #endif
 
-}
+}  // namespace gmx
index 759a2c17eebe4eb232f5527e3e02fb84e707d207..f2a52026236e11b1aefb7a5bc2ba256d60900e5f 100644 (file)
@@ -126,6 +126,6 @@ TEST(ExponentialDistributionTest, AltParam)
     EXPECT_REAL_EQ_TOL(distA(rngA), distB(rngB, paramA), gmx::test::ulpTolerance(0));
 }
 
-}      // namespace anonymous
+}  // namespace
 
-}      // namespace gmx
+}  // namespace gmx
index 4cee2ca2a22a7828c881d91eb8b26d6cbe55ce21..1c6fdd154ab00e8ee72111938f6621e07d265d58 100644 (file)
@@ -120,6 +120,6 @@ TEST(GammaDistributionTest, AltParam)
     EXPECT_REAL_EQ_TOL(distA(rngA), distB(rngB, paramA), gmx::test::ulpTolerance(0));
 }
 
-}      // namespace anonymous
+}  // namespace
 
-}      // namespace gmx
+}  // namespace gmx
index 3ad6af4ab70f9de4deb948ff815290ba2cdf06cb..97167966cbb3e6219407bd8689580c99fd1e441d 100644 (file)
@@ -132,6 +132,6 @@ TEST(NormalDistributionTest, AltParam)
     EXPECT_REAL_EQ_TOL(valA, valB, gmx::test::ulpTolerance(0));
 }
 
-}      // namespace anonymous
+}  // namespace
 
-}      // namespace gmx
+}  // namespace gmx
index ac2cb0697c5e51f0187b75b358207ac2390c42fa..e97ceb5acede7468b44f8462bbd04e8addafa887 100644 (file)
@@ -66,6 +66,6 @@ TEST(SeedTest, makeRandomSeed)
     EXPECT_NE(i0, i1);
 }
 
-}      // namespace anonymous
+}  // namespace
 
-}      // namespace gmx
+}  // namespace gmx
index 6693d875b4d6674502b65e0a1279883dbfc50905..502c8dfb3001a61dbbc11ca878a849b2416be5d9 100644 (file)
@@ -178,6 +178,6 @@ TEST(TabulatedNormalDistributionTableTest, HasValidProperties)
     EXPECT_REAL_EQ_TOL(1.0, variance, tolerance) << "Table should have unit variance";
 }
 
-}      // namespace anonymous
+}  // namespace
 
-}      // namespace gmx
+}  // namespace gmx
index 6552fec98abc0afdaa671702dff2da126c4246bc..7afd82665c2969b64120d8eb81892fb7805f9cb5 100644 (file)
@@ -244,6 +244,6 @@ TEST_F(ThreeFry2x64Test, ExhaustInternalCounter)
     EXPECT_THROW_GMX(rngA(), gmx::InternalError);
 }
 
-}      // namespace anonymous
+}  // namespace
 
-}      // namespace gmx
+}  // namespace gmx
index b7cd01ef61e390512e42f40400463906076bb512..b718ada683cdcdc5c47946926d0fef960c1c4df4 100644 (file)
@@ -122,6 +122,6 @@ TEST(UniformIntDistributionTest, AltParam)
 }
 
 
-}      // namespace anonymous
+}  // namespace
 
-}      // namespace gmx
+}  // namespace gmx
index 599d89ebea468cebed16c21c0abc6ee3f53f0b9e..0214912b002a70c203c2d18383d3c39038e6d69f 100644 (file)
@@ -145,6 +145,6 @@ TEST(UniformRealDistributionTest, AltParam)
     EXPECT_REAL_EQ_TOL(valA, valB, gmx::test::ulpTolerance(0));
 }
 
-}      // namespace anonymous
+}  // namespace
 
-}      // namespace gmx
+}  // namespace gmx
index 5c1d4284856e3511141ea034cd2e4b7a236f9882..44e9a38d8cce69fd3fc1feb18f2cba6a78589d8b 100644 (file)
@@ -278,7 +278,7 @@ highBitCounter
         }
     }
 };
-}
+}   // namespace internal
 
 /*! \brief General implementation class for ThreeFry counter-based random engines.
  *
index 1492715dfec93cd8f5a67448eb28b03a7db26910..34d4b28dde8192d84e38f1c79afb6161ab38d6dc 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2010,2012,2013,2014,2015,2016, by the GROMACS development team, led by
+ * Copyright (c) 2010,2012,2013,2014,2015,2016,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.
@@ -133,6 +133,6 @@ struct SelectionTopologyProperties
     bool needsMasses;
 };
 
-}
+}  // namespace gmx
 
 #endif
index 3c1c54b79a8449f9d1b1b5bab2e2abe6a42bbba4..51bb2da4bd1c282151259cdaa4dd4e4a12903069 100644 (file)
@@ -97,7 +97,7 @@ struct SimdDoubleTag {};
 struct SimdFInt32Tag {};
 /*! \libinternal \brief Tag type to select to load SimdDInt32 with simdLoad(U) */
 struct SimdDInt32Tag {};
-}
+}  // namespace gmx
 
 /*! \name SIMD predefined macros to describe high-level capabilities
  *
index 9525a054bd8cdca3d8454559e1573263dfe97ff7..d7b5839251d9ad3957d283aee2513ef9f92cdc17 100644 (file)
@@ -310,4 +310,4 @@ simdCheck(gmx::SimdType    wanted,
 
 /*! \endcond */
 
-}
+}  // namespace gmx
index bc16427175c3365bb48dbf482eba1a83aef213cb..d7d13c0ad53f2330044300b3693b0ec9ca0237b7 100644 (file)
@@ -127,5 +127,5 @@ SimdBaseTest::compareVectorRealUlp(const char * refExpr,   const char * tstExpr,
 /*! \} */
 /*! \endcond */
 
-}      // namespace
-}      // namespace
+}  // namespace test
+}  // namespace gmx
index 2f85847a5901b2b1fb60cbf9960f112e9e380571..1718763e3f1c090f4dd84879a5c3f554ac4220b5 100644 (file)
@@ -192,7 +192,7 @@ class SimdBaseTest : public ::testing::Test
         std::pair<real, real>  range_;        //!< Range for math function tests.
 };
 
-}      // namespace
-}      // namespace
+}      // namespace test
+}      // namespace gmx
 
 #endif // GMX_SIMD_TESTS_BASE_H
index 2b3f9f9e6a0d42f8b0845e86f2aa7e0b238c1f63..9ae28508eb3ccdda04c4a6c20e5f9780765a10e4 100644 (file)
@@ -333,6 +333,6 @@ TEST(SimdScalarTest, cvtIB2B)
 /*! \} */
 /*! \endcond internal */
 
-}      // namespace anonymous
-}      // namespace test
-}      // namespace gmx
+}  // namespace
+}  // namespace test
+}  // namespace gmx
index df297937b31de69ed0f53dba5f2169d0e32b949f..8ce6a3d519173754c04fb7ba63685d2655066e1e 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2014,2015,2016,2017, by the GROMACS development team, led by
+ * Copyright (c) 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.
@@ -408,6 +408,6 @@ TEST(SimdScalarMathTest, pmePotentialCorrectionSingleAccuracy)
 /*! \} */
 /*! \endcond internal */
 
-}      // namespace anonymous
-}      // namespace test
-}      // namespace gmx
+}  // namespace
+}  // namespace test
+}  // namespace gmx
index 76e64c78a80825e9d25defd15a5519384171392f..a234d48fdbca2542cb12ce704438b46a44a95370 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2014,2015,2016,2017, by the GROMACS development team, led by
+ * Copyright (c) 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.
@@ -220,6 +220,6 @@ TEST(SimdScalarUtilTest, reduceIncr4ReturnSum)
 /*! \} */
 /*! \endcond internal */
 
-}      // namespace anonymous
-}      // namespace test
-}      // namespace gmx
+}  // namespace
+}  // namespace test
+}  // namespace gmx
index 8655f64dcd5c381adc22cc040e8d91ee007a68d8..77a91e79007e732673846b81718c0873e97972a3 100644 (file)
@@ -267,7 +267,7 @@ SimdTest::compareSimdEq(const char *  refExpr,      const char *  tstExpr,
 /*! \} */
 /*! \endcond */
 
-}      // namespace
-}      // namespace
+}      // namespace test
+}      // namespace gmx
 
 #endif // GMX_SIMD
index 60fb2ba2e86d58651a72c57968e54c41c8accb0b..8c0ecbd96bc594d745c3c0c94b3e544f4cc7e699 100644 (file)
@@ -305,8 +305,8 @@ SimdInt32   setSimdIntFrom1I(int value);
 /*! \} */
 /*! \endcond */
 
-}      // namespace
-}      // namespace
+}      // namespace test
+}      // namespace gmx
 
 #endif // GMX_SIMD
 
index 86858d67b88f765da4752d8b21536e6dc1e1014e..fa98e148280cfa1041a122f1065cbbda829a0812 100644 (file)
@@ -146,7 +146,7 @@ Simd4Test::compareSimd4RealEq(const char * refExpr, const char * tstExpr,
 /*! \} */
 /*! \endcond */
 
-}      // namespace
-}      // namespace
+}      // namespace test
+}      // namespace gmx
 
 #endif // GMX_SIMD
index b7971035ddf6fb63d2d542f63a76143acdbf91fd..bee86fd9691b3d9737479a9eddb39eec1d454257 100644 (file)
@@ -181,8 +181,8 @@ Simd4Real   setSimd4RealFrom1R(real value);
 /*! \} */
 /*! \endcond */
 
-}      // namespace
-}      // namespace
+}      // namespace test
+}      // namespace gmx
 
 #endif // GMX_SIMD
 
index 451dadd7dcc90636370a8cfe6c0eefa55c500305..007b25e0faa0bf98366a7536a3ad64b0341d36a9 100644 (file)
@@ -354,7 +354,7 @@ TEST_F(Simd4FloatingpointTest, transpose)
 /*! \endcond */
 
 }      // namespace
-}      // namespace
-}      // namespace
+}      // namespace test
+}      // namespace gmx
 
 #endif // GMX_SIMD
index 989eca28000583f4f4f32e178284f1a4e947b177..5ae601e32a952c6722b5b610996512b98547db8e 100644 (file)
@@ -223,7 +223,7 @@ TEST_F(Simd4MathTest, invsqrtSingleaccuracy)
 /*! \} */
 /*! \endcond */
 
-}      // namespace
-}      // namespace
+}      // namespace test
+}      // namespace gmx
 
 #endif // GMX_SIMD
index 97ae2d2d1ffadb382528c99a8bc0ee893483e44f..60653ecbc0866f2bf4ede8da2ee21a8b60d66eeb 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2014,2015,2017, by the GROMACS development team, led by
+ * Copyright (c) 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.
@@ -79,7 +79,7 @@ TEST_F(Simd4VectorOperationsTest, norm2)
 /*! \endcond */
 
 }      // namespace
-}      // namespace
-}      // namespace
+}      // namespace test
+}      // namespace gmx
 
 #endif // GMX_SIMD
index 825df83b6fdd07565eb5d5126a287b0681f6ae92..d92cabf9946036eb7d009790bf72cdede3e12b21 100644 (file)
@@ -526,7 +526,7 @@ TEST_F(SimdFloatingpointTest, cvtDouble2Float)
 /*! \endcond */
 
 }      // namespace
-}      // namespace
-}      // namespace
+}      // namespace test
+}      // namespace gmx
 
 #endif // GMX_SIMD
index a957201707558482654eba9faa837c9bf9862b15..72912172a33f97575d5d9c98a71024aadc84006c 100644 (file)
@@ -991,6 +991,6 @@ TEST_F(SimdFloatingpointUtilTest, loadU4NOffset)
 /*! \} */
 /*! \endcond */
 
-}      // namespace
-}      // namespace
-}      // namespace
+}  // namespace
+}  // namespace test
+}  // namespace gmx
index b2a99ecd780ab7853a74ac09aa1ac2ce9d29a7d1..0f1e06496ae58d1c012c2c27cd9f2b7a26b78d8a 100644 (file)
@@ -314,7 +314,7 @@ TEST_F(SimdIntegerTest, cvtIB2B)
 /*! \endcond */
 
 }      // namespace
-}      // namespace
-}      // namespace
+}      // namespace test
+}      // namespace gmx
 
 #endif // GMX_SIMD
index a62d893a9a86029dddf6d509ea84df77e743ab38..8fa8733a66def50859d0dfa49271156453572ba0 100644 (file)
@@ -986,7 +986,7 @@ TEST_F(SimdMathTest, pmePotentialCorrectionSingleAccuracy)
 /*! \} */
 /*! \endcond */
 
-}      // namespace
-}      // namespace
+}      // namespace test
+}      // namespace gmx
 
 #endif // GMX_SIMD
index 147493db016fffc0e422d02a7d3a09311ab385ec..9229e32922a0c1c1acd40af5eb051b3be638bd9b 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2014,2015,2017, by the GROMACS development team, led by
+ * Copyright (c) 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.
@@ -125,7 +125,7 @@ TEST_F(SimdVectorOperationsTest, cprod)
 /*! \endcond */
 
 }      // namespace
-}      // namespace
-}      // namespace
+}      // namespace test
+}      // namespace gmx
 
 #endif // GMX_SIMD
index da94daf08cd2e61cf329938a86f5569d6158b419..e49007e506f3b9ba7735db51c1c24c82cac0c646 100644 (file)
@@ -298,7 +298,7 @@ fillSingleCubicSplineTableData(ArrayRef<const double>                 function,
 
 }
 
-}   // namespace anonymous
+}   // namespace
 
 
 
index de4487ad985b4522026bde5c1bfe06d8c58b4c86..979c146704dd114ac7b563022fa48b60287a87b6 100644 (file)
@@ -261,7 +261,7 @@ fillDdfzTableData(const std::vector<real>    &functionTableData,
     }
 }
 
-}   // namespace anonymous
+}   // namespace
 
 
 
index 8f8725c53c089766e14c3a5ba9e04cf3ccc1090e..a866b8816f98b164855bee38bd756c425d9aad50 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2016,2017, by the GROMACS development team, led by
+ * Copyright (c) 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.
@@ -58,6 +58,7 @@ namespace gmx
 struct
 AnalyticalSplineTableInput
 {
+    //NOLINTNEXTLINE(google-runtime-member-string-references)
     const std::string                    &desc;        //!< \libinternal Brief description of function
     std::function<double(double)>         function;    //!< \libinternal Analytical form of function
     std::function<double(double)>         derivative;  //!< \libinternal Analytical derivative
@@ -68,6 +69,7 @@ AnalyticalSplineTableInput
 struct
 NumericalSplineTableInput
 {
+    //NOLINTNEXTLINE(google-runtime-member-string-references)
     const std::string                    &desc;        //!< \libinternal Brief description of function
     ArrayRef<const double>                function;    //!< \libinternal Vector with function values
     ArrayRef<const double>                derivative;  //!< \libinternal Vector with derivative values
index 94e7274552c35785379e00d54fad57c1d0a70736..4e7691bc63651783db3d403a3163ecea661d33c6 100644 (file)
@@ -408,4 +408,4 @@ bool decideWhetherToUseGpusForPme(const bool              useGpuForNonbonded,
     return false;
 }
 
-} // namespace
+}  // namespace gmx
index 694024202b282a47044e6f3cc258130b81f6947f..0730d52b9a0e13d586760055d88cb1b9b3454fee 100644 (file)
@@ -186,6 +186,6 @@ bool decideWhetherToUseGpusForPme(bool                    useGpuForNonbonded,
                                   int                     numPmeRanksPerSimulation,
                                   bool                    gpusWereDetected);
 
-}
+}  // namespace gmx
 
 #endif
index ea19040a7ce0d86c386793592223120e79b86559..10716733ff78112967bd415d1f43665e6c93748a 100644 (file)
@@ -219,4 +219,4 @@ findAllGpuTasksOnThisNode(ArrayRef<const GpuTask>         gpuTasksOnThisRank,
     return gpuTasksOnRanksOfThisNode;
 }
 
-} // namespace
+}  // namespace gmx
index 6c84f8b6d6a2939cef4d4a2fbe4c9be3891893e6..090c1c800bc8c714e5b7da5174debaba02765123 100644 (file)
@@ -60,6 +60,6 @@ GpuTasksOnRanks
 findAllGpuTasksOnThisNode(ArrayRef<const GpuTask>         gpuTasksOnThisRank,
                           const PhysicalNodeCommunicator &physicalNodeComm);
 
-} // namespace
+}  // namespace gmx
 
 #endif
index e3daa7ea41e96573f7283c11c54f68febf7f4946..e1cb200375a28e241d46d1c0c7f2ffe1df85af80 100644 (file)
@@ -139,4 +139,4 @@ reportGpuUsage(const MDLogger                &mdlog,
     GMX_LOG(mdlog.warning).appendText(output);
 }
 
-} // namespace
+}  // namespace gmx
index 8fba70b5608a271c80415f877bb30a550b2aa524..400cdeb165d34c7a268de0066bf788a6b9ba64fa 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2017, by the GROMACS development team, led by
+ * Copyright (c) 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.
@@ -78,6 +78,6 @@ reportGpuUsage(const MDLogger                &mdlog,
                bool                           bPrintHostName);
 
 
-} // namespace
+}  // namespace gmx
 
 #endif
index ab1436759a876641d6deae33e522e54c08c7da43..ad7a544e49d348ee8246e124d621e4b9df637081 100644 (file)
@@ -946,4 +946,4 @@ void checkHardwareOversubscription(int                             numThreadsOnT
     }
 }
 
-} // namespace
+}  // namespace gmx
index 5fcc64e6e40cf1f8d939c5aa0512ddb04e6dab7a..5ff290eabcad5f65cb6fdb67299316cd324ee0c7 100644 (file)
@@ -130,6 +130,6 @@ void checkHardwareOversubscription(int                             numThreadsOnT
                                    const PhysicalNodeCommunicator &comm,
                                    const MDLogger                 &mdlog);
 
-} // namespace
+}  // namespace gmx
 
 #endif
index 5749d437e36f698393510e8644bf97171ce8769c..136587e3cb92ae5613351f8dc62bf3bc40634ffc 100644 (file)
@@ -325,4 +325,4 @@ runTaskAssignment(const std::vector<int>         &gpuIdsToUse,
     // would require communication.
 }
 
-} // namespace
+}  // namespace gmx
index c6217a8b03e9cfe73eab141fee5c0528ce0b823a..7c8250a5645691da8d6afdd278967e3ee172ff27 100644 (file)
@@ -131,6 +131,6 @@ bool hasTaskType(const GpuTaskMapping &mapping)
     return mapping.task_ == TaskType;
 }
 
-} // namespace
+}  // namespace gmx
 
 #endif
index c4756770dd7b5fabed710260dc44dab661ff48ec..066336746cc863a5fec6c5bee131b1168ffd9a78 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2017, by the GROMACS development team, led by
+ * Copyright (c) 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.
@@ -138,5 +138,5 @@ TEST(GpuIdStringHandlingTest, InvalidInputsThrow)
 }
 
 } // namespace
-} // namespace
-} // namespace
+} // namespace test
+} // namespace gmx
index e3e06e0677b8a09b40188246ed1fa3370cd97a4d..78ed11a45a8232be14ef556fad2d2c938053cff9 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2017, by the GROMACS development team, led by
+ * Copyright (c) 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.
@@ -157,4 +157,4 @@ void checkUserGpuIds(const gmx_gpu_info_t   &gpu_info,
     }
 }
 
-} // namespace
+}  // namespace gmx
index 006e6b283ebfbdf7d4a199d0a47bc90cf7c323df..fa362bd73015114b0fd60af26d0240de68324fc5 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2017, by the GROMACS development team, led by
+ * Copyright (c) 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.
@@ -135,6 +135,6 @@ void checkUserGpuIds(const gmx_gpu_info_t   &gpu_info,
                      const std::vector<int> &compatibleGpus,
                      const std::vector<int> &gpuIds);
 
-} // namespace
+}  // namespace gmx
 
 #endif
index e07003a90b5e49a1ba286570c41322bf81070613..10d30e192a7ff87f53d9e0f7947cc3e0ff79f9be 100644 (file)
@@ -184,7 +184,7 @@ class RangePartitioning
         std::vector<int> index_ = { 0 }; /**< The list of block begin/end indices */
 };
 
-}      // nsamespace gmx
+}  // namespace gmx
 
 /* Deprecated, C-style version of RangePartitioning */
 typedef struct t_block
index ba76ee0a81d45cb087f999a764bb60c3c3220925..3ef6c4f70ee0ef3323f6f055a69a1f277737fdd3 100644 (file)
@@ -98,4 +98,4 @@ EnergyFrame::MapConstIterator EnergyFrame::find(const std::string &key) const
     return values_.find(key);
 }
 
-} // namespace
+}  // namespace gmx
index c83453fbb023e0486515a1ef3423bcf787714af0..0819a8eccfc66dcc0cf37bac22fa51da48129117 100644 (file)
@@ -112,6 +112,6 @@ class EnergyFrame
         double       time_;
 };
 
-} // namespace
+}  // namespace gmx
 
 #endif
index 24b81c73560306575729a2a3428cd36e5d6c9d68..6b40390679215d47813b08cce48c1e63e0eb79b7 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2011,2012,2013,2014, by the GROMACS development team, led by
+ * Copyright (c) 2011,2012,2013,2014,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.
@@ -60,6 +60,6 @@ class AngleInfo
 
 } // namespace analysismodules
 
-} // namespace gmxana
+} // namespace gmx
 
 #endif
index 72ed81be660abf6e9d10d80080d7905fb5bef479..eda82a763555df7128aacaeb815c320daddcc9ad 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2017, by the GROMACS development team, led by
+ * Copyright (c) 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.
@@ -151,6 +151,6 @@ TEST_F(ClustsizeTest, MolCSize)
 
 } // namespace
 
-} // namespace
+} // namespace test
 
-} // namespace
+} // namespace gmx
index 0812235611572b35479434d8400f58820f308af1..51e748ef3c9704786100a977604e79ad8392962e 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2010,2011,2012,2013,2014,2015,2017, by the GROMACS development team, led by
+ * Copyright (c) 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.
@@ -180,7 +180,7 @@ SelectionTester::writeOutput()
 {
 }
 
-}
+}  // namespace gmx
 
 /*! \internal \brief
  * The main function for the selection testing tool.
index 343482a115027d65185aea021fd99a04246799f6..90a90ff48012061b6f56bc88fa8fba04c2ec42b7 100644 (file)
@@ -827,4 +827,4 @@ std::string getCoolQuote()
     }
 }
 
-} // namespace
+}  // namespace gmx
index d1ce03149c5bf9f36e2a279d3d14ef75873a15b0..64b0713d5c39fbd6cb57ef3bd705ccf09bf85852 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2017, by the GROMACS development team, led by
+ * Copyright (c) 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.
@@ -72,4 +72,4 @@ void niceHeader(TextWriter *writer, const char *fn, char commentChar)
     writer->writeLine(formatString("%c", commentChar));
 }
 
-} // namespace
+}  // namespace gmx
index fb72ca82ca60471d957eed31075c307b5f5deb83..e93e0de92854e6fcf14fe5bb9de1e6917278cbc4 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2017, by the GROMACS development team, led by
+ * Copyright (c) 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.
@@ -57,6 +57,6 @@ class TextWriter;
  * \throws     std::bad_alloc if out of memory. */
 void niceHeader(TextWriter *writer, const char *fn, char commentChar);
 
-} // namespace
+}  // namespace gmx
 
 #endif
index 6c912add49a9217f272d2d2831d7ed85c883b5d6..703f5d5643b4f13dd02513f2f3074edfb976a4be 100644 (file)
@@ -124,4 +124,4 @@ void PhysicalNodeCommunicator::barrier() const
 #endif
 }
 
-} // namespace
+}  // namespace gmx
index f6d74055e8b0d4cc6dc4d94d46391829f17f4b92..a85d987750e6e39b6ed8775b58cfa75d1b8e1cb6 100644 (file)
@@ -84,6 +84,6 @@ class PhysicalNodeCommunicator
         void barrier() const;
 };
 
-} // namespace
+}  // namespace gmx
 
 #endif
index 1982c1a874c80cd9b0c5a4afbf736730b93a43f2..aa77d1f29d4da33e4e7d2cbfe28f0af74236d83e 100644 (file)
@@ -123,7 +123,7 @@ TYPED_TEST(AllocatorTest, VectorAllocatesAndReservesWithAlignment) //NOLINT(misc
     }
 }
 
-} // namespace
-} // namespace
+}  // namespace test
+}  // namespace gmx
 
 #endif
index 11a695336f61262feb7242c12c7c085e360ed0d4..e188dcb8d08d661cae1e2e2a0de04b2ca3ed4700 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2015,2017, by the GROMACS development team, led by
+ * Copyright (c) 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,8 +66,8 @@ using AllocatorTypesToTest = ::testing::Types<AlignedAllocator<real>,
 
 TYPED_TEST_CASE(AllocatorTest, AllocatorTypesToTest);
 
-} // namespace
-} // namespace
+}  // namespace test
+}  // namespace gmx
 
 // Includes tests common to all allocation policies.
 #include "gromacs/utility/tests/alignedallocator-impl.h"
@@ -84,5 +84,5 @@ TYPED_TEST(AllocatorTest, StatelessAllocatorUsesNoMemory)
               sizeof(std::vector<value_type, TypeParam>));
 }
 
-} // namespace
-} // namespace
+}  // namespace test
+}  // namespace gmx
index 99153f5b5d8480f8a2b7f2e29a3cc38f9b2b689b..47dddfb5a7d8abc778a63676c673a12651a835a7 100644 (file)
@@ -268,4 +268,4 @@ TEST(DISABLED_ArrayRefTest, GenericTests)
 
 }      // namespace
 
-}      // namespace
+}      // namespace gmx
index 697bf13eb6829fbbde08dabbbdf996c2c6f437e9..95d6495474ffae4e2dd811188d11b0f891961ad0 100644 (file)
@@ -118,5 +118,5 @@ TEST(RegexBasicTest, MatchesForCharacterClassesWorkWhenSupported)
 }
 
 } // namespace
-} // namespace
-} // namespace
+} // namespace test
+} // namespace gmx
index 2cc6990c152573ec82bf0a55979ac35e1ce6e1f8..cc3b8901348f519bdec92127a5380b6033c5bf95 100644 (file)
@@ -240,5 +240,5 @@ TEST(MutexTaskTest, MutualExclusionWorksWithTryLockOnSameThread)
 }
 
 } // namespace
-} // namespace
-} // namespace
+} // namespace test
+} // namespace gmx
index 5260a4b5162b23b41a13a1066331f5f1e8ecd92c..b88421aca73de44cfe9489f3c11d976db9de98f6 100644 (file)
@@ -61,4 +61,4 @@ TEST(PhysicalNodeCommunicatorTest, CanCallBarrier)
 }
 
 } // namespace
-} // namespace
+} // namespace gmx
index 86ed2ebc2eb50e189e1bf2f764796bf91772d4b0..275a1761657e21b5361015a215567343b837f6f4 100644 (file)
@@ -59,4 +59,4 @@ TEST(PhysicalNodeCommunicatorTest, CanCallBarrier)
 }
 
 } // namespace
-} // namespace
+} // namespace gmx
index 621544f6427a61f090d4f04f81dc015913d6fee9..0fea8f8fd9d40f1bd35603364001d9e4c0e36660 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2012,2014,2015,2016,2017, by the GROMACS development team, led by
+ * Copyright (c) 2012,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.
@@ -432,5 +432,5 @@ TEST_F(TextLineWrapperTest, WrapsCorrectlyWithExtraWhitespace)
 }
 
 } // namespace
-} // namespace
-} // namespace
+} // namespace test
+} // namespace gmx
index aa1b3e8b5f7096872b330c83978782983a7c739d..5f24ff663393c40519a9ca18a8845d8ea0908a1c 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2017, by the GROMACS development team, led by
+ * Copyright (c) 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.
@@ -276,5 +276,5 @@ INSTANTIATE_TEST_CASE_P(ParsesLinesDifferently, TextReaderTest,
                                               ));
 
 } // namespace
-} // namespace
-} // namespace
+} // namespace test
+} // namespace gmx
index d6c8abd187f511d7757a93e6fa7d8dd2c7d75ad5..31e6cfcbef9b3299d49e1079bb9775c2a0c1211d 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2017, by the GROMACS development team, led by
+ * Copyright (c) 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.
@@ -50,4 +50,4 @@ TEST(TypeTraitsTest, IsIntegralConstant)
     EXPECT_TRUE((isIntegralConstant<std::integral_constant<long, 5>, long>::value));
 }
 }
-}
+}  // namespace gmx
index 1d56da89b96de64c5a7acc62cbf95f49981fbdf5..ae214d59a57995393b4040c9439f9ea2069e2e05 100644 (file)
@@ -525,4 +525,4 @@ int Mdrunner::mainFunction(int argc, char *argv[])
     return rc;
 }
 
-} // namespace
+}  // namespace gmx
index 2fe371aa6dca23b5da8e9aabe1a9292670023bf4..babe81bf9315f441589094b1e8fb0b76747bdafd 100644 (file)
@@ -75,5 +75,5 @@ void compareEnergyFrames(const EnergyFrame      &reference,
     }
 }
 
-} // namespace
-} // namespace
+}  // namespace test
+}  // namespace gmx
index a8522cc92c0fd56914d3c83b845fe82b9f8ab6ed..b6e0aa51ef34e1335cc8f6064c3ef1ab62bec056 100644 (file)
@@ -68,7 +68,7 @@ void compareEnergyFrames(const EnergyFrame      &reference,
                          const EnergyFrame      &test,
                          const EnergyTolerances &tolerances);
 
-} // namespace
-} // namespace
+}  // namespace test
+}  // namespace gmx
 
 #endif
index 91a742424ff37c4ff6e709aa5e3477e8926859ae..eb4d9d72a88eaa04dad4679f67b672a205c8b849 100644 (file)
@@ -194,5 +194,5 @@ EnergyFrameReader::frame()
     return EnergyFrame(*enxframeGuard_.get(), indicesOfEnergyFields_);
 }
 
-} // namespace
-} // namespace
+}  // namespace test
+}  // namespace gmx
index 7a2590055408666a039cb0aa79b4bcb7645e1a59..1191852c06ee38128aaec1a5fe41008f54e7c7f2 100644 (file)
@@ -154,7 +154,7 @@ class EnergyFrameReader
         GMX_DISALLOW_COPY_AND_ASSIGN(EnergyFrameReader);
 };
 
-} // namespace
-} // namespace
+}  // namespace test
+}  // namespace gmx
 
 #endif
index 9b3e4c1afe4cfab01d570a950c329f36650e6209..d76d6cd18722fc942c10b71d8791b25c71952b05 100644 (file)
@@ -128,6 +128,6 @@ const EnergyIntegratorType c_integratorsToTest [] = {"md", "md-vv", "md-vv-avek"
 
 INSTANTIATE_TEST_CASE_P(Checking, InitialConstraintsTest, ::testing::ValuesIn(c_integratorsToTest));
 
-}
-}
-}
+}  // namespace
+}  // namespace test
+}  // namespace gmx
index aeed2e7cf340fc7a15d2414ee25bfd66ab4ac964..e0aa9973ccc0f15019a5e45403b3ffa108182794 100644 (file)
@@ -89,7 +89,7 @@ GMX_TEST_OPTIONS(MdrunTestOptions, options)
 }
 //! \endcond
 
-}
+}       // namespace
 
 SimulationRunner::SimulationRunner(TestFileManager *fileManager) :
     mdpOutputFileName_(fileManager->getTemporaryFilePath("output.mdp")),
index 386474de9dc6a620bc0e2c10f307aa0dae1c9fce..315e9b97d2b8ad97dbee244075e52111b86b2bd6 100644 (file)
@@ -115,5 +115,5 @@ TEST_F(MultiSimTerminationTest, WritesCheckpointAfterMaxhTerminationAndThenResta
     runMaxhTest();
 }
 
-} // namespace
-} // namespace
+}  // namespace test
+}  // namespace gmx
index add40e2a6debf27e5d4b4e949d953c41da822a29..1ffedbddc151eca2e533eddacf990d49c3ec6d19 100644 (file)
@@ -169,5 +169,5 @@ void MultiSimTest::runMaxhTest()
     helper.runSecondMdrun();
 }
 
-} // namespace
-} // namespace
+}  // namespace test
+}  // namespace gmx
index 5633f834db693a30405776b598176c348a46b8a4..96d7f7ea21ae9c231bce1795c3032c71039303c6 100644 (file)
@@ -107,7 +107,7 @@ class MultiSimTest : public ::testing::Test,
         TestFileManager    fileManager_;
 };
 
-} // namespace
-} // namespace
+}  // namespace test
+}  // namespace gmx
 
 #endif
index 287ebe9d2ee64d18bd629c251ee24525d2f2ad7c..4a97813c5e013795789196aac5a4684a705e740e 100644 (file)
@@ -249,6 +249,6 @@ TEST_F(PmeTest, ScalesTheBox)
     runTest(runModes);
 }
 
-}
-}
-}
+}  // namespace
+}  // namespace test
+}  // namespace gmx
index 370bc7bf952f7f338b91ff3de4d72bbbfbe9ca07..14a72b00e4a8d38faf2275c2094439d04375dd2b 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2013,2014,2015,2016, by the GROMACS development team, led by
+ * Copyright (c) 2013,2014,2015,2016,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.
@@ -86,5 +86,5 @@ TEST_F(ReplicaExchangeTerminationTest, WritesCheckpointAfterMaxhTerminationAndTh
     runMaxhTest();
 }
 
-} // namespace
-} // namespace
+}  // namespace test
+}  // namespace gmx
index 794b342666b25122fb19a3194e0cdcc7205fdce1..3bd8ec8e75d2c4aba6cd44113d345d919d67c1ad 100644 (file)
@@ -204,6 +204,6 @@ TEST_F(BondedInteractionsTest, TabulatedDihedralWorks)
     checkMdrun();
 }
 
-} // namespace
+}  // namespace test
 
-} // namespace
+}  // namespace gmx
index bce57464a115833eea6b94f4945ac74986548585..3b289ef53ec3f7d517825301add7b94bce50f8c3 100644 (file)
@@ -94,5 +94,5 @@ TEST_F(MdrunTerminationTest, CheckpointRestartWorksWithNoAppend)
     helper.runSecondMdrunWithNoAppend();
 }
 
-} // namespace
-} // namespace
+}  // namespace test
+}  // namespace gmx
index 34c6225437b6ec9d4e2d80be5b98b1786a02413d..8f2dbc42577637dea168c5549b82503bbcbdca97 100644 (file)
@@ -93,5 +93,5 @@ void TerminationHelper::runSecondMdrunWithNoAppend()
     ASSERT_EQ(0, runner_->callMdrun(secondPart));
 }
 
-} // namespace
-} // namespace
+}  // namespace test
+}  // namespace gmx
index e9c1a8e13098c619adffd75f6daf8a42c529bc57..5acde75894ce834c1e3e9fdc04f913d6a68da70d 100644 (file)
@@ -93,7 +93,7 @@ class TerminationHelper
         SimulationRunner *runner_;
 };
 
-} // namespace
-} // namespace
+}  // namespace test
+}  // namespace gmx
 
 #endif
index db16d0c93b2ee11a5f42b512759b8e8371452678..e3dc3115f9e349b93c026503708be9c71d96eb53 100644 (file)
@@ -141,6 +141,6 @@ TEST_P(TpiTest, ReproducesOutput)
 
 INSTANTIATE_TEST_CASE_P(Simple, TpiTest, ::testing::Values(1993, 2994));
 
-}
-}
-}
+}  // namespace
+}  // namespace test
+}  // namespace gmx
index e6905b206795a6668150021acaa8ffa4f3ee6415..b11433b05dbb73e3fb9d3bb472aff734d6ef09a4 100644 (file)
@@ -209,5 +209,5 @@ void compareTrajectoryFrames(const TrajectoryFrame              &reference,
     compareForces(reference, test, matchSettings, tolerances.forces);
 }
 
-} // namespace
-} // namespace
+}  // namespace test
+}  // namespace gmx
index cfa018ccc866de3087ec3a8cf451de20369367d8..be416d5c6d49f87c987bb0dfec66ceaa697c08f8 100644 (file)
@@ -106,7 +106,7 @@ void compareTrajectoryFrames(const TrajectoryFrame              &reference,
                              const TrajectoryFrameMatchSettings &matchSettings,
                              const TrajectoryTolerances         &tolerances);
 
-} // namespace
-} // namespace
+}  // namespace test
+}  // namespace gmx
 
 #endif
index cf43cf89ee574ff324889daf95e2aa9b036d1011..cf282fdf40e938e47e1f5080683a02a601bde6d9 100644 (file)
@@ -156,5 +156,5 @@ TrajectoryFrameReader::frame()
     return TrajectoryFrame(*trxframeGuard_.get());
 }
 
-} // namespace
-} // namespace
+}  // namespace test
+}  // namespace gmx
index 9de1f9e47eccb33400e6a393c12166db8feb94ac..d5fbdac103f462bd8a39ac904a58e1e987bec8da 100644 (file)
@@ -136,7 +136,7 @@ class TrajectoryFrameReader
 //! Convenience smart pointer typedef
 typedef std::unique_ptr<TrajectoryFrameReader> TrajectoryFrameReaderPtr;
 
-} // namespace
-} // namespace
+}  // namespace test
+}  // namespace gmx
 
 #endif
index c7990838d420ada60beadb9f01b5b63ed11f5af9..f68d401ffe197d36792cfdbaeb35d5e932229f49 100644 (file)
@@ -79,7 +79,7 @@ GMX_TEST_OPTIONS(ExceptionOptions, options)
                                         "exceptions"));
 }
 //! \endcond
-}
+}       // namespace
 
 namespace internal
 {
index 8e6b2e4d9760575fe671a55938f2696d8b13f136..2267c3ed974b82f2431b2b56c435ec711381ab57 100644 (file)
@@ -79,7 +79,7 @@ namespace internal
  */
 void processExpectedException(const std::exception &ex);
 //! \endcond
-}
+}       // namespace internal
 
 //! \libinternal \addtogroup module_testutils
 //! \{
index 67a79975d52617b4d2591dc1bbc208af5834377e..2644274c22847d98021fdd68131ac3fa0e43f898 100644 (file)
@@ -172,5 +172,5 @@ RVecEq(const FloatingPointTolerance &tolerance)
     return testing::MakeMatcher(new RVecMatcher<real>(tolerance));
 }
 
-} // namespace
-} // namespace
+}  // namespace test
+}  // namespace gmx
index c78d3e960cb6b5e901bf265d43e22a3095a3af29..0394d2b91459a47b7058c0b012cd061e08e86d48 100644 (file)
@@ -102,7 +102,7 @@ RealEq(const FloatingPointTolerance &tolerance);
 testing::Matcher < std::tuple < RVec, RVec>>
 RVecEq(const FloatingPointTolerance &tolerance);
 
-} // namespace
-} // namespace
+}  // namespace test
+}  // namespace gmx
 
 #endif