Apply clang-format-11
authorMark Abraham <mark.j.abraham@gmail.com>
Mon, 10 May 2021 13:36:44 +0000 (15:36 +0200)
committerMark Abraham <mark.j.abraham@gmail.com>
Tue, 11 May 2021 06:28:14 +0000 (06:28 +0000)
This is better than slowly dribbling changes all over the
code base

275 files changed:
api/gmxapi/cpp/session.cpp
api/gmxapi/cpp/system.cpp
api/legacy/include/gromacs/utility/gmxassert.h
api/legacy/include/gromacs/utility/listoflists.h
api/legacy/include/gromacs/utility/real.h
api/nblib/gmxsetup.cpp
api/nblib/listed_forces/bondtypes.h
api/nblib/molecules.h
api/nblib/simulationstate.cpp
api/nblib/tests/testsystems.cpp
api/nblib/topology.cpp
src/gromacs/analysisdata/arraydata.cpp
src/gromacs/analysisdata/dataframe.cpp
src/gromacs/analysisdata/dataframe.h
src/gromacs/analysisdata/datamodulemanager.cpp
src/gromacs/analysisdata/dataproxy.cpp
src/gromacs/analysisdata/datastorage.cpp
src/gromacs/analysisdata/framelocaldata.h
src/gromacs/analysisdata/modules/histogram.cpp
src/gromacs/analysisdata/modules/plot.cpp
src/gromacs/analysisdata/tests/datatest.cpp
src/gromacs/analysisdata/tests/mock_datamodule.cpp
src/gromacs/applied_forces/awh/awh.cpp
src/gromacs/applied_forces/awh/awh.h
src/gromacs/applied_forces/awh/biasgrid.cpp
src/gromacs/applied_forces/awh/biasparams.h
src/gromacs/applied_forces/awh/biaswriter.cpp
src/gromacs/applied_forces/awh/correlationgrid.cpp
src/gromacs/applied_forces/awh/dimparams.h
src/gromacs/applied_forces/awh/tests/awh_setup.h
src/gromacs/applied_forces/densityfitting/densityfittingamplitudelookup.cpp
src/gromacs/applied_forces/densityfitting/densityfittingforceprovider.cpp
src/gromacs/commandline/cmdlinehelpcontext.cpp
src/gromacs/commandline/cmdlinehelpmodule.cpp
src/gromacs/commandline/cmdlinehelpwriter.cpp
src/gromacs/commandline/cmdlinemodulemanager_impl.h
src/gromacs/commandline/cmdlineoptionsmodule.cpp
src/gromacs/commandline/cmdlineparser.cpp
src/gromacs/commandline/cmdlineprogramcontext.cpp
src/gromacs/commandline/pargs.cpp
src/gromacs/commandline/pargs.h
src/gromacs/commandline/tests/cmdlinemodulemanagertest.cpp
src/gromacs/commandline/tests/cmdlineparser.cpp
src/gromacs/coordinateio/coordinatefile.h
src/gromacs/coordinateio/outputadapters/setatoms.h
src/gromacs/coordinateio/outputadapters/setstarttime.h
src/gromacs/coordinateio/outputadapters/settimestep.h
src/gromacs/domdec/dlbtiming.cpp
src/gromacs/domdec/domdec.cpp
src/gromacs/domdec/domdec_network.cpp
src/gromacs/domdec/domdec_specatomcomm.cpp
src/gromacs/domdec/ga2la.h
src/gromacs/essentialdynamics/edsam.cpp
src/gromacs/ewald/pme.cpp
src/gromacs/ewald/pme_coordinate_receiver_gpu_impl.cu
src/gromacs/ewald/pme_force_sender_gpu_impl.cu
src/gromacs/ewald/pme_gather.clh
src/gromacs/ewald/pme_gather.cpp
src/gromacs/ewald/pme_gpu_internal.cpp
src/gromacs/ewald/pme_gpu_types_host_impl.h
src/gromacs/ewald/pme_only.cpp
src/gromacs/ewald/pme_redistribute.cpp
src/gromacs/ewald/tests/pmebsplinetest.cpp
src/gromacs/ewald/tests/pmetestcommon.cpp
src/gromacs/fileio/mrcdensitymap.cpp
src/gromacs/fileio/mrcdensitymapheader.h
src/gromacs/fileio/tests/fileioxdrserializer.cpp
src/gromacs/gmxana/gmx_awh.cpp
src/gromacs/gmxana/gmx_order.cpp
src/gromacs/gmxana/gmx_sham.cpp
src/gromacs/gmxana/gmx_wham.cpp
src/gromacs/gmxlib/nonbonded/nb_free_energy.cpp
src/gromacs/gmxlib/nonbonded/nb_free_energy.h
src/gromacs/gmxpreprocess/gen_vsite.cpp
src/gromacs/gmxpreprocess/genhydro.cpp
src/gromacs/gmxpreprocess/gpp_atomtype.cpp
src/gromacs/gmxpreprocess/vsite_parm.cpp
src/gromacs/gmxpreprocess/x2top.cpp
src/gromacs/gpu_utils/device_context_sycl.cpp
src/gromacs/gpu_utils/device_utils.clh
src/gromacs/gpu_utils/gpuregiontimer_ocl.h
src/gromacs/hardware/cpuinfo.cpp
src/gromacs/hardware/detecthardware.cpp
src/gromacs/hardware/device_management_sycl.cpp
src/gromacs/hardware/hardwaretopology.cpp
src/gromacs/hardware/hardwaretopology.h
src/gromacs/listed_forces/bonded.cpp
src/gromacs/listed_forces/bonded.h
src/gromacs/listed_forces/disre.cpp
src/gromacs/listed_forces/gpubonded_impl.cu
src/gromacs/listed_forces/gpubondedkernels.cu
src/gromacs/listed_forces/tests/pairs.cpp
src/gromacs/math/arrayrefwithpadding.h
src/gromacs/math/coordinatetransformation.cpp
src/gromacs/math/densityfit.cpp
src/gromacs/math/gausstransform.cpp
src/gromacs/math/multidimarray.h
src/gromacs/math/paddedvector.h
src/gromacs/math/tests/neldermead.cpp
src/gromacs/mdlib/boxdeformation.cpp
src/gromacs/mdlib/calc_verletbuf.cpp
src/gromacs/mdlib/coupling.cpp
src/gromacs/mdlib/energyoutput.cpp
src/gromacs/mdlib/expanded.cpp
src/gromacs/mdlib/gmx_omp_nthreads.cpp
src/gromacs/mdlib/groupcoord.cpp
src/gromacs/mdlib/leapfrog_gpu.cu
src/gromacs/mdlib/lincs.cpp
src/gromacs/mdlib/lincs_gpu.cpp
src/gromacs/mdlib/mdatoms.cpp
src/gromacs/mdlib/resethandler.cpp
src/gromacs/mdlib/settle.cpp
src/gromacs/mdlib/settle_gpu.cpp
src/gromacs/mdlib/simulationsignal.cpp
src/gromacs/mdlib/tests/leapfrogtestrunners.cpp
src/gromacs/mdlib/update.cpp
src/gromacs/mdlib/update_constrain_gpu_impl.h
src/gromacs/mdlib/updategroupscog.cpp
src/gromacs/mdrun/md.cpp
src/gromacs/mdrun/runner.cpp
src/gromacs/mdrun/simulationinputhandle.cpp
src/gromacs/mdrun/simulatorbuilder.h
src/gromacs/mdrunutility/threadaffinity.cpp
src/gromacs/mdspan/extents.h
src/gromacs/mdspan/mdspan.h
src/gromacs/mdtypes/forcebuffers.cpp
src/gromacs/mdtypes/forcebuffers.h
src/gromacs/mdtypes/forceoutput.h
src/gromacs/mdtypes/group.cpp
src/gromacs/mdtypes/iforceprovider.h
src/gromacs/mdtypes/interaction_const.h
src/gromacs/mdtypes/swaphistory.h
src/gromacs/modularsimulator/compositesimulatorelement.cpp
src/gromacs/modularsimulator/constraintelement.cpp
src/gromacs/modularsimulator/freeenergyperturbationdata.cpp
src/gromacs/modularsimulator/parrinellorahmanbarostat.cpp
src/gromacs/modularsimulator/propagator.cpp
src/gromacs/modularsimulator/signallers.cpp
src/gromacs/modularsimulator/statepropagatordata.cpp
src/gromacs/modularsimulator/velocityscalingtemperaturecoupling.cpp
src/gromacs/nbnxm/atomdata.cpp
src/gromacs/nbnxm/benchmark/bench_setup.cpp
src/gromacs/nbnxm/cuda/nbnxm_cuda_kernel_utils.cuh
src/gromacs/nbnxm/gpu_data_mgmt.h
src/gromacs/nbnxm/kerneldispatch.cpp
src/gromacs/nbnxm/kernels_reference/kernel_ref_prune.cpp
src/gromacs/nbnxm/kernels_simd_2xmm/kernel_common.h
src/gromacs/nbnxm/kernels_simd_2xmm/kernel_outer.h
src/gromacs/nbnxm/kernels_simd_2xmm/kernel_prune.cpp
src/gromacs/nbnxm/kernels_simd_4xm/kernel_common.h
src/gromacs/nbnxm/kernels_simd_4xm/kernel_outer.h
src/gromacs/nbnxm/kernels_simd_4xm/kernel_prune.cpp
src/gromacs/nbnxm/nbnxm_gpu.h
src/gromacs/nbnxm/nbnxm_setup.cpp
src/gromacs/nbnxm/opencl/nbnxm_ocl_kernel.clh
src/gromacs/nbnxm/opencl/nbnxm_ocl_kernel_pruneonly.clh
src/gromacs/nbnxm/opencl/nbnxm_ocl_kernel_utils.clh
src/gromacs/nbnxm/pairlist_simd_2xmm.h
src/gromacs/nbnxm/pairlist_simd_4xm.h
src/gromacs/nbnxm/pairlist_tuning.cpp
src/gromacs/nbnxm/pairlistwork.h
src/gromacs/nbnxm/pairsearch.cpp
src/gromacs/nbnxm/sycl/nbnxm_sycl_kernel.cpp
src/gromacs/onlinehelp/helpformat.cpp
src/gromacs/onlinehelp/helpwritercontext.cpp
src/gromacs/onlinehelp/tests/mock_helptopic.cpp
src/gromacs/options/abstractoption.h
src/gromacs/options/basicoptions.cpp
src/gromacs/options/basicoptions.h
src/gromacs/options/filenameoption.cpp
src/gromacs/options/optionstoragetemplate.h
src/gromacs/options/repeatingsection.h
src/gromacs/options/treesupport.cpp
src/gromacs/options/valuestore.h
src/gromacs/pbcutil/pbc_aiuc_cuda.cuh
src/gromacs/pbcutil/tests/com.cpp
src/gromacs/pulling/pull.cpp
src/gromacs/pulling/pull_internal.h
src/gromacs/pulling/pull_rotation.cpp
src/gromacs/random/gammadistribution.h
src/gromacs/random/normaldistribution.h
src/gromacs/random/tabulatednormaldistribution.h
src/gromacs/random/uniformintdistribution.h
src/gromacs/restraint/tests/manager.cpp
src/gromacs/selection/nbsearch.cpp
src/gromacs/selection/nbsearch.h
src/gromacs/selection/parsetree.cpp
src/gromacs/selection/parsetree.h
src/gromacs/selection/poscalc.cpp
src/gromacs/selection/selectioncollection.cpp
src/gromacs/selection/selectionenums.h
src/gromacs/selection/selectionoption.h
src/gromacs/selection/selectionoptionbehavior.cpp
src/gromacs/selection/selelem.h
src/gromacs/selection/selhelp.cpp
src/gromacs/selection/selmethod.h
src/gromacs/selection/selvalue.h
src/gromacs/selection/sm_same.cpp
src/gromacs/selection/tests/nbsearch.cpp
src/gromacs/selection/tests/poscalc.cpp
src/gromacs/simd/impl_arm_neon_asimd/impl_arm_neon_asimd_simd_float.h
src/gromacs/simd/impl_arm_neon_asimd/impl_arm_neon_asimd_util_double.h
src/gromacs/simd/impl_arm_neon_asimd/impl_arm_neon_asimd_util_float.h
src/gromacs/simd/impl_arm_sve/impl_arm_sve_simd_float.h
src/gromacs/simd/impl_arm_sve/impl_arm_sve_util_double.h
src/gromacs/simd/impl_arm_sve/impl_arm_sve_util_float.h
src/gromacs/simd/impl_ibm_vsx/impl_ibm_vsx_util_double.h
src/gromacs/simd/impl_ibm_vsx/impl_ibm_vsx_util_float.h
src/gromacs/simd/impl_reference/impl_reference_simd4_double.h
src/gromacs/simd/impl_reference/impl_reference_simd4_float.h
src/gromacs/simd/impl_reference/impl_reference_simd_double.h
src/gromacs/simd/impl_reference/impl_reference_simd_float.h
src/gromacs/simd/impl_reference/impl_reference_util_double.h
src/gromacs/simd/impl_reference/impl_reference_util_float.h
src/gromacs/simd/impl_x86_avx2_256/impl_x86_avx2_256_simd_float.h
src/gromacs/simd/impl_x86_avx_256/impl_x86_avx_256_util_double.h
src/gromacs/simd/impl_x86_avx_256/impl_x86_avx_256_util_float.h
src/gromacs/simd/impl_x86_avx_512/impl_x86_avx_512_util_double.h
src/gromacs/simd/impl_x86_avx_512/impl_x86_avx_512_util_float.h
src/gromacs/simd/impl_x86_sse2/impl_x86_sse2_simd_double.h
src/gromacs/simd/impl_x86_sse2/impl_x86_sse2_simd_float.h
src/gromacs/simd/impl_x86_sse2/impl_x86_sse2_util_double.h
src/gromacs/simd/impl_x86_sse2/impl_x86_sse2_util_float.h
src/gromacs/simd/scalar/scalar.h
src/gromacs/simd/simd_math.h
src/gromacs/simd/tests/base.cpp
src/gromacs/simd/tests/bootstrap_loadstore.cpp
src/gromacs/simd/tests/simd_floatingpoint.cpp
src/gromacs/simd/tests/simd_math.cpp
src/gromacs/simd/vector_operations.h
src/gromacs/swap/swapcoords.cpp
src/gromacs/tables/cubicsplinetable.cpp
src/gromacs/tables/forcetable.cpp
src/gromacs/tables/quadraticsplinetable.cpp
src/gromacs/timing/cyclecounter.cpp
src/gromacs/topology/atomprop.cpp
src/gromacs/topology/idef.cpp
src/gromacs/topology/idef.h
src/gromacs/topology/residuetypes.cpp
src/gromacs/trajectory/energyframe.cpp
src/gromacs/trajectoryanalysis/analysissettings_impl.h
src/gromacs/trajectoryanalysis/cmdlinerunner.cpp
src/gromacs/trajectoryanalysis/modules/angle.cpp
src/gromacs/trajectoryanalysis/modules/msd.cpp
src/gromacs/trajectoryanalysis/modules/sasa.cpp
src/gromacs/trajectoryanalysis/modules/select.cpp
src/gromacs/trajectoryanalysis/tests/moduletest.cpp
src/gromacs/trajectoryanalysis/tests/surfacearea.cpp
src/gromacs/trajectoryanalysis/topologyinformation.cpp
src/gromacs/utility/datafilefinder.h
src/gromacs/utility/directoryenumerator.cpp
src/gromacs/utility/inmemoryserializer.cpp
src/gromacs/utility/keyvaluetree.cpp
src/gromacs/utility/keyvaluetreetransform.cpp
src/gromacs/utility/keyvaluetreetransform.h
src/gromacs/utility/logger.cpp
src/gromacs/utility/loggerbuilder.cpp
src/gromacs/utility/path.h
src/gromacs/utility/stringstream.cpp
src/gromacs/utility/stringutil.cpp
src/gromacs/utility/tests/inmemoryserializer.cpp
src/gromacs/utility/textwriter.cpp
src/programs/mdrun/tests/energycomparison.cpp
src/programs/mdrun/tests/mdruncomparison.h
src/programs/mdrun/tests/multiple_time_stepping.cpp
src/programs/mdrun/tests/terminationhelper.cpp
src/programs/mdrun/tests/trajectorycomparison.cpp
src/programs/view/xdlgitem.h
src/testutils/cmdlinetest.cpp
src/testutils/interactivetest.cpp
src/testutils/mpi_printer.cpp
src/testutils/refdata.cpp
src/testutils/refdata_checkers.h
src/testutils/testinit.cpp
src/testutils/tests/interactivetest.cpp

index 0bccfacf8d6bb2f5ef06d91e715b850ff07e27c8..b2c33dcdb7cd6b0b3d87517f62df7e8e0cf72784 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2018,2020, by the GROMACS development team, led by
+ * Copyright (c) 2018,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.
@@ -350,8 +350,7 @@ std::shared_ptr<Session> launchSession(Context* context, const Workflow& work) n
 SessionImpl::~SessionImpl() = default;
 
 SessionResources::SessionResources(gmxapi::SessionImpl* session, std::string name) :
-    sessionImpl_(session),
-    name_(std::move(name))
+    sessionImpl_(session), name_(std::move(name))
 {
 }
 
index 2a25b842905026ee8c42a1c323b7515da05e55a6..a41c021b78fd6381b24dbf5292e59af26ad5b179 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2018,2020, by the GROMACS development team, led by
+ * Copyright (c) 2018,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.
@@ -117,8 +117,7 @@ System fromTprFile(const std::string& filename)
 }
 
 System::Impl::Impl(std::unique_ptr<gmxapi::Workflow> workflow) noexcept :
-    workflow_(std::move(workflow)),
-    spec_(std::make_shared<MDWorkSpec>())
+    workflow_(std::move(workflow)), spec_(std::make_shared<MDWorkSpec>())
 {
     GMX_ASSERT(workflow_, "Class invariant implies non-null workflow_ member");
     GMX_ASSERT(spec_, "Class invariant implies non-null work specification member.");
index dea2e5eb0d62db5e317ade4c8581ec35d3b0fd74..ec31a945c64c0da417d3bb05915bff381e21bfd7 100644 (file)
@@ -67,7 +67,7 @@
 #        define GMX_RELEASE_ASSERT(condition, msg)                \
             ((void)((condition) ? (void)0                         \
                                 : ::gmx::internal::assertHandler( \
-                                          #condition, msg, GMX_CURRENT_FUNCTION, __FILE__, __LINE__)))
+                                        #condition, msg, GMX_CURRENT_FUNCTION, __FILE__, __LINE__)))
 #    else
 // Use an "immediately invoked function expression" to allow being
 // used in constexpr context with older GCC versions
index 13c14149a5f562e64f5650532acdcf6eda77f89f..48fc0c8fc872cd52f5b971c611dacfac33177391 100644 (file)
@@ -92,8 +92,7 @@ public:
      * \param[in] elements    Elements for all lists concatenated, is consumed
      */
     ListOfLists(std::vector<int>&& listRanges, std::vector<T>&& elements) :
-        listRanges_(std::move(listRanges)),
-        elements_(std::move(elements))
+        listRanges_(std::move(listRanges)), elements_(std::move(elements))
     {
         if (listRanges_.empty() || listRanges_.at(0) != 0)
         {
index 2a959637a195a04ca2ad44f1b9aafff659c8ed93..9ca65626911bb10590f069e7d1d3050d4d6aa26f 100644 (file)
@@ -4,7 +4,7 @@
  * Copyright (c) 1991-2000, University of Groningen, The Netherlands.
  * Copyright (c) 2001-2004, The GROMACS development team.
  * 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.
@@ -74,7 +74,8 @@
  */
 #    define GMX_DOUBLE_NEGZERO                 \
         ({                                     \
-            const union {                      \
+            const union                        \
+            {                                  \
                 int    di[2];                  \
                 double d;                      \
             } _gmx_dzero = { 0, -2147483648 }; \
@@ -82,7 +83,8 @@
         })
 #    define GMX_FLOAT_NEGZERO               \
         ({                                  \
-            const union {                   \
+            const union                     \
+            {                               \
                 int   fi;                   \
                 float f;                    \
             } _gmx_fzero = { -2147483648 }; \
index 3baa358e98d0fbe5393606240f53b8f6ec031bf5..30f14937ee55d59370255eefb6dd09b18564a18c 100644 (file)
@@ -176,7 +176,7 @@ void NbvSetupUtil::setAtomProperties(const std::vector<int>&  particleTypeIdOfAl
 void NbvSetupUtil::setupNbnxmInstance(const size_t numParticleTypes, const NBKernelOptions& options)
 {
     const auto pinPolicy  = (options.useGpu ? gmx::PinningPolicy::PinnedIfSupported
-                                           : gmx::PinningPolicy::CannotBePinned);
+                                            : gmx::PinningPolicy::CannotBePinned);
     const int  numThreads = options.numOpenMPThreads;
     // Note: the options and Nbnxm combination rule enums values should match
     const int combinationRule = static_cast<int>(options.ljCombinationRule);
index 73bdfe2ee96a2d0bbaee51217727247014fbe979..cef684d822506f4e8bce05042aae18d29f7f3d0b 100644 (file)
@@ -150,9 +150,7 @@ struct CubicBondType
 {
     CubicBondType() = default;
     CubicBondType(ForceConstant fq, ForceConstant fc, EquilDistance d) :
-        quadraticForceConstant_(fq),
-        cubicForceConstant_(fc),
-        equilDistance_(d)
+        quadraticForceConstant_(fq), cubicForceConstant_(fc), equilDistance_(d)
     {
     }
 
@@ -191,9 +189,7 @@ class MorseBondType
 public:
     MorseBondType() = default;
     MorseBondType(ForceConstant f, Exponent e, EquilDistance d) :
-        forceConstant_(f),
-        exponent_(e),
-        equilDistance_(d)
+        forceConstant_(f), exponent_(e), equilDistance_(d)
     {
     }
 
@@ -249,15 +245,11 @@ public:
 
     ProperDihedral() = default;
     ProperDihedral(Radians phi, ForceConstant f, Multiplicity m) :
-        phi_(phi),
-        forceConstant_(f),
-        multiplicity_(m)
+        phi_(phi), forceConstant_(f), multiplicity_(m)
     {
     }
     ProperDihedral(Degrees phi, ForceConstant f, Multiplicity m) :
-        phi_(phi * DEG2RAD),
-        forceConstant_(f),
-        multiplicity_(m)
+        phi_(phi * DEG2RAD), forceConstant_(f), multiplicity_(m)
     {
     }
 
@@ -340,10 +332,7 @@ class Default5Center
 public:
     Default5Center() = default;
     Default5Center(Radians phi, Radians psi, ForceConstant fphi, ForceConstant fpsi) :
-        phi_(phi),
-        psi_(psi),
-        fphi_(fphi),
-        fpsi_(fpsi)
+        phi_(phi), psi_(psi), fphi_(fphi), fpsi_(fpsi)
     {
     }
 
index c8ae094cc16be3c8afef8b9d8dc3a7e83f0feb28..14c7f087c95032b23c08d97f3d838050ff963ce7 100644 (file)
@@ -86,15 +86,13 @@ class ParticleIdentifier final
 public:
     //! \brief construct form a ParticleName, allow implicit conversion
     ParticleIdentifier(ParticleName particleName) :
-        particleName_(std::move(particleName)),
-        residueName_()
+        particleName_(std::move(particleName)), residueName_()
     {
     }
 
     //! \brief construct with a non-default ResidueName
     ParticleIdentifier(ParticleName particleName, ResidueName residueName) :
-        particleName_(std::move(particleName)),
-        residueName_(std::move(residueName))
+        particleName_(std::move(particleName)), residueName_(std::move(residueName))
     {
     }
 
index bd5d2d8595da97e1bbaf65c2ad7a9935c1ba9c76..dbbfa10c2746c8f09fa6ca1f79eb18985567168b 100644 (file)
@@ -69,8 +69,7 @@ SimulationState::Impl::Impl(const std::vector<Vec3>& coordinates,
                             const std::vector<Vec3>& forces,
                             const Box&               box,
                             Topology                 topology) :
-    box_(box),
-    topology_(std::move(topology))
+    box_(box), topology_(std::move(topology))
 {
     auto numParticles = topology_.numParticles();
 
index 2bedef8887ecc158f0d914c1d4c023be3c06be21..b9d438e4fe1f233d78a387259df54e76968c9975 100644 (file)
@@ -255,8 +255,7 @@ Topology ArgonTopologyBuilder::argonTopology()
 }
 
 ArgonSimulationStateBuilder::ArgonSimulationStateBuilder() :
-    box_(6.05449),
-    topology_(ArgonTopologyBuilder(12).argonTopology())
+    box_(6.05449), topology_(ArgonTopologyBuilder(12).argonTopology())
 {
 
     coordinates_ = {
@@ -324,8 +323,7 @@ std::vector<Vec3>& ArgonSimulationStateBuilder::velocities()
 }
 
 SpcMethanolSimulationStateBuilder::SpcMethanolSimulationStateBuilder() :
-    box_(3.01000),
-    topology_(SpcMethanolTopologyBuilder().buildTopology(1, 1))
+    box_(3.01000), topology_(SpcMethanolTopologyBuilder().buildTopology(1, 1))
 {
     coordinates_ = {
         { 1.970, 1.460, 1.209 }, // Me1
index acaea4999f2a25cce5fc775f78aa112c10122f55..204b26dd00c920f3c262f8d44e10cd3134629ec3 100644 (file)
@@ -138,7 +138,7 @@ ListedInteractionData TopologyBuilder::createInteractionData(const ParticleSeque
         std::transform(begin(expansionArrayStage1),
                        end(expansionArrayStage1),
                        begin(expansionArray),
-                       [& S2 = expansionArrayStage2](size_t S1Element) { return S2[S1Element]; });
+                       [&S2 = expansionArrayStage2](size_t S1Element) { return S2[S1Element]; });
 
         // add data about InteractionType instances
         interactionDataElement.parameters = std::move(uniqueInteractionInstances);
index de6436e46c7f241a886678a1cb08d5f04433956e..83aa4029eefd406b3cdb3ca6ab373205fd4eb8c4 100644 (file)
@@ -2,7 +2,7 @@
  * This file is part of the GROMACS molecular simulation package.
  *
  * Copyright (c) 2010,2011,2012,2013,2014 by the GROMACS development team.
- * Copyright (c) 2015,2017,2019,2020, by the GROMACS development team, led by
+ * Copyright (c) 2015,2017,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.
@@ -55,11 +55,7 @@ namespace gmx
 {
 
 AbstractAnalysisArrayData::AbstractAnalysisArrayData() :
-    rowCount_(0),
-    pointSetInfo_(0, 0, 0, 0),
-    xstep_(1.0),
-    bUniformX_(true),
-    bReady_(false)
+    rowCount_(0), pointSetInfo_(0, 0, 0, 0), xstep_(1.0), bUniformX_(true), bReady_(false)
 {
     xvalue_.push_back(0);
 }
index 7c1de57ea8ebd34acd3df3caff086e7a0b2bd690..a59a9e4f0333c064e72e5f2081a4cf3b687fa9f2 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2012,2013,2014,2017,2019, by the GROMACS development team, led by
+ * Copyright (c) 2012,2013,2014,2017,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.
@@ -56,9 +56,7 @@ AnalysisDataFrameHeader::AnalysisDataFrameHeader() : index_(-1), x_(0.0), dx_(0.
 
 
 AnalysisDataFrameHeader::AnalysisDataFrameHeader(int index, real x, real dx) :
-    index_(index),
-    x_(x),
-    dx_(dx)
+    index_(index), x_(x), dx_(dx)
 {
     GMX_ASSERT(index >= 0, "Invalid frame index");
 }
@@ -82,10 +80,7 @@ AnalysisDataPointSetRef::AnalysisDataPointSetRef(const AnalysisDataFrameHeader&
 
 AnalysisDataPointSetRef::AnalysisDataPointSetRef(const AnalysisDataFrameHeader&        header,
                                                  const std::vector<AnalysisDataValue>& values) :
-    header_(header),
-    dataSetIndex_(0),
-    firstColumn_(0),
-    values_(values)
+    header_(header), dataSetIndex_(0), firstColumn_(0), values_(values)
 {
     GMX_ASSERT(header_.isValid(), "Invalid point set reference should not be constructed");
 }
@@ -94,9 +89,7 @@ AnalysisDataPointSetRef::AnalysisDataPointSetRef(const AnalysisDataFrameHeader&
 AnalysisDataPointSetRef::AnalysisDataPointSetRef(const AnalysisDataPointSetRef& points,
                                                  int                            firstColumn,
                                                  int                            columnCount) :
-    header_(points.header()),
-    dataSetIndex_(points.dataSetIndex()),
-    firstColumn_(0)
+    header_(points.header()), dataSetIndex_(points.dataSetIndex()), firstColumn_(0)
 {
     GMX_ASSERT(firstColumn >= 0, "Invalid first column");
     GMX_ASSERT(columnCount >= 0, "Invalid column count");
@@ -152,9 +145,7 @@ AnalysisDataFrameRef::AnalysisDataFrameRef() {}
 AnalysisDataFrameRef::AnalysisDataFrameRef(const AnalysisDataFrameHeader&      header,
                                            const AnalysisDataValuesRef&        values,
                                            const AnalysisDataPointSetInfosRef& pointSets) :
-    header_(header),
-    values_(values),
-    pointSets_(pointSets)
+    header_(header), values_(values), pointSets_(pointSets)
 {
     GMX_ASSERT(!pointSets_.empty(), "There must always be a point set");
 }
@@ -163,9 +154,7 @@ AnalysisDataFrameRef::AnalysisDataFrameRef(const AnalysisDataFrameHeader&      h
 AnalysisDataFrameRef::AnalysisDataFrameRef(const AnalysisDataFrameHeader&               header,
                                            const std::vector<AnalysisDataValue>&        values,
                                            const std::vector<AnalysisDataPointSetInfo>& pointSets) :
-    header_(header),
-    values_(values),
-    pointSets_(pointSets)
+    header_(header), values_(values), pointSets_(pointSets)
 {
     GMX_ASSERT(!pointSets_.empty(), "There must always be a point set");
 }
index 07d66ea3562734ecb3b4742a31279329422eef7b..20db90e1de81d8c8d13cdd68ea0aca649011ec86 100644 (file)
@@ -290,10 +290,7 @@ class AnalysisDataPointSetInfo
 public:
     //! Construct point set data object with the given values.
     AnalysisDataPointSetInfo(int valueOffset, int valueCount, int dataSetIndex, int firstColumn) :
-        valueOffset_(valueOffset),
-        valueCount_(valueCount),
-        dataSetIndex_(dataSetIndex),
-        firstColumn_(firstColumn)
+        valueOffset_(valueOffset), valueCount_(valueCount), dataSetIndex_(dataSetIndex), firstColumn_(firstColumn)
     {
         GMX_ASSERT(valueOffset >= 0, "Negative value offsets are invalid");
         GMX_ASSERT(valueCount >= 0, "Negative value counts are invalid");
index c5e982f579703b980b75eadf4d65317782183ed8..4424f137a997416a176e25c5230190c82f1ca09e 100644 (file)
@@ -74,8 +74,7 @@ public:
     {
         //! Initializes the module information.
         explicit ModuleInfo(AnalysisDataModulePointer module) :
-            module(std::move(module)),
-            bParallel(false)
+            module(std::move(module)), bParallel(false)
         {
         }
 
index 24460bd78eaadd23e32434f156a0f0b15e0bd53f..e4e68c237c515c334d5f6baedf8b2a8490c1e4bf 100644 (file)
@@ -2,7 +2,7 @@
  * This file is part of the GROMACS molecular simulation package.
  *
  * Copyright (c) 2010,2011,2012,2013,2014 by the GROMACS development team.
- * Copyright (c) 2017,2019,2020, by the GROMACS development team, led by
+ * Copyright (c) 2017,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.
@@ -52,10 +52,7 @@ namespace gmx
 {
 
 AnalysisDataProxy::AnalysisDataProxy(int firstColumn, int columnSpan, AbstractAnalysisData* data) :
-    source_(*data),
-    firstColumn_(firstColumn),
-    columnSpan_(columnSpan),
-    bParallel_(false)
+    source_(*data), firstColumn_(firstColumn), columnSpan_(columnSpan), bParallel_(false)
 {
     GMX_RELEASE_ASSERT(data != nullptr, "Source data must not be NULL");
     GMX_RELEASE_ASSERT(firstColumn >= 0 && columnSpan > 0, "Invalid proxy column");
index 2e701f2ecf46adbbb35b4a5a5b94bf838f3a1ae4..faf425ccc096d5fbbf8c1c70b17303ea516009ab 100644 (file)
@@ -537,9 +537,7 @@ void AnalysisDataStorageImpl::finishFrameSerial(int index)
  */
 
 AnalysisDataStorageFrameData::AnalysisDataStorageFrameData(AnalysisDataStorageImpl* storageImpl, int index) :
-    storageImpl_(*storageImpl),
-    header_(index, 0.0, 0.0),
-    status_(eMissing)
+    storageImpl_(*storageImpl), header_(index, 0.0, 0.0), status_(eMissing)
 {
     GMX_RELEASE_ASSERT(storageImpl->data_ != nullptr,
                        "Storage frame constructed before data started");
index 33d9e977ed0f93c93adc7778fa28350c1dcfb9c9..6c5fe0143265c5ac9e9b831d3fb63f3eb7c8c781 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2014,2015,2017,2019,2020, by the GROMACS development team, led by
+ * Copyright (c) 2014,2015,2017,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.
@@ -106,8 +106,7 @@ public:
 
     //! Constructs a handle from specified frame data.
     AnalysisDataFrameLocalDataHandle(const std::vector<int>* dataSetIndices, ValueArray* values) :
-        dataSetIndices_(dataSetIndices),
-        values_(values)
+        dataSetIndices_(dataSetIndices), values_(values)
     {
     }
 
index 59d5ac6ac79556634eeb99681e611bbe7b5f1090..22c43011b9996e47ca1604c20a8ffe42281dbcab 100644 (file)
@@ -96,12 +96,7 @@ AnalysisHistogramSettingsInitializer::AnalysisHistogramSettingsInitializer() :
  */
 
 AnalysisHistogramSettings::AnalysisHistogramSettings() :
-    firstEdge_(0.0),
-    lastEdge_(0.0),
-    binWidth_(0.0),
-    inverseBinWidth_(0.0),
-    binCount_(0),
-    bAll_(false)
+    firstEdge_(0.0), lastEdge_(0.0), binWidth_(0.0), inverseBinWidth_(0.0), binCount_(0), bAll_(false)
 {
 }
 
@@ -513,8 +508,7 @@ BasicHistogramImpl::BasicHistogramImpl() : averager_(new BasicAverageHistogramMo
 
 
 BasicHistogramImpl::BasicHistogramImpl(const AnalysisHistogramSettings& settings) :
-    settings_(settings),
-    averager_(new BasicAverageHistogramModule(settings))
+    settings_(settings), averager_(new BasicAverageHistogramModule(settings))
 {
 }
 
index 09fab9e125a4a4e020e8ef956acbcd9ac6bdf041..e737ac3dce46390a0ac952c166ae22b15bd8af21 100644 (file)
@@ -2,7 +2,7 @@
  * This file is part of the GROMACS molecular simulation package.
  *
  * Copyright (c) 2010-2018, 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.
@@ -73,9 +73,7 @@ namespace gmx
  */
 
 AnalysisDataPlotSettings::AnalysisDataPlotSettings() :
-    selections_(nullptr),
-    timeUnit_(TimeUnit::Default),
-    plotFormat_(XvgFormat::Xmgrace)
+    selections_(nullptr), timeUnit_(TimeUnit::Default), plotFormat_(XvgFormat::Xmgrace)
 {
 }
 
@@ -420,8 +418,7 @@ AnalysisDataVectorPlotModule::AnalysisDataVectorPlotModule() : bWrite_{ true, tr
 
 
 AnalysisDataVectorPlotModule::AnalysisDataVectorPlotModule(const AnalysisDataPlotSettings& settings) :
-    AbstractPlotModule(settings),
-    bWrite_{ true, true, true, false }
+    AbstractPlotModule(settings), bWrite_{ true, true, true, false }
 {
 }
 
index 4bf7a4ef12f3b5493d034b1804c16d9703a7e371..8f7480b5ca2de1277aea10a15a2b261ec4989e14 100644 (file)
@@ -2,7 +2,7 @@
  * This file is part of the GROMACS molecular simulation package.
  *
  * Copyright (c) 2011,2012,2013,2014,2015 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.
@@ -67,9 +67,7 @@ namespace test
  */
 
 AnalysisDataTestInputPointSet::AnalysisDataTestInputPointSet(int index, int dataSetIndex, int firstColumn) :
-    index_(index),
-    dataSetIndex_(dataSetIndex),
-    firstColumn_(firstColumn)
+    index_(index), dataSetIndex_(dataSetIndex), firstColumn_(firstColumn)
 {
 }
 
@@ -119,8 +117,7 @@ void AnalysisDataTestInputFrame::addPointSetWithValueAndError(int dataSet, int f
  */
 
 AnalysisDataTestInput::AnalysisDataTestInput(int dataSetCount, bool bMultipoint) :
-    columnCounts_(dataSetCount),
-    bMultipoint_(bMultipoint)
+    columnCounts_(dataSetCount), bMultipoint_(bMultipoint)
 {
 }
 
index e99f5e893546eb81c7c96ad21596e5743bd673b3..1f349e5f3e306b53096740e0a1c33d56ad6b88f1 100644 (file)
@@ -2,7 +2,7 @@
  * This file is part of the GROMACS molecular simulation package.
  *
  * Copyright (c) 2011,2012,2013,2014,2015 by the GROMACS development team.
- * Copyright (c) 2017,2019,2020, by the GROMACS development team, led by
+ * Copyright (c) 2017,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.
@@ -336,10 +336,7 @@ public:
                             const AnalysisDataTestInputPointSet* points,
                             int                                  firstcol,
                             int                                  n) :
-        frame_(frame),
-        points_(points),
-        firstcol_(firstcol),
-        n_(n)
+        frame_(frame), points_(points), firstcol_(firstcol), n_(n)
     {
     }
 
index de3ebea8911512bd6c7116cee960bd856db039de..159aa0639e0242869b3d8691dec3e263c14c08d5 100644 (file)
@@ -147,8 +147,7 @@ static bool anyDimUsesPull(const ArrayRef<BiasCoupledToSystem> biasCoupledToSyst
 }
 
 BiasCoupledToSystem::BiasCoupledToSystem(Bias bias, const std::vector<int>& pullCoordIndex) :
-    bias_(std::move(bias)),
-    pullCoordIndex_(pullCoordIndex)
+    bias_(std::move(bias)), pullCoordIndex_(pullCoordIndex)
 {
     /* We already checked for this in grompp, but check again here. */
     GMX_RELEASE_ASSERT(
index d44f295eb2903fc381874b77b689cbcf63a5627d..89f358e53261e3147258eaa4d6b80ba01ff7b1fd 100644 (file)
@@ -281,7 +281,7 @@ private:
     const t_commrec* commRecord_;          /**< Pointer to the communication record. */
     const gmx_multisim_t* multiSimRecord_; /**< Handler for multi-simulations. */
     pull_t*               pull_;           /**< Pointer to the pull working data. */
-    double                potentialOffset_; /**< The offset of the bias potential which changes due to bias updates. */
+    double potentialOffset_; /**< The offset of the bias potential which changes due to bias updates. */
     const int numFepLambdaStates_; /**< The number of free energy lambda states of the system. */
     int       fepLambdaState_;     /**< The current free energy lambda state. */
 };
index bd3fe10c58f4084e70f32ba3b0d2bcd24e5a71cd..ccc7dca95943aa93ecca552a948950eb18876724 100644 (file)
@@ -753,9 +753,7 @@ void BiasGrid::initPoints()
 }
 
 GridAxis::GridAxis(double origin, double end, double period, double pointDensity) :
-    origin_(origin),
-    period_(period),
-    isFepLambdaAxis_(false)
+    origin_(origin), period_(period), isFepLambdaAxis_(false)
 {
     length_ = getIntervalLengthPeriodic(origin_, end, period_);
 
@@ -797,10 +795,7 @@ GridAxis::GridAxis(double origin, double end, double period, double pointDensity
 }
 
 GridAxis::GridAxis(double origin, double end, double period, int numPoints, bool isFepLambdaAxis) :
-    origin_(origin),
-    period_(period),
-    numPoints_(numPoints),
-    isFepLambdaAxis_(isFepLambdaAxis)
+    origin_(origin), period_(period), numPoints_(numPoints), isFepLambdaAxis_(isFepLambdaAxis)
 {
     if (isFepLambdaAxis)
     {
index ec72ace256cb3a836c84c8cd794649e83855a5a5..119f91d74e2f80d36ff46b0c6735482dac76fcd1 100644 (file)
@@ -211,10 +211,10 @@ private:
     const int64_t numStepsUpdateTarget_; /**< Number of steps per updating the target distribution. */
     const int64_t numStepsCheckCovering_; /**< Number of steps per checking for covering. */
 public:
-    const AwhTargetType eTarget;              /**< Type of target distribution. */
-    const double        freeEnergyCutoffInKT; /**< Free energy cut-off in kT for cut-off target distribution. */
-    const double        temperatureScaleFactor; /**< Temperature scaling factor for temperature scaled targed distributions. */
-    const bool          idealWeighthistUpdate; /**< Update reference weighthistogram using the target distribution? Otherwise use the realized distribution. */
+    const AwhTargetType eTarget;       /**< Type of target distribution. */
+    const double freeEnergyCutoffInKT; /**< Free energy cut-off in kT for cut-off target distribution. */
+    const double temperatureScaleFactor; /**< Temperature scaling factor for temperature scaled targed distributions. */
+    const bool   idealWeighthistUpdate; /**< Update reference weighthistogram using the target distribution? Otherwise use the realized distribution. */
     const int    numSharedUpdate; /**< The number of (multi-)simulations sharing the bias update */
     const double updateWeight;    /**< The probability weight accumulated for each update. */
     const double localWeightScaling; /**< Scaling factor applied to a sample before adding it to the reference weight histogram (= 1, usually). */
@@ -224,7 +224,7 @@ private:
     awh_ivec coverRadius_; /**< The radius (in points) that needs to be sampled around a point before it is considered covered. */
 public:
     const bool convolveForce; /**< True if we convolve the force, false means use MC between umbrellas. */
-    const int  biasIndex; /**< Index of the bias, used as a second random seed and for priting. */
+    const int biasIndex; /**< Index of the bias, used as a second random seed and for priting. */
 private:
     const bool disableUpdateSkips_; /**< If true, we disallow update skips, even when the method supports it. */
 };
index aa0b916dfea272d1e54c8ea433ee8b2c8c4e9ca9..903ea747d983873e338820548bcf150ae73877d0 100644 (file)
@@ -124,9 +124,7 @@ float getNormalizationValue(AwhOutputEntryType outputType, const Bias& bias, int
 } // namespace
 
 AwhEnergyBlock::AwhEnergyBlock(int numPoints, Normalization normalizationType, float normalizationValue) :
-    normalizationType(normalizationType),
-    normalizationValue(normalizationValue),
-    data_(numPoints)
+    normalizationType(normalizationType), normalizationValue(normalizationValue), data_(numPoints)
 {
 }
 
index 5a7b956e1b1c3390e9ccca114c6f88c2b30b0bc1..b50ed789cd35eb7f7e9ff21fa2b95cd37c6a0be2 100644 (file)
@@ -85,8 +85,7 @@ CorrelationGrid::CorrelationGrid(int                numPoints,
                                  double             blockLengthInit,
                                  BlockLengthMeasure blockLengthMeasure,
                                  double             dtSample) :
-    dtSample(dtSample),
-    blockLengthMeasure(blockLengthMeasure)
+    dtSample(dtSample), blockLengthMeasure(blockLengthMeasure)
 {
     /* Set the initial block length for the block averaging. The length doesn't really matter
        after the block length has been doubled a few times, as long as it's set small enough */
index 11fc93f83c2b50c09ce0dc704eba0279c854b787..cf536b8ec8df7efeaf5096bc57d96bd8860c09bc 100644 (file)
@@ -93,8 +93,7 @@ private:
      * Private constructor called by public builder functions for PullDimParams and FepLambdaDimParams.
      */
     DimParams(double conversionFactor, std::variant<PullDimParams, FepDimParams> dimParams) :
-        dimParams(std::move(dimParams)),
-        userCoordUnitsToInternal(conversionFactor)
+        dimParams(std::move(dimParams)), userCoordUnitsToInternal(conversionFactor)
     {
     }
 
index 18bd4be1a9796ad5c9655b2d8b769b9ee646b539..6e2c1f553d5158d9a199620862bacf0125d161ce 100644 (file)
@@ -72,9 +72,7 @@ struct AwhTestParameters
     explicit AwhTestParameters(ISerializer* serializer);
     //! Move constructor
     AwhTestParameters(AwhTestParameters&& o) noexcept :
-        beta(o.beta),
-        awhParams(std::move(o.awhParams)),
-        dimParams(std::move(o.dimParams))
+        beta(o.beta), awhParams(std::move(o.awhParams)), dimParams(std::move(o.dimParams))
     {
     }
     //! 1/(kB*T).
index 75d1d26a077558a3425bf0dc27245b0e6184de39..2f8a8bc89ed19a841d2d11c7d7a48c459b100cc1 100644 (file)
@@ -220,7 +220,7 @@ DensityFittingAmplitudeLookup& DensityFittingAmplitudeLookup::operator=(const De
 
 DensityFittingAmplitudeLookup::DensityFittingAmplitudeLookup(DensityFittingAmplitudeLookup&&) noexcept = default;
 
-DensityFittingAmplitudeLookup& DensityFittingAmplitudeLookup::
-                               operator=(DensityFittingAmplitudeLookup&&) noexcept = default;
+DensityFittingAmplitudeLookup&
+DensityFittingAmplitudeLookup::operator=(DensityFittingAmplitudeLookup&&) noexcept = default;
 
 } // namespace gmx
index 9a4f5d7e86bd033a6cf058f672767c4e0bb9644c..111b79b0b89a4f26ae86d8fe9e950789d3da28a2 100644 (file)
@@ -233,11 +233,11 @@ DensityFittingForceProvider::Impl::Impl(const DensityFittingParameters&
         Matrix3x3 translationMatrix = transformationMatrixParametersAsArray.has_value()
                                               ? *transformationMatrixParametersAsArray
                                               : identityMatrix<real, 3>();
-        RVec translationVector = translationParametersAsArray.has_value()
-                                         ? RVec((*translationParametersAsArray)[XX],
+        RVec      translationVector = translationParametersAsArray.has_value()
+                                              ? RVec((*translationParametersAsArray)[XX],
                                                 (*translationParametersAsArray)[YY],
                                                 (*translationParametersAsArray)[ZZ])
-                                         : RVec(0, 0, 0);
+                                              : RVec(0, 0, 0);
         affineTransformation_.emplace(translationMatrix.asConstView(), translationVector);
     }
 
index 04abd8681705843c318cffd5ac7ba0a14120ad4d..306a984ad0124f7c1e6c5ea25dbbc82d5db9ed0e 100644 (file)
@@ -85,9 +85,7 @@ public:
     }
     //! Creates an implementation class from a low-level context.
     explicit Impl(const HelpWriterContext& writerContext) :
-        writerContext_(writerContext),
-        completionWriter_(nullptr),
-        bHidden_(false)
+        writerContext_(writerContext), completionWriter_(nullptr), bHidden_(false)
     {
     }
 
index 4518c54515e7f9d2d49d346a99d21e20833b79c0..fd0ca99811386bc8b21b49797978db8152ba913b 100644 (file)
@@ -425,8 +425,7 @@ class ModuleHelpTopic : public IHelpTopic
 public:
     //! Constructs a help topic for a specific module.
     ModuleHelpTopic(const ICommandLineModule& module, const CommandLineHelpModuleImpl& helpModule) :
-        module_(module),
-        helpModule_(helpModule)
+        module_(module), helpModule_(helpModule)
     {
     }
 
@@ -519,9 +518,7 @@ private:
 
 HelpExportReStructuredText::HelpExportReStructuredText(const CommandLineHelpModuleImpl& helpModule,
                                                        IFileOutputRedirector* outputRedirector) :
-    outputRedirector_(outputRedirector),
-    binaryName_(helpModule.binaryName_),
-    links_(eHelpOutputFormat_Rst)
+    outputRedirector_(outputRedirector), binaryName_(helpModule.binaryName_), links_(eHelpOutputFormat_Rst)
 {
     TextReader  linksFile("links.dat");
     std::string line;
@@ -793,8 +790,7 @@ class ModificationCheckingFileOutputStream : public TextOutputStream
 {
 public:
     ModificationCheckingFileOutputStream(const char* path, IFileOutputRedirector* redirector) :
-        path_(path),
-        redirector_(redirector)
+        path_(path), redirector_(redirector)
     {
     }
 
index bd03eebe65bee7f62ca83599a3b5e80a51eaa4bb..e98d0efbeaa734ba60ba5d57a59c7860e15bfba6 100644 (file)
@@ -2,7 +2,7 @@
  * This file is part of the GROMACS molecular simulation package.
  *
  * Copyright (c) 2010-2018, 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.
@@ -287,11 +287,7 @@ class SynopsisFormatter : public IOptionsFormatter
 public:
     //! Creates a helper object for formatting the synopsis.
     explicit SynopsisFormatter(const HelpWriterContext& context) :
-        context_(context),
-        bFormatted_(false),
-        lineLength_(0),
-        indent_(0),
-        currentLength_(0)
+        context_(context), bFormatted_(false), lineLength_(0), indent_(0), currentLength_(0)
     {
     }
 
@@ -430,11 +426,7 @@ private:
 OptionsListFormatter::OptionsListFormatter(const HelpWriterContext&   context,
                                            const CommonFormatterData& common,
                                            const char*                title) :
-    context_(context),
-    common_(common),
-    title_(title),
-    header_(nullptr),
-    bDidOutput_(false)
+    context_(context), common_(common), title_(title), header_(nullptr), bDidOutput_(false)
 {
 }
 
index 2ab9d2bb0d646061e227bfaf2731ae0c4e878a6f..1af5f01598897c153fb62eb040b22f95b7021268 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2012,2013,2014,2015,2019, by the GROMACS development team, led by
+ * Copyright (c) 2012,2013,2014,2015,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.
@@ -94,9 +94,7 @@ public:
      * Does not throw.
      */
     CommandLineModuleGroupData(const CommandLineModuleMap& modules, const char* binaryName, const char* title) :
-        allModules_(modules),
-        binaryName_(binaryName),
-        title_(title)
+        allModules_(modules), binaryName_(binaryName), title_(title)
     {
     }
 
index 53f2f92636489d3697a66a2d263f74f772becd7e..36badc4093b4d6628c658f98029691083234ae15 100644 (file)
@@ -2,7 +2,7 @@
  * This file is part of the GROMACS molecular simulation package.
  *
  * Copyright (c) 2014,2015,2016,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.
@@ -111,15 +111,11 @@ public:
     typedef ICommandLineOptionsModule::FactoryMethod FactoryMethod;
 
     CommandLineOptionsModule(const char* name, const char* description, FactoryMethod factory) :
-        name_(name),
-        description_(description),
-        factory_(std::move(factory))
+        name_(name), description_(description), factory_(std::move(factory))
     {
     }
     CommandLineOptionsModule(const char* name, const char* description, ICommandLineOptionsModulePointer module) :
-        name_(name),
-        description_(description),
-        module_(std::move(module))
+        name_(name), description_(description), module_(std::move(module))
     {
     }
     const char* name() const override { return name_; }
index 5f33ed552faba4ce7864812aaf0b11031daa241d..c3b9dc0851efc50ac7f84c1858debc83d4c3ba72 100644 (file)
@@ -2,7 +2,7 @@
  * This file is part of the GROMACS molecular simulation package.
  *
  * Copyright (c) 2010-2018, 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.
@@ -93,9 +93,7 @@ public:
 };
 
 CommandLineParser::Impl::Impl(Options* options) :
-    assigner_(options),
-    bSkipUnknown_(false),
-    bAllowPositionalArguments_(false)
+    assigner_(options), bSkipUnknown_(false), bAllowPositionalArguments_(false)
 {
     assigner_.setAcceptBooleanNoPrefix(true);
 }
index 5c4b5b89f0e6161a587c5b92703f7a04bcbd5046..6b1eda99affc681eaf5941b4a5d8047f3e6cb4a5 100644 (file)
@@ -312,9 +312,7 @@ public:
 CommandLineProgramContext::Impl::Impl() : programName_("GROMACS"), bSourceLayout_(false) {}
 
 CommandLineProgramContext::Impl::Impl(int argc, const char* const argv[], ExecutableEnvironmentPointer env) :
-    executableEnv_(std::move(env)),
-    invokedName_(argc != 0 ? argv[0] : ""),
-    bSourceLayout_(false)
+    executableEnv_(std::move(env)), invokedName_(argc != 0 ? argv[0] : ""), bSourceLayout_(false)
 {
     programName_ = Path::getFilename(invokedName_);
     programName_ = stripSuffixIfPresent(programName_, ".exe");
index c027dba96aa5260d66fbfb620faa4dea2a001cf7..9acde8e261bb14ddbd8a1d64646850f7211d9b26 100644 (file)
@@ -276,10 +276,7 @@ private:
     {
         //! Creates a conversion helper for a given `t_pargs` struct.
         explicit ProgramArgData(t_pargs* pa) :
-            pa(pa),
-            optionInfo(nullptr),
-            enumIndex(0),
-            boolValue(false)
+            pa(pa), optionInfo(nullptr), enumIndex(0), boolValue(false)
         {
         }
 
index 3ceb0acc81684f5c0a92db120db15c3828426249..08b1999a8ea4954faae5ba0413182c2ee013daeb 100644 (file)
@@ -91,7 +91,8 @@ typedef struct
      * changed.  In other words, the initial value for the variable defines the
      * default value.
      */
-    union {
+    union
+    {
         /*! \brief
          * Generic pointer for operations that do not need type information.
          *
index 9d7684be2e616bda64bab5ba7dabbfa4f40ca91b..5a0de0edfa9664fb666becf75d4d5300314ba461 100644 (file)
@@ -124,8 +124,7 @@ class CommandLineModuleManagerTestBase::Impl
 {
 public:
     Impl(const CommandLine& args, const char* realBinaryName) :
-        programContext_(args.argc(), args.argv()),
-        manager_(realBinaryName, &programContext_)
+        programContext_(args.argc(), args.argv()), manager_(realBinaryName, &programContext_)
     {
         manager_.setQuiet(true);
         manager_.setOutputRedirector(&redirector_);
index 9558b9b309869682145acc5361b3b09888289abf..2020e41cd721c2d6e7e3a6569093c53049f15a20 100644 (file)
@@ -2,7 +2,7 @@
  * This file is part of the GROMACS molecular simulation package.
  *
  * Copyright (c) 2010-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.
@@ -78,10 +78,7 @@ public:
 };
 
 CommandLineParserTest::CommandLineParserTest() :
-    parser_(&options_),
-    flag_(false),
-    ivalue1p_(0),
-    ivalue12_(0)
+    parser_(&options_), flag_(false), ivalue1p_(0), ivalue12_(0)
 {
     using gmx::BooleanOption;
     using gmx::DoubleOption;
index 86dcc9b4ab542d61c078fdc63921373c036783a5..fc7fa14e46cd9d041e816dafa18f6d810086c1a4 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * 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.
@@ -109,11 +109,7 @@ public:
      *                 than the object created here.
      */
     TrajectoryFileOpener(const std::string& name, int filetype, const Selection& sel, const gmx_mtop_t* mtop) :
-        outputFileName_(name),
-        outputFile_(nullptr),
-        filetype_(filetype),
-        sel_(sel),
-        mtop_(mtop)
+        outputFileName_(name), outputFile_(nullptr), filetype_(filetype), sel_(sel), mtop_(mtop)
     {
     }
 
@@ -201,8 +197,7 @@ private:
                           const Selection&       sel,
                           const gmx_mtop_t*      mtop,
                           OutputAdapterContainer adapters) :
-        file_(name, filetype, sel, mtop),
-        outputAdapters_(std::move(adapters))
+        file_(name, filetype, sel, mtop), outputAdapters_(std::move(adapters))
     {
     }
 
index 00d7d1af377934d99493f576aad6433c0e0a77b5..2091cf38a5c50853dced06aa471e1be64ad44437 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * 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.
@@ -76,9 +76,7 @@ public:
      * framework.
      */
     explicit SetAtoms(ChangeAtomsType atomFlag, AtomsDataPtr inputAtoms) :
-        atomFlag_(atomFlag),
-        haveStructureFileAtoms_(false),
-        atoms_(std::move(inputAtoms))
+        atomFlag_(atomFlag), haveStructureFileAtoms_(false), atoms_(std::move(inputAtoms))
     {
         if (atoms_ != nullptr)
         {
index 247f33779023b48eb84c1f31ddb933242cd829a5..6f47e16977be476e1819138da29f22b83282f7e8 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * 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.
@@ -68,9 +68,7 @@ public:
      * \param[in] startTime User defined value for the initial time.
      */
     explicit SetStartTime(real startTime) :
-        startTime_(startTime),
-        haveProcessedFirstFrame_(false),
-        differenceToInitialTime_(0)
+        startTime_(startTime), haveProcessedFirstFrame_(false), differenceToInitialTime_(0)
     {
     }
     /*! \brief
index 6368a885838a315414d632b4cd5ff7d7cfc733d7..fbae8451caef4e5df1e40db792dea388b9576792 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * 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.
@@ -71,9 +71,7 @@ public:
      * \param[in] timeStep User defined value for the time step.
      */
     explicit SetTimeStep(real timeStep) :
-        timeStep_(timeStep),
-        previousFrameTime_(0.0),
-        haveProcessedFirstFrame_(false)
+        timeStep_(timeStep), previousFrameTime_(0.0), haveProcessedFirstFrame_(false)
     {
     }
     /*! \brief
index c13fc4a8b4781b3f5f387c940c3e42e45821fe04..dcde124435b27844b203b79d6f59e75d4f3d0a25 100644 (file)
@@ -50,11 +50,7 @@ struct BalanceRegion
 {
     /*! \brief Constructor */
     BalanceRegion() :
-        isOpen(false),
-        isOpenOnCpu(false),
-        isOpenOnGpu(false),
-        cyclesOpenCpu(0),
-        cyclesLastCpu(0)
+        isOpen(false), isOpenOnCpu(false), isOpenOnGpu(false), cyclesOpenCpu(0), cyclesLastCpu(0)
     {
     }
 
index 346a09bf6df9bc03d3b1a80e8f800ca1bbe3f139..a9304bbab60126f27fe00f449b4c2b320a73c21a 100644 (file)
@@ -1285,7 +1285,7 @@ static void setup_neighbor_relations(gmx_domdec_t* dd)
 static void make_pp_communicator(const gmx::MDLogger& mdlog,
                                  gmx_domdec_t*        dd,
                                  t_commrec gmx_unused* cr,
-                                 bool gmx_unused reorder)
+                                 bool gmx_unused       reorder)
 {
 #if GMX_MPI
     gmx_domdec_comm_t*  comm      = dd->comm;
@@ -1422,10 +1422,10 @@ static void receive_ddindex2simnodeid(gmx_domdec_t* dd, t_commrec* cr)
 static CartesianRankSetup split_communicator(const gmx::MDLogger& mdlog,
                                              t_commrec*           cr,
                                              const DdRankOrder    ddRankOrder,
-                                             bool gmx_unused    reorder,
-                                             const DDRankSetup& ddRankSetup,
-                                             ivec               ddCellIndex,
-                                             std::vector<int>*  pmeRanks)
+                                             bool gmx_unused      reorder,
+                                             const DDRankSetup&   ddRankSetup,
+                                             ivec                 ddCellIndex,
+                                             std::vector<int>*    pmeRanks)
 {
     CartesianRankSetup cartSetup;
 
@@ -2928,11 +2928,7 @@ DomainDecompositionBuilder::Impl::Impl(const MDLogger&      mdlog,
                                        const t_inputrec&    ir,
                                        const matrix         box,
                                        ArrayRef<const RVec> xGlobal) :
-    mdlog_(mdlog),
-    cr_(cr),
-    options_(options),
-    mtop_(mtop),
-    ir_(ir)
+    mdlog_(mdlog), cr_(cr), options_(options), mtop_(mtop), ir_(ir)
 {
     GMX_LOG(mdlog_.info).appendTextFormatted("\nInitializing Domain Decomposition on %d ranks", cr_->sizeOfDefaultCommunicator);
 
index c6363362febb09c5786eae80b5a315f399b8ee80..b5c01f85e073535c4cf80593732ba09085864d2f 100644 (file)
@@ -146,15 +146,15 @@ template void ddSendrecv(const gmx_domdec_t*, int, int, gmx::ArrayRef<real>, gmx
 template void ddSendrecv(const gmx_domdec_t*, int, int, gmx::ArrayRef<gmx::RVec>, gmx::ArrayRef<gmx::RVec>);
 
 void dd_sendrecv2_rvec(const struct gmx_domdec_t gmx_unused* dd,
-                       int gmx_unused ddimind,
+                       int gmx_unused                        ddimind,
                        rvec gmx_unused* buf_s_fw,
-                       int gmx_unused n_s_fw,
+                       int gmx_unused   n_s_fw,
                        rvec gmx_unused* buf_r_fw,
-                       int gmx_unused n_r_fw,
+                       int gmx_unused   n_r_fw,
                        rvec gmx_unused* buf_s_bw,
-                       int gmx_unused n_s_bw,
+                       int gmx_unused   n_s_bw,
                        rvec gmx_unused* buf_r_bw,
-                       int gmx_unused n_r_bw)
+                       int gmx_unused   n_r_bw)
 {
 #if GMX_MPI
     MPI_Request req[4];
@@ -275,7 +275,7 @@ void dd_scatter(const gmx_domdec_t gmx_unused* dd, int gmx_unused nbytes, const
 }
 
 void dd_gather(const gmx_domdec_t gmx_unused* dd,
-               int gmx_unused nbytes,
+               int gmx_unused                 nbytes,
                const void gmx_unused* src,
                void gmx_unused* dest)
 {
@@ -318,7 +318,7 @@ void dd_scatterv(const gmx_domdec_t gmx_unused* dd,
 }
 
 void dd_gatherv(const gmx_domdec_t gmx_unused* dd,
-                int gmx_unused scount,
+                int gmx_unused                 scount,
                 const void gmx_unused* sbuf,
                 int gmx_unused* rcounts,
                 int gmx_unused* disps,
index 948041d7d789f881792e744b5c27f85c5dd4cbbc..89948c7bd2dd3aacb659b49106a3035b03095f92 100644 (file)
@@ -378,14 +378,14 @@ int setup_specat_communication(gmx_domdec_t*             dd,
     for (int d = dd->ndim - 1; d >= 0; d--)
     {
         /* Pulse the grid forward and backward */
-        int       dim  = dd->dim[d];
-        bool      bPBC = (dim < dd->unitCellInfo.npbcdim);
-        const int ndir = (dd->numCells[dim] == 2)
-                                 ?
-                                 /* Only 2 cells, so we only need to communicate once */
+        int       dim       = dd->dim[d];
+        bool      bPBC      = (dim < dd->unitCellInfo.npbcdim);
+        const int ndir      = (dd->numCells[dim] == 2)
+                                      ?
+                                      /* Only 2 cells, so we only need to communicate once */
                                  1
-                                 : 2;
-        int* nsend_ptr = nullptr;
+                                      : 2;
+        int*      nsend_ptr = nullptr;
         for (int dir = 0; dir < ndir; dir++)
         {
             if (!bPBC && dd->numCells[dim] > 2
index e4b972afbfd3f03d8892b76ec0debd43ea5fa083..1f6b92d0e3f7ee3b6c6b234d16aad8babbf41605 100644 (file)
@@ -4,7 +4,7 @@
  * Copyright (c) 1991-2000, University of Groningen, The Netherlands.
  * Copyright (c) 2001-2004, The GROMACS development team.
  * Copyright (c) 2010,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.
@@ -166,7 +166,8 @@ public:
     }
 
 private:
-    union Data {
+    union Data
+    {
         std::vector<Entry>    direct;
         gmx::HashedMap<Entry> hashed;
         // constructor and destructor function in parent class
index 605c36d485780c12ea150b839618bf0d190b8183..ad5e7d9295b26d7eca62b9bbf8f5d98047c669e0 100644 (file)
@@ -1960,7 +1960,7 @@ static void translate_and_rotate(rvec*  x,        /* The positions to be transla
 
 /* Gets the rms deviation of the positions to the structure s */
 /* fit_to_structure has to be called before calling this routine! */
-static real rmsd_from_structure(rvec* x,           /* The positions under consideration */
+static real rmsd_from_structure(rvec*           x, /* The positions under consideration */
                                 struct gmx_edx* s) /* The structure from which the rmsd shall be computed */
 {
     real rmsd = 0.0;
index efea5c7a06786dc624de6a27d464435e39fd10ab..027cc6f245c12368ef468a3c5316911fbe38b824 100644 (file)
@@ -323,11 +323,7 @@ PmeAtomComm::PmeAtomComm(MPI_Comm   PmeMpiCommunicator,
                          const int  pmeOrder,
                          const int  dimIndex,
                          const bool doSpread) :
-    dimind(dimIndex),
-    bSpread(doSpread),
-    pme_order(pmeOrder),
-    nthread(numThreads),
-    spline(nthread)
+    dimind(dimIndex), bSpread(doSpread), pme_order(pmeOrder), nthread(numThreads), spline(nthread)
 {
     if (PmeMpiCommunicator != MPI_COMM_NULL)
     {
index 7fa2122dfb8a1cc5a65f03084e9356de114fc7a9..0fbede7b092929aa54d1038f7011c612bd133043 100644 (file)
@@ -59,9 +59,7 @@ namespace gmx
 PmeCoordinateReceiverGpu::Impl::Impl(const DeviceStream&    pmeStream,
                                      MPI_Comm               comm,
                                      gmx::ArrayRef<PpRanks> ppRanks) :
-    pmeStream_(pmeStream),
-    comm_(comm),
-    ppRanks_(ppRanks)
+    pmeStream_(pmeStream), comm_(comm), ppRanks_(ppRanks)
 {
     request_.resize(ppRanks.size());
     ppSync_.resize(ppRanks.size());
index b124c03136e19cf66ab0f2ca729566ead93546a6..ecec4d6ac6fd42b19ac574aa7db555b74baf3856 100644 (file)
@@ -58,9 +58,7 @@ namespace gmx
 PmeForceSenderGpu::Impl::Impl(GpuEventSynchronizer*  pmeForcesReady,
                               MPI_Comm               comm,
                               gmx::ArrayRef<PpRanks> ppRanks) :
-    pmeForcesReady_(pmeForcesReady),
-    comm_(comm),
-    ppRanks_(ppRanks)
+    pmeForcesReady_(pmeForcesReady), comm_(comm), ppRanks_(ppRanks)
 {
 }
 
index 361461b4176bbda2bfd42187285ab4de3ef37aab..f9e3e95715f7c6f43e7990639b29dd4cb9c41c37 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2018,2019,2020, by the GROMACS development team, led by
+ * Copyright (c) 2018,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.
@@ -313,7 +313,7 @@ __kernel void CUSTOMIZED_KERNEL_NAME(pme_gather_kernel)(const struct PmeOpenCLKe
 #define gridlineIndicesSize (atomsPerBlock * DIM)
 #define splineParamsSize (atomsPerBlock * DIM * order)
 
-    __local int sm_gridlineIndices[gridlineIndicesSize];
+    __local int    sm_gridlineIndices[gridlineIndicesSize];
     __local float2 sm_splineParams[splineParamsSize]; /* Theta/dtheta pairs  as .x/.y */
 
     /* Spline Y/Z coordinates */
index 2a7925cfe281335cd195176f2497f87aab10265c..babb5837b2d2077c3d60cc196cf7fe94b182ba2b 100644 (file)
@@ -4,7 +4,7 @@
  * Copyright (c) 1991-2000, University of Groningen, The Netherlands.
  * Copyright (c) 2001-2004, The GROMACS development team.
  * 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.
@@ -77,16 +77,12 @@ using namespace gmx; // TODO: Remove when this file is moved into gmx namespace
  */
 struct do_fspline
 {
-    do_fspline(const gmx_pme_t* pme,
-               const real* gmx_restrict grid,
-               const PmeAtomComm* gmx_restrict atc,
+    do_fspline(const gmx_pme_t*                 pme,
+               const real* gmx_restrict         grid,
+               const PmeAtomComm* gmx_restrict  atc,
                const splinedata_t* gmx_restrict spline,
                int                              nn) :
-        pme(pme),
-        grid(grid),
-        atc(atc),
-        spline(spline),
-        nn(nn)
+        pme(pme), grid(grid), atc(atc), spline(spline), nn(nn)
     {
     }
 
@@ -285,9 +281,9 @@ struct do_fspline
     }
 #endif
 private:
-    const gmx_pme_t* const pme;
-    const real* const gmx_restrict grid;
-    const PmeAtomComm* const gmx_restrict atc;
+    const gmx_pme_t* const                 pme;
+    const real* const gmx_restrict         grid;
+    const PmeAtomComm* const gmx_restrict  atc;
     const splinedata_t* const gmx_restrict spline;
     const int                              nn;
 
index 798a9be9ef3563485370ca9d39bd7b18c37b3398..9700d01f941336e94d4fce061973252c35dd53b1 100644 (file)
@@ -1133,8 +1133,8 @@ static auto selectSplineAndSpreadKernelPtr(const PmeGpu*  pmeGpu,
  *
  * \return Pointer to CUDA kernel
  */
-static auto selectSplineKernelPtr(const PmeGpu*  pmeGpu,
-                                  ThreadsPerAtom threadsPerAtom,
+static auto selectSplineKernelPtr(const PmeGpu*   pmeGpu,
+                                  ThreadsPerAtom  threadsPerAtom,
                                   bool gmx_unused writeSplinesToGlobal,
                                   const int       numGrids)
 {
index 8204a9123f7ebe12c90e719dee55f6a52f30aab2..6b16ba5c16ca54120cf1a8367e1c638ff4d2f61d 100644 (file)
@@ -84,8 +84,7 @@ struct PmeGpuSpecific
      * \param[in] pmeStream      GPU pme stream.
      */
     PmeGpuSpecific(const DeviceContext& deviceContext, const DeviceStream& pmeStream) :
-        deviceContext_(deviceContext),
-        pmeStream_(pmeStream)
+        deviceContext_(deviceContext), pmeStream_(pmeStream)
     {
     }
 
index 82d6574866a5223cc74b44a31ae53313c805c671..c7944730100a23372bca303c0148e706cbaa6d61 100644 (file)
@@ -254,7 +254,7 @@ static int gmx_pme_recv_coeffs_coords(struct gmx_pme_t*            pme,
                                       real*                        ewaldcoeff_lj,
                                       bool                         useGpuForPme,
                                       gmx::StatePropagatorDataGpu* stateGpu,
-                                      PmeRunMode gmx_unused runMode)
+                                      PmeRunMode gmx_unused        runMode)
 {
     int status = -1;
     int nat    = 0;
index e70e45ef2e9ab5be605bb67f89cb1beb7e8087d2..9fdea71a55f7cf84e3257e5d2c8e4936c1763759 100644 (file)
@@ -244,12 +244,12 @@ void PmeAtomComm::setNumAtoms(const int numAtoms)
 
 //! Communicates buffers between rank separated by \p shift slabs
 static void pme_dd_sendrecv(PmeAtomComm gmx_unused* atc,
-                            gmx_bool gmx_unused bBackward,
-                            int gmx_unused shift,
+                            gmx_bool gmx_unused     bBackward,
+                            int gmx_unused          shift,
                             void gmx_unused* buf_s,
-                            int gmx_unused nbyte_s,
+                            int gmx_unused   nbyte_s,
                             void gmx_unused* buf_r,
-                            int gmx_unused nbyte_r)
+                            int gmx_unused   nbyte_r)
 {
 #if GMX_MPI
     int        dest, src;
index 7c38a52c91599c1e60d7fc7899e476fa7296b248..1496db2bf5e519fc0a1e0f209e360380ea52fded 100644 (file)
@@ -103,7 +103,7 @@ public:
         inputRec.nkz         = gridSize[ZZ];
         inputRec.coulombtype = (moduliType == ModuliType::P3M) ? CoulombInteractionType::P3mAD
                                                                : CoulombInteractionType::Pme;
-        inputRec.pme_order = pmeOrder;
+        inputRec.pme_order   = pmeOrder;
 
         /* PME initialization call which checks the inputs and computes the B-spline moduli according to the grid sizes. */
         PmeSafePointer pme = pmeInitEmpty(&inputRec);
index c8e8530ee7924c87d24f9f30ec77a479f1190c83..3d611ca0d0ea3552232cc5d404c1fcf5487ed10b 100644 (file)
@@ -910,8 +910,7 @@ const char* codePathToString(CodePath codePath)
 PmeTestHardwareContext::PmeTestHardwareContext() : codePath_(CodePath::CPU) {}
 
 PmeTestHardwareContext::PmeTestHardwareContext(TestDevice* testDevice) :
-    codePath_(CodePath::CPU),
-    testDevice_(testDevice)
+    codePath_(CodePath::CPU), testDevice_(testDevice)
 {
     setActiveDevice(testDevice_->deviceInfo());
     pmeGpuProgram_ = buildPmeGpuProgram(testDevice_->deviceContext());
index 2fd3e5aa0fd6278652e435d95496bd62224d080a..c4cd56623bca5df1987cea974f7e0d42afcc34ec 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * 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.
@@ -251,8 +251,7 @@ public:
 };
 
 MrcDensityMapOfFloatWriter::Impl::Impl(const MrcDensityMapHeader& header, ArrayRef<const float> data) :
-    header_(header),
-    data_(data)
+    header_(header), data_(data)
 {
 }
 
index 82160127fa62ccda348df20c5480730169f5974c..c6f471357c15b64011acbc997274450cc315e39c 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * 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.
@@ -87,8 +87,8 @@ enum class MrcDataMode : int32_t
  */
 struct MrcDataStatistics
 {
-    float min_  = 0.; //!< Minimum data value scales values in (currently unsupported) compressed data mode.
-    float max_  = 0.; //!< Maximum data value scales values in (currently unsupported) compressed data mode.
+    float min_ = 0.; //!< Minimum data value scales values in (currently unsupported) compressed data mode.
+    float max_ = 0.; //!< Maximum data value scales values in (currently unsupported) compressed data mode.
     float mean_ = 0.; //!< mean of the data
     float rms_  = 0.; //!< rms of the data
 };
index 2c5d9b0c4309632435361ff75897d569801a74d5..b57ddcd7150c1272c6e8cad9ec1734a9d947cba4 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * 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.
@@ -56,12 +56,14 @@ namespace test
 {
 namespace
 {
-union IntAndFloat32 {
+union IntAndFloat32
+{
     std::int32_t int32Value_;
     float        floatValue_;
 };
 
-union IntAndFloat64 {
+union IntAndFloat64
+{
     std::int64_t int64Value_;
     double       doubleValue_;
 };
@@ -104,8 +106,8 @@ public:
         double         doubleValue_        = c_intAndFloat64.doubleValue_;
         int            intValue_           = integerSizeDependentTestingValue();
         real           realValue_          = std::is_same_v<real, double>
-                                  ? static_cast<real>(c_intAndFloat64.doubleValue_)
-                                  : static_cast<real>(c_intAndFloat32.floatValue_);
+                                                     ? static_cast<real>(c_intAndFloat64.doubleValue_)
+                                                     : static_cast<real>(c_intAndFloat32.floatValue_);
     } defaultValues_;
 
     TestFileManager fileManager_;
index f83e9ba3a661c21c2c532086c7fbe15473c9c7de..3e43d1de535840481d65945aa098c07dae5c47e7 100644 (file)
@@ -299,10 +299,7 @@ std::vector<std::string> makeLegend(const AwhBiasParams& awhBiasParams,
 } // namespace
 
 OutputFile::OutputFile(const std::string& filename, const std::string& baseTitle, int numBias, int biasIndex) :
-    numDim_(0),
-    firstGraphSubBlock_(0),
-    numGraph_(0),
-    useKTForEnergy_(false)
+    numDim_(0), firstGraphSubBlock_(0), numGraph_(0), useKTForEnergy_(false)
 
 {
     baseFilename_ = filename.substr(0, filename.find('.'));
index f0e0857ccd9b0f497ad0f0548b7ab986d361818b..5113096c859afec8f6323eb5bc04476271d94aaf 100644 (file)
@@ -436,10 +436,10 @@ static void calc_order(const char*             fn,
             nr_tails,                      /* nr tails, to check if index file is correct    */
             size = 0,                      /* nr. of atoms in group. same as nr_tails        */
             i, j, m, k, teller = 0, slice; /* current slice number                           */
-    real        nr_frames = 0;
-    int*        slCount;      /* nr. of atoms in one slice                      */
-    real        sdbangle = 0; /* sum of these angles                            */
-    gmx_bool    use_unitvector = FALSE; /* use a specified unit vector instead of axis to specify unit normal*/
+    real nr_frames = 0;
+    int* slCount;                /* nr. of atoms in one slice                      */
+    real sdbangle           = 0; /* sum of these angles                            */
+    gmx_bool use_unitvector = FALSE; /* use a specified unit vector instead of axis to specify unit normal*/
     rvec        direction, com;
     int         comsize, distsize;
     int *       comidx = nullptr, *distidx = nullptr;
index 44dffff46d3b1601c729fccc3743b4d4bd1dbb27..462967fd1cd667cdf54f681b23d210b1aef9954b 100644 (file)
@@ -333,13 +333,13 @@ static void pick_minima(const char* logfile, int* ibox, int ndim, int len, real
                         this_min.ener  = W[this_min.index];
                         if (is_local_minimum_from_below(&this_min, i, 0, index3(ibox, i - 1, j, k), W)
                             && is_local_minimum_from_above(
-                                       &this_min, i, ibox[0] - 1, index3(ibox, i + 1, j, k), W)
+                                    &this_min, i, ibox[0] - 1, index3(ibox, i + 1, j, k), W)
                             && is_local_minimum_from_below(&this_min, j, 0, index3(ibox, i, j - 1, k), W)
                             && is_local_minimum_from_above(
-                                       &this_min, j, ibox[1] - 1, index3(ibox, i, j + 1, k), W)
+                                    &this_min, j, ibox[1] - 1, index3(ibox, i, j + 1, k), W)
                             && is_local_minimum_from_below(&this_min, k, 0, index3(ibox, i, j, k - 1), W)
                             && is_local_minimum_from_above(
-                                       &this_min, k, ibox[2] - 1, index3(ibox, i, j, k + 1), W))
+                                    &this_min, k, ibox[2] - 1, index3(ibox, i, j, k + 1), W))
                         {
                             add_minimum(fp, nmin, &this_min, mm);
                             nmin++;
@@ -384,11 +384,11 @@ static void pick_minima(const char* logfile, int* ibox, int ndim, int len, real
                     this_point[i]--;
                     bMin = bMin
                            && is_local_minimum_from_below(
-                                      &this_min, index, 0, indexn(ndim, ibox, this_point), W);
+                                   &this_min, index, 0, indexn(ndim, ibox, this_point), W);
                     this_point[i] += 2;
                     bMin = bMin
                            && is_local_minimum_from_above(
-                                      &this_min, index, ibox[i] - 1, indexn(ndim, ibox, this_point), W);
+                                   &this_min, index, ibox[i] - 1, indexn(ndim, ibox, this_point), W);
                     this_point[i]--;
                 }
                 if (bMin)
index 55be0a50c6f094bcbffe014ac2feb85e57f9475e..f747c892990f1af2e5123dc1b44460fabc7d041d 100644 (file)
@@ -172,8 +172,8 @@ typedef struct
     double*  k;     //!< force constants for the nPull coords
     double*  pos;   //!< umbrella positions for the nPull coords
     double* z; //!< z=(-Fi/kT) for the nPull coords. These values are iteratively computed during wham
-    int* N;    //!< nr of data points in nPull histograms.
-    int* Ntot; //!< also nr of data points. N and Ntot only differ if bHistEq==TRUE
+    int*    N;    //!< nr of data points in nPull histograms.
+    int*    Ntot; //!< also nr of data points. N and Ntot only differ if bHistEq==TRUE
 
     /*! \brief  g = 1 + 2*tau[int]/dt where tau is the integrated autocorrelation time.
      *
@@ -229,10 +229,10 @@ typedef struct UmbrellaOptions // NOLINT(clang-analyzer-optin.performance.Paddin
      * \name Basic WHAM options
      */
     /*!\{*/
-    int      bins; //!< nr of bins, min, max, and dz of profile
-    real     min, max, dz;
-    real     Temperature, Tolerance; //!< temperature, converged when probability changes less than Tolerance
-    gmx_bool bCycl;                  //!< generate cyclic (periodic) PMF
+    int  bins; //!< nr of bins, min, max, and dz of profile
+    real min, max, dz;
+    real Temperature, Tolerance; //!< temperature, converged when probability changes less than Tolerance
+    gmx_bool bCycl;              //!< generate cyclic (periodic) PMF
     /*!\}*/
     /*!
      * \name Output control
index 6f51cee1719de33b9676c411f265f135c23f09b8..d73bc7fb0eca796d1fe8b57cbf7160d3f497b34e 100644 (file)
@@ -217,7 +217,7 @@ static void nb_free_energy_kernel(const t_nblist&                nlist,
                                   gmx::ArrayRef<real>            dvdl,
                                   gmx::ArrayRef<real>            energygrp_elec,
                                   gmx::ArrayRef<real>            energygrp_vdw,
-                                  t_nrnb* gmx_restrict nrnb)
+                                  t_nrnb* gmx_restrict           nrnb)
 {
 #define STATE_A 0
 #define STATE_B 1
@@ -370,7 +370,7 @@ static void nb_free_energy_kernel(const t_nblist&                nlist,
     }
 
     // TODO: We should get rid of using pointers to real
-    const real* x             = coords[0];
+    const real*        x      = coords[0];
     real* gmx_restrict f      = &(forceWithShiftForces->force()[0][0]);
     real* gmx_restrict fshift = &(forceWithShiftForces->shiftForces()[0][0]);
 
@@ -881,7 +881,7 @@ typedef void (*KernelFunction)(const t_nblist&                nlist,
                                gmx::ArrayRef<real>            dvdl,
                                gmx::ArrayRef<real>            energygrp_elec,
                                gmx::ArrayRef<real>            energygrp_vdw,
-                               t_nrnb* gmx_restrict nrnb);
+                               t_nrnb* gmx_restrict           nrnb);
 
 template<bool useSoftCore, bool scLambdasOrAlphasDiffer, bool vdwInteractionTypeIsEwald, bool elecInteractionTypeIsEwald, bool vdwModifierIsPotSwitch>
 static KernelFunction dispatchKernelOnUseSimd(const bool useSimd)
index 534b7527d6c412adc651cf36589a9ad279c3a807..3a04f196cb8699f2e1151950b80aef1f9787fe3e 100644 (file)
@@ -71,6 +71,6 @@ void gmx_nb_free_energy_kernel(const t_nblist&                nlist,
                                gmx::ArrayRef<real>            dvdl,
                                gmx::ArrayRef<real>            energygrp_elec,
                                gmx::ArrayRef<real>            energygrp_vdw,
-                               t_nrnb* gmx_restrict nrnb);
+                               t_nrnb* gmx_restrict           nrnb);
 
 #endif
index 448b5de2fa47a2d78d95ed80fe1a265e22c304bf..72caa6c88e4531ac5566e4ce36abe307a6571fed 100644 (file)
@@ -98,11 +98,7 @@ struct VirtualSiteConfiguration
                                       int                nhyd,
                                       const std::string& nextheavy,
                                       const std::string& dummy) :
-        atomtype(type),
-        isplanar(planar),
-        nHydrogens(nhyd),
-        nextHeavyType(nextheavy),
-        dummyMass(dummy)
+        atomtype(type), isplanar(planar), nHydrogens(nhyd), nextHeavyType(nextheavy), dummyMass(dummy)
     {
     }
     //! Type for the XH3/XH2 atom.
@@ -152,9 +148,7 @@ struct VirtualSiteTopology
          * \param[in] v Value for distance.
          */
         VirtualSiteBond(const std::string& a1, const std::string& a2, real v) :
-            atom1(a1),
-            atom2(a2),
-            value(v)
+            atom1(a1), atom2(a2), value(v)
         {
         }
         //! Atom 1 in bond.
@@ -178,10 +172,7 @@ struct VirtualSiteTopology
          * \param[in] v Value for angle.
          */
         VirtualSiteAngle(const std::string& a1, const std::string& a2, const std::string& a3, real v) :
-            atom1(a1),
-            atom2(a2),
-            atom3(a3),
-            value(v)
+            atom1(a1), atom2(a2), atom3(a3), value(v)
         {
         }
         //! Atom 1 in angle.
index b9c8680c2ef9310cffb36646e6ffefea4f297764..c1926e4c6cdc9d82e29e0aa989ea67727f6d2748 100644 (file)
@@ -337,9 +337,13 @@ static int check_atoms_present(const t_atoms*                            pdba,
                     nadd--;
                     break;
                 }
-                case MoleculePatchType::Replace: { break;
+                case MoleculePatchType::Replace:
+                {
+                    break;
                 }
-                default: { GMX_THROW(gmx::InternalError("Case not handled"));
+                default:
+                {
+                    GMX_THROW(gmx::InternalError("Case not handled"));
                 }
             }
         }
index 429de6bd30245ec78a588539bdcc910f2b0689c4..8c2c60ab3dda1343e6d532e36fd37ecca798cec5 100644 (file)
@@ -61,11 +61,7 @@ struct AtomTypeData
 {
     //! Explicit constructor.
     AtomTypeData(const t_atom& a, char** name, const InteractionOfType& nb, const int bondAtomType, const int atomNumber) :
-        atom_(a),
-        name_(name),
-        nb_(nb),
-        bondAtomType_(bondAtomType),
-        atomNumber_(atomNumber)
+        atom_(a), name_(name), nb_(nb), bondAtomType_(bondAtomType), atomNumber_(atomNumber)
     {
     }
     //! Actual atom data.
index 82051635a1804a73a7d1147831e10294af67ce6a..9e6eabffd0594ee47bd5df65150a4da898df828d 100644 (file)
@@ -111,8 +111,7 @@ struct VsiteBondParameter
 {
     //! Constructor initializes datastructure.
     VsiteBondParameter(int ftype, const InteractionOfType& vsiteInteraction) :
-        ftype_(ftype),
-        vsiteInteraction_(vsiteInteraction)
+        ftype_(ftype), vsiteInteraction_(vsiteInteraction)
     {
     }
     //! Function type for virtual site.
@@ -424,11 +423,11 @@ static bool calc_vsite3_param(PreprocessingAtomTypes*                     atypes
      * i.e. if atom k and l are dummy masses (MNH* or MCH3*) */
     bXH3 = ((gmx::equalCaseInsensitive(get_atomtype_name_AB(&at->atom[vsite->ak()], atypes), "MNH", 3))
             && (gmx::equalCaseInsensitive(
-                       get_atomtype_name_AB(&at->atom[vsite->al()], atypes), "MNH", 3)))
+                    get_atomtype_name_AB(&at->atom[vsite->al()], atypes), "MNH", 3)))
            || ((gmx::equalCaseInsensitive(
                        get_atomtype_name_AB(&at->atom[vsite->ak()], atypes), "MCH3", 4))
                && (gmx::equalCaseInsensitive(
-                          get_atomtype_name_AB(&at->atom[vsite->al()], atypes), "MCH3", 4)));
+                       get_atomtype_name_AB(&at->atom[vsite->al()], atypes), "MCH3", 4)));
 
     bjk    = get_bond_length(bonds, vsite->aj(), vsite->ak());
     bjl    = get_bond_length(bonds, vsite->aj(), vsite->al());
@@ -566,11 +565,11 @@ static bool calc_vsite3out_param(PreprocessingAtomTypes*                     aty
      * i.e. if atom k and l are dummy masses (MNH* or MCH3*) */
     bXH3 = ((gmx::equalCaseInsensitive(get_atomtype_name_AB(&at->atom[vsite->ak()], atypes), "MNH", 3))
             && (gmx::equalCaseInsensitive(
-                       get_atomtype_name_AB(&at->atom[vsite->al()], atypes), "MNH", 3)))
+                    get_atomtype_name_AB(&at->atom[vsite->al()], atypes), "MNH", 3)))
            || ((gmx::equalCaseInsensitive(
                        get_atomtype_name_AB(&at->atom[vsite->ak()], atypes), "MCH3", 4))
                && (gmx::equalCaseInsensitive(
-                          get_atomtype_name_AB(&at->atom[vsite->al()], atypes), "MCH3", 4)));
+                       get_atomtype_name_AB(&at->atom[vsite->al()], atypes), "MCH3", 4)));
 
     /* check if construction parity must be swapped */
     bSwapParity = (vsite->c1() == -1);
@@ -953,8 +952,7 @@ class VsiteAtomMapping
 public:
     //! Only construct with all information in place or nothing
     VsiteAtomMapping(int functionType, int interactionIndex) :
-        functionType_(functionType),
-        interactionIndex_(interactionIndex)
+        functionType_(functionType), interactionIndex_(interactionIndex)
     {
     }
     VsiteAtomMapping() : functionType_(-1), interactionIndex_(-1) {}
index 876afdef94c6241d2b86adc6b32d52b9d1dac2ae..de2544bd6a6d40aa540b14554ffe25a3a67f8acc 100644 (file)
@@ -282,7 +282,8 @@ static void calc_angles_dihs(InteractionsOfType* ang, InteractionsOfType* dih, c
         int  al = dihedral.al();
         real ph =
                 gmx::c_rad2Deg
-                * dih_angle(x[ai], x[aj], x[ak], x[al], bPBC ? &pbc : nullptr, r_ij, r_kj, r_kl, m, n, &t1, &t2, &t3);
+                * dih_angle(
+                        x[ai], x[aj], x[ak], x[al], bPBC ? &pbc : nullptr, r_ij, r_kj, r_kl, m, n, &t1, &t2, &t3);
         dihedral.setForceParameter(0, ph);
     }
 }
index 7b4f88f31d9c82619f04247a6d1b563adb376801..a3434d303976f71b5ec1ccc3d31078166991042f 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2020, by the GROMACS development team, led by
+ * Copyright (c) 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.
@@ -50,8 +50,7 @@
 
 //! Constructor
 DeviceContext::DeviceContext(const DeviceInformation& deviceInfo) :
-    deviceInfo_(deviceInfo),
-    context_(cl::sycl::context(deviceInfo.syclDevice))
+    deviceInfo_(deviceInfo), context_(cl::sycl::context(deviceInfo.syclDevice))
 {
 }
 
index dd95c9128fbb97b44ad9128fa1bc6859c9f6ab11..30fe06e9bc00db2d6e994c97634c32ad7ec67e29 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2012,2018,2019, by the GROMACS development team, led by
+ * Copyright (c) 2012,2018,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.
@@ -58,7 +58,8 @@
  */
 gmx_opencl_inline void atomicAdd_l_f(volatile __local float* addr, float val)
 {
-    union {
+    union
+    {
         unsigned int u32;
         float        f32;
     } next, expected, current;
@@ -96,7 +97,8 @@ gmx_opencl_inline void atomicAdd_l_f3(__local float3* addr, float3 val)
  */
 gmx_opencl_inline void atomicAdd_g_f(volatile __global float* addr, float val)
 {
-    union {
+    union
+    {
         unsigned int u32;
         float        f32;
     } next, expected, current;
index 8adaf08eefef775c53f83c97c5f12c5b4c6bef28..32505f783dce616b36e3fd9bf965e23b5a429a8f 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2016,2017,2018,2019,2020, by the GROMACS development team, led by
+ * Copyright (c) 2016,2017,2018,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.
@@ -94,7 +94,7 @@ public:
         {
             if (events_[i]) // This conditional is ugly, but is required to make some tests (e.g. empty domain) pass
             {
-                cl_ulong start_ns, end_ns;
+                cl_ulong          start_ns, end_ns;
                 cl_int gmx_unused cl_error;
 
                 cl_error = clGetEventProfilingInfo(
index 82c50f0e19d6025efa9e23a4895cbbbc48c97cb9..7ea989e74d03d2fea94b96c9aafc7efe20138297 100644 (file)
@@ -548,10 +548,11 @@ void renumberIndex(std::vector<unsigned int>* v)
     for (std::size_t i = 0; i < uniqueSortedV.size(); i++)
     {
         unsigned int val = uniqueSortedV[i];
-        std::replace_if(v->begin(),
-                        v->end(),
-                        [val](unsigned int& c) -> bool { return c == val; },
-                        static_cast<unsigned int>(i));
+        std::replace_if(
+                v->begin(),
+                v->end(),
+                [val](unsigned int& c) -> bool { return c == val; },
+                static_cast<unsigned int>(i));
     }
 }
 
@@ -1089,11 +1090,7 @@ CpuInfo CpuInfo::detect()
 }
 
 CpuInfo::CpuInfo() :
-    vendor_(CpuInfo::Vendor::Unknown),
-    brandString_("Unknown CPU brand"),
-    family_(0),
-    model_(0),
-    stepping_(0)
+    vendor_(CpuInfo::Vendor::Unknown), brandString_("Unknown CPU brand"), family_(0), model_(0), stepping_(0)
 {
 }
 
index 2325c71bd1826cffa156cb373e56620109899653..e13a58b5b8bfa3bef00310ca533a995c1bd429ab 100644 (file)
@@ -2,7 +2,7 @@
  * This file is part of the GROMACS molecular simulation package.
  *
  * Copyright (c) 2012,2013,2014,2015,2016, The GROMACS development team.
- * Copyright (c) 2017,2018,2019,2020, by the GROMACS development team, led by
+ * Copyright (c) 2017,2018,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.
@@ -71,8 +71,7 @@
 
 gmx_hw_info_t::gmx_hw_info_t(std::unique_ptr<gmx::CpuInfo>          cpuInfo,
                              std::unique_ptr<gmx::HardwareTopology> hardwareTopology) :
-    cpuInfo(std::move(cpuInfo)),
-    hardwareTopology(std::move(hardwareTopology))
+    cpuInfo(std::move(cpuInfo)), hardwareTopology(std::move(hardwareTopology))
 {
 }
 
index 04d8ab543c5c2b4d3cbb6fe18193f902125a0a99..8923fe3e403fa0c4c2bcc74a54344c4fbdd9fdee 100644 (file)
@@ -171,8 +171,7 @@ static bool isDeviceFunctional(const cl::sycl::device& syclDevice, std::string*
                  cgh.parallel_for<class DummyKernel>(range, [=](cl::sycl::id<1> threadId) {
                      d_buffer[threadId] = threadId.get(0);
                  });
-             })
-                .wait_and_throw();
+             }).wait_and_throw();
         const auto h_Buffer = buffer.get_access<cl::sycl::access::mode::read>();
         for (int i = 0; i < numThreads; i++)
         {
index 25330ef66311bd017d1691a5492d670b2a733c79..7ab562e39c5e5fd6eb36eb48996ddb552031b42b 100644 (file)
@@ -737,16 +737,12 @@ HardwareTopology::Machine::Machine()
 
 
 HardwareTopology::HardwareTopology() :
-    supportLevel_(SupportLevel::None),
-    machine_(),
-    isThisSystem_(true)
+    supportLevel_(SupportLevel::None), machine_(), isThisSystem_(true)
 {
 }
 
 HardwareTopology::HardwareTopology(int logicalProcessorCount) :
-    supportLevel_(SupportLevel::None),
-    machine_(),
-    isThisSystem_(true)
+    supportLevel_(SupportLevel::None), machine_(), isThisSystem_(true)
 {
     if (logicalProcessorCount > 0)
     {
index 065cb1d42bc76acc381b5d8af395bb4d61914811..8f8f22972d9395ccfbc8d4624c6e3f34cf7ea6b9 100644 (file)
@@ -126,8 +126,8 @@ public:
     /*! \libinternal \brief Information about a single numa node */
     struct Numa
     {
-        std::vector<NumaNode> nodes;                     //!< Information about each numa node
-        float                 baseLatency;               //!< Scale factor for relative latencies
+        std::vector<NumaNode>           nodes;       //!< Information about each numa node
+        float                           baseLatency; //!< Scale factor for relative latencies
         std::vector<std::vector<float>> relativeLatency; //!< 2D matrix of relative latencies between nodes
         float                           maxRelativeLatency; //!< Largest relative latency
     };
index 87c06ee74f65b3dc3ec386a196050190f115bc52..06a895acc471d11cb219c266bcb0bcfd5647fe61 100644 (file)
@@ -820,7 +820,7 @@ real water_pol(int             nbonds,
                rvec4           f[],
                rvec gmx_unused fshift[],
                const t_pbc gmx_unused* pbc,
-               real gmx_unused lambda,
+               real gmx_unused         lambda,
                real gmx_unused*          dvdlambda,
                gmx::ArrayRef<const real> charge,
                t_fcdata gmx_unused* fcd,
@@ -2568,14 +2568,14 @@ real dihres(int             nbonds,
 }
 
 
-real unimplemented(int gmx_unused nbonds,
-                   const t_iatom gmx_unused forceatoms[],
+real unimplemented(int gmx_unused             nbonds,
+                   const t_iatom gmx_unused   forceatoms[],
                    const t_iparams gmx_unused forceparams[],
-                   const rvec gmx_unused x[],
-                   rvec4 gmx_unused f[],
-                   rvec gmx_unused fshift[],
+                   const rvec gmx_unused      x[],
+                   rvec4 gmx_unused           f[],
+                   rvec gmx_unused            fshift[],
                    const t_pbc gmx_unused* pbc,
-                   real gmx_unused lambda,
+                   real gmx_unused         lambda,
                    real gmx_unused* dvdlambda,
                    gmx::ArrayRef<const real> /*charge*/,
                    t_fcdata gmx_unused* fcd,
@@ -3091,7 +3091,7 @@ real cmap_dihs(int                 nbonds,
                rvec4               f[],
                rvec                fshift[],
                const struct t_pbc* pbc,
-               real gmx_unused lambda,
+               real gmx_unused     lambda,
                real gmx_unused* dvdlambda,
                gmx::ArrayRef<const real> /*charge*/,
                t_fcdata gmx_unused* fcd,
index 7a2b6282b91b064588fbe2441aae6f73ea89cc48..63474319c8e4ec32885e54fc5729b140ffc2429f 100644 (file)
@@ -126,7 +126,7 @@ real cmap_dihs(int                 nbonds,
                rvec4               f[],
                rvec                fshift[],
                const struct t_pbc* pbc,
-               real gmx_unused lambda,
+               real gmx_unused     lambda,
                real gmx_unused* dvdlambda,
                gmx::ArrayRef<const real> /*charge*/,
                t_fcdata gmx_unused* fcd,
index e22a49ba95bc847dfe3326525b8ea134f5cbbf62..34a2627bd0b1ead3aa3e0d9afcb75afb035d9cfa 100644 (file)
@@ -419,7 +419,7 @@ real ta_disres(int              nfa,
                rvec4*           f,
                rvec*            fshift,
                const t_pbc*     pbc,
-               real gmx_unused lambda,
+               real gmx_unused  lambda,
                real gmx_unused* dvdlambda,
                gmx::ArrayRef<const real> /*charge*/,
                t_fcdata gmx_unused* fcd,
index c5fbd00e4669d0b46f918bb250fdd3236e4d4c73..48bd3f836060d807d1172d6d4583ba80d9a9457b 100644 (file)
@@ -72,8 +72,7 @@ GpuBonded::Impl::Impl(const gmx_ffparams_t& ffparams,
                       const DeviceContext&  deviceContext,
                       const DeviceStream&   deviceStream,
                       gmx_wallcycle*        wcycle) :
-    deviceContext_(deviceContext),
-    deviceStream_(deviceStream)
+    deviceContext_(deviceContext), deviceStream_(deviceStream)
 {
     GMX_RELEASE_ASSERT(deviceStream.isValid(),
                        "Can't run GPU version of bonded forces in stream that is not valid.");
index 1537c58d58b653252441cfe63547f3c06f527ade..8ab52bf5b408110df131f7cfd671c86cc2bfde3e 100644 (file)
@@ -79,7 +79,7 @@
 
 /* Harmonic */
 __device__ __forceinline__ static void
-           harmonic_gpu(const float kA, const float xA, const float x, float* V, float* F)
+harmonic_gpu(const float kA, const float xA, const float x, float* V, float* F)
 {
     constexpr float half = 0.5f;
     float           dx, dx2;
@@ -369,7 +369,7 @@ __device__ __forceinline__ static float dih_angle_gpu(const T        xi,
 
 
 __device__ __forceinline__ static void
-           dopdihs_gpu(const float cpA, const float phiA, const int mult, const float phi, float* v, float* f)
+dopdihs_gpu(const float cpA, const float phiA, const int mult, const float phi, float* v, float* f)
 {
     float mdphi, sdphi;
 
@@ -380,22 +380,22 @@ __device__ __forceinline__ static void
 }
 
 template<bool calcVir>
-__device__ static void do_dih_fup_gpu(const int      i,
-                                      const int      j,
-                                      const int      k,
-                                      const int      l,
-                                      const float    ddphi,
-                                      const float3   r_ij,
-                                      const float3   r_kj,
-                                      const float3   r_kl,
-                                      const float3   m,
-                                      const float3   n,
-                                      float3         gm_f[],
-                                      float3         sm_fShiftLoc[],
-                                      const PbcAiuc& pbcAiuc,
-                                      const float4   gm_xq[],
-                                      const int      t1,
-                                      const int      t2,
+__device__ static void do_dih_fup_gpu(const int            i,
+                                      const int            j,
+                                      const int            k,
+                                      const int            l,
+                                      const float          ddphi,
+                                      const float3         r_ij,
+                                      const float3         r_kj,
+                                      const float3         r_kl,
+                                      const float3         m,
+                                      const float3         n,
+                                      float3               gm_f[],
+                                      float3               sm_fShiftLoc[],
+                                      const PbcAiuc&       pbcAiuc,
+                                      const float4         gm_xq[],
+                                      const int            t1,
+                                      const int            t2,
                                       const int gmx_unused t3)
 {
     float iprm  = norm2(m);
index 1a734aa51c39d58ff1ae547538e407203f141a7a..137ebfd4407033245652566b95f8a9e65357571f 100644 (file)
@@ -101,8 +101,7 @@ constexpr int c_numAtoms = 3;
 struct OutputQuantities
 {
     OutputQuantities(int energyGroup) :
-        energy(energyGroup),
-        dvdLambda(static_cast<int>(FreeEnergyPerturbationCouplingType::Count), 0.0)
+        energy(energyGroup), dvdLambda(static_cast<int>(FreeEnergyPerturbationCouplingType::Count), 0.0)
     {
     }
 
index b6489475c30a5a131978750827b4732b29a0a199..ee60701610ec47f2fafc1faff4589d3e347b3595 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2018,2019,2020, by the GROMACS development team, led by
+ * Copyright (c) 2018,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.
@@ -99,25 +99,19 @@ public:
      * Passed pointers must remain valid for the lifetime of this object.
      */
     ArrayRefWithPadding(pointer begin, pointer end, pointer paddedEnd) :
-        begin_(begin),
-        end_(end),
-        paddedEnd_(paddedEnd)
+        begin_(begin), end_(end), paddedEnd_(paddedEnd)
     {
         GMX_ASSERT(end >= begin, "Invalid range");
         GMX_ASSERT(paddedEnd >= end, "Invalid range");
     }
     //! Copy constructor
     ArrayRefWithPadding(const ArrayRefWithPadding& o) :
-        begin_(o.begin_),
-        end_(o.end_),
-        paddedEnd_(o.paddedEnd_)
+        begin_(o.begin_), end_(o.end_), paddedEnd_(o.paddedEnd_)
     {
     }
     //! Move constructor
     ArrayRefWithPadding(ArrayRefWithPadding&& o) noexcept :
-        begin_(std::move(o.begin_)),
-        end_(std::move(o.end_)),
-        paddedEnd_(std::move(o.paddedEnd_))
+        begin_(std::move(o.begin_)), end_(std::move(o.end_)), paddedEnd_(std::move(o.paddedEnd_))
     {
     }
     /*! \brief Convenience overload constructor to make an ArrayRefWithPadding<const T> from a non-const one.
index 6555d96e2db2e072e0e8f9374ad04e3582e3f3c1..9001f1c93e18fcac3bc8057c2c56a014e858e9da 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * 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.
@@ -147,8 +147,7 @@ public:
 };
 
 TranslateAndScale::Impl::Impl(const RVec& scale, const RVec& translation) :
-    scale_{ scale },
-    translation_{ translation }
+    scale_{ scale }, translation_{ translation }
 {
 }
 
index 6cfcc15305d1afddeb78621d299067890a059e4e..1b8dc3bf9963e3686cf7352aff82c86cbd5f79ce 100644 (file)
@@ -98,8 +98,7 @@ private:
 };
 
 DensitySimilarityInnerProduct::DensitySimilarityInnerProduct(density referenceDensity) :
-    referenceDensity_{ referenceDensity },
-    gradient_{ referenceDensity.extents() }
+    referenceDensity_{ referenceDensity }, gradient_{ referenceDensity.extents() }
 {
     const auto numVoxels = gradient_.asConstView().mapping().required_span_size();
     /* the gradient for the inner product measure of fit is constant and does not
@@ -184,8 +183,7 @@ private:
 };
 
 DensitySimilarityRelativeEntropy::DensitySimilarityRelativeEntropy(density referenceDensity) :
-    referenceDensity_{ referenceDensity },
-    gradient_(referenceDensity.extents())
+    referenceDensity_{ referenceDensity }, gradient_(referenceDensity.extents())
 {
 }
 
@@ -330,8 +328,7 @@ private:
 };
 
 DensitySimilarityCrossCorrelation::DensitySimilarityCrossCorrelation(density referenceDensity) :
-    referenceDensity_{ referenceDensity },
-    gradient_(referenceDensity.extents())
+    referenceDensity_{ referenceDensity }, gradient_(referenceDensity.extents())
 {
 }
 
index a539062ac770db943f504285eb952e29a13ff62b..8f52f282bc1a7a5196524927cbd7a9276f8277a6 100644 (file)
@@ -250,8 +250,8 @@ IVec rangeEndWithinLattice(const IVec& index, const dynamicExtents3D& extents, c
  * OuterProductEvaluator
  */
 
-mdspan<const float, dynamic_extent, dynamic_extent> OuterProductEvaluator::
-                                                    operator()(ArrayRef<const float> x, ArrayRef<const float> y)
+mdspan<const float, dynamic_extent, dynamic_extent>
+OuterProductEvaluator::operator()(ArrayRef<const float> x, ArrayRef<const float> y)
 {
     data_.resize(ssize(x), ssize(y));
     for (gmx::index xIndex = 0; xIndex < ssize(x); ++xIndex)
index 8f6047cc400f8c99ca4c6ed2fe06d2b5be8649e6..867ac725f2e5ec6c135e578a02859910e7198162 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * 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.
@@ -159,14 +159,12 @@ public:
     }
     //! Copy constructor
     constexpr MultiDimArray(const MultiDimArray& o) :
-        data_(o.data_),
-        view_(data_.data(), o.view_.extents())
+        data_(o.data_), view_(data_.data(), o.view_.extents())
     {
     }
     //! Move constructor
     MultiDimArray(MultiDimArray&& o) noexcept :
-        data_(std::move(o.data_)),
-        view_(data_.data(), o.view_.extents())
+        data_(std::move(o.data_)), view_(data_.data(), o.view_.extents())
     {
     }
     //! Copy assignment
index 033af87c52ad1c6ef94fea7895e863f30d7c2334..3664c735e171d10d93f1a46a3602152a1f7dea75 100644 (file)
@@ -231,8 +231,7 @@ public:
     PaddedVector() : storage_(), unpaddedEnd_(begin()) {}
     /*! \brief Constructor that specifies the initial size. */
     explicit PaddedVector(size_type count, const allocator_type& allocator = Allocator()) :
-        storage_(count, allocator),
-        unpaddedEnd_(begin() + count)
+        storage_(count, allocator), unpaddedEnd_(begin() + count)
     {
         // The count elements have been default inserted, and now
         // the padding elements are added
@@ -240,8 +239,7 @@ public:
     }
     /*! \brief Constructor that specifies the initial size and an element to copy. */
     explicit PaddedVector(size_type count, value_type const& v, const allocator_type& allocator = Allocator()) :
-        storage_(count, v, allocator),
-        unpaddedEnd_(begin() + count)
+        storage_(count, v, allocator), unpaddedEnd_(begin() + count)
     {
         // The count elements have been default inserted, and now
         // the padding elements are added
@@ -249,8 +247,7 @@ public:
     }
     //! Default constructor with allocator
     explicit PaddedVector(allocator_type const& allocator) :
-        storage_(allocator),
-        unpaddedEnd_(begin())
+        storage_(allocator), unpaddedEnd_(begin())
     {
     }
     //! Copy constructor
@@ -260,8 +257,7 @@ public:
      * Leaves \c o in a valid state (ie the destructor can be
      * called). */
     PaddedVector(PaddedVector&& o) noexcept :
-        storage_(std::exchange(o.storage_, {})),
-        unpaddedEnd_(o.unpaddedEnd_)
+        storage_(std::exchange(o.storage_, {})), unpaddedEnd_(o.unpaddedEnd_)
     {
     }
     /*! \brief Move constructor using \c alloc for the new vector.
@@ -274,8 +270,7 @@ public:
      * Leaves \c o in a valid state (ie. the destructor can be
      * called). */
     PaddedVector(PaddedVector&& o, const Allocator& alloc) noexcept :
-        storage_(alloc),
-        unpaddedEnd_(begin())
+        storage_(alloc), unpaddedEnd_(begin())
     {
         if (alloc == o.storage_.get_allocator())
         {
@@ -294,8 +289,7 @@ public:
     }
     //! Construct from an initializer list
     PaddedVector(std::initializer_list<value_type> const& il) :
-        storage_(il),
-        unpaddedEnd_(storage_.end())
+        storage_(il), unpaddedEnd_(storage_.end())
     {
         // We can't choose the padding until we know the size of
         // the normal vector, so we have to make the storage_ and
index 3a142ac98a2d517dd1c42291145219c736d73ab9..5c82d9d26fec40e3c6ae193917ed94d0b8753279 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2020, by the GROMACS development team, led by
+ * Copyright (c) 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.
@@ -66,8 +66,7 @@ class NelderMeadSimplexTest : public ::testing::Test
 public:
     //! Set up a one-d, two-vertices Nelder-Mead simplex
     NelderMeadSimplexTest() :
-        initialGuess_{ 1 },
-        simplex_{ NelderMeadSimplexTest::doubleFirstCoordinateValue, initialGuess_ }
+        initialGuess_{ 1 }, simplex_{ NelderMeadSimplexTest::doubleFirstCoordinateValue, initialGuess_ }
     {
     }
 
index e42a95fe46d7f15cdce072d993a8e520a6d475d9..afc22d4565aee0cc187998fd5ddf8145250c6230 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2018,2019,2020, by the GROMACS development team, led by
+ * Copyright (c) 2018,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.
@@ -101,8 +101,7 @@ BoxDeformation::BoxDeformation(double        timeStep,
                                int64_t       initialStep,
                                const tensor& deformationTensor,
                                const matrix& referenceBox) :
-    timeStep_(timeStep),
-    initialStep_(initialStep)
+    timeStep_(timeStep), initialStep_(initialStep)
 {
     copy_mat(deformationTensor, deformationTensor_);
     copy_mat(referenceBox, referenceBox_);
index f29ff7303b793d2c7159a0874ea322f8944e7281..4ef9cd3d6b0e6f3a6d0071fc12cbc699afa5ba34 100644 (file)
@@ -1311,7 +1311,7 @@ static real chanceOfUpdateGroupCrossingCell(const gmx_mtop_t&      mtop,
         const gmx_moltype_t& moltype = mtop.moltype[molblock.type];
         chance += molblock.nmol
                   * chanceOfUpdateGroupCrossingCell(
-                            moltype, mtop.ffparams, updateGrouping[molblock.type], kT_fac, cellSize);
+                          moltype, mtop.ffparams, updateGrouping[molblock.type], kT_fac, cellSize);
     }
 
     return chance;
index e6c3613f49e112f97e614f10a753253d921a53d5..c9a288d8a43b8ecd670a51e5f33d6fa05b82e2f2 100644 (file)
@@ -881,8 +881,8 @@ void calculateScalingMatrixImplDetail<PressureCoupling::Berendsen>(const t_input
                                                                    real              dt,
                                                                    const matrix      pres,
                                                                    const matrix      box,
-                                                                   real    scalar_pressure,
-                                                                   real    xy_pressure,
+                                                                   real scalar_pressure,
+                                                                   real xy_pressure,
                                                                    int64_t gmx_unused step)
 {
     real p_corr_z = 0;
index 631e7b1dade7cb1a4a6a4064402aa5e87e26b8f5..cc19e024dfcdcff19b9eabe3c3ae8896ce30ec96 100644 (file)
@@ -1195,12 +1195,12 @@ void EnergyOutput::printStepToEnergyFile(ener_file* fp_ene,
     {
         t_oriresdata& orires = *fcd->orires;
         diagonalize_orires_tensors(&orires);
-        nr[enxOR]    = orires.numRestraints;
-        block[enxOR] = orires.orientationsTimeAndEnsembleAv.data();
-        id[enxOR]    = enxOR;
-        nr[enxORI]   = (orires.orientations.data() != orires.orientationsTimeAndEnsembleAv.data())
-                             ? orires.numRestraints
-                             : 0;
+        nr[enxOR]     = orires.numRestraints;
+        block[enxOR]  = orires.orientationsTimeAndEnsembleAv.data();
+        id[enxOR]     = enxOR;
+        nr[enxORI]    = (orires.orientations.data() != orires.orientationsTimeAndEnsembleAv.data())
+                                ? orires.numRestraints
+                                : 0;
         block[enxORI] = orires.orientations.data();
         id[enxORI]    = enxORI;
         nr[enxORT]    = ssize(orires.eigenOutput);
index 025cdac6573216f416f977d3c0cf022259a703ff..51807ab3bc34aa9ed62d9050b809fac81765a4f5 100644 (file)
@@ -1479,7 +1479,7 @@ int ExpandedEnsembleDynamics(FILE*                               log,
             {
                 told              = ir->opts.ref_t[i];
                 ir->opts.ref_t[i] = simtemp->temperatures[lamnew];
-                buf_ngtc[i]       = std::sqrt(ir->opts.ref_t[i] / told); /* using the buffer as temperature scaling */
+                buf_ngtc[i] = std::sqrt(ir->opts.ref_t[i] / told); /* using the buffer as temperature scaling */
             }
         }
 
index 6d94b641cf5295cb3df9f24051e7f7161370456c..91c72b198ae66334547acf63d9f1e0bcabe142c0 100644 (file)
@@ -240,9 +240,9 @@ static void manage_number_of_openmp_threads(const gmx::MDLogger& mdlog,
                                             int                  nthreads_hw_avail,
                                             int                  omp_nthreads_req,
                                             int                  omp_nthreads_pme_req,
-                                            gmx_bool gmx_unused bThisNodePMEOnly,
-                                            int                 numRanksOnThisNode,
-                                            gmx_bool            bSepPME)
+                                            gmx_bool gmx_unused  bThisNodePMEOnly,
+                                            int                  numRanksOnThisNode,
+                                            gmx_bool             bSepPME)
 {
     int   nth;
     char* env;
index 34a7ca9156c69ee72bf1098a7b43d1a7f41d6bfa..ac84c96273ee4eef5f82dc6eaa087852c34c98a9 100644 (file)
@@ -4,7 +4,7 @@
  * Copyright (c) 1991-2000, University of Groningen, The Netherlands.
  * Copyright (c) 2001-2008, The GROMACS development team.
  * Copyright (c) 2012,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.
@@ -59,7 +59,7 @@ void dd_make_local_group_indices(const gmx_ga2la_t* ga2la,
                                  int* nr_loc,     /* OUT: Number of group atoms found locally */
                                  int* anrs_loc[], /* OUT: Local atom numbers of the group  */
                                  int* nalloc_loc, /* IN+OUT: Allocation size of anrs_loc */
-                                 int  coll_ind[]) /* OUT (opt): Where is this position found in the collective array? */
+                                 int coll_ind[]) /* OUT (opt): Where is this position found in the collective array? */
 {
     GMX_ASSERT(ga2la, "We need a valid ga2la object");
 
index 7028e256b85f018d48a7fc58d256851a33ae48c0..0ce1174b336e59d4153c6f923aebbd9ec83231c2 100644 (file)
@@ -313,9 +313,7 @@ void LeapFrogGpu::integrate(DeviceBuffer<Float3>              d_x,
 LeapFrogGpu::LeapFrogGpu(const DeviceContext& deviceContext,
                          const DeviceStream&  deviceStream,
                          const int            numTempScaleValues) :
-    deviceContext_(deviceContext),
-    deviceStream_(deviceStream),
-    numTempScaleValues_(numTempScaleValues)
+    deviceContext_(deviceContext), deviceStream_(deviceStream), numTempScaleValues_(numTempScaleValues)
 {
     numAtoms_ = 0;
 
index 093ff1bec170985b91bd0e6d0f2b5cc173520723..81a0d1173cddc29af1225dbdc7eb78f044be84d3 100644 (file)
@@ -502,13 +502,13 @@ static inline void gmx_simdcall gatherLoadUTransposeTSANSafe(const real*
 static void gmx_simdcall calc_dr_x_f_simd(int                           b0,
                                           int                           b1,
                                           gmx::ArrayRef<const AtomPair> atoms,
-                                          const rvec* gmx_restrict x,
-                                          const rvec* gmx_restrict f,
-                                          const real* gmx_restrict blc,
-                                          const real*              pbc_simd,
-                                          rvec* gmx_restrict r,
-                                          real* gmx_restrict rhs,
-                                          real* gmx_restrict sol)
+                                          const rvec* gmx_restrict      x,
+                                          const rvec* gmx_restrict      f,
+                                          const real* gmx_restrict      blc,
+                                          const real*                   pbc_simd,
+                                          rvec* gmx_restrict            r,
+                                          real* gmx_restrict            rhs,
+                                          real* gmx_restrict            sol)
 {
     assert(b0 % GMX_SIMD_REAL_WIDTH == 0);
 
@@ -757,14 +757,14 @@ static void do_lincsp(ArrayRefWithPadding<const RVec> xPadded,
 static void gmx_simdcall calc_dr_x_xp_simd(int                           b0,
                                            int                           b1,
                                            gmx::ArrayRef<const AtomPair> atoms,
-                                           const rvec* gmx_restrict x,
-                                           const rvec* gmx_restrict xp,
-                                           const real* gmx_restrict bllen,
-                                           const real* gmx_restrict blc,
-                                           const real*              pbc_simd,
-                                           rvec* gmx_restrict r,
-                                           real* gmx_restrict rhs,
-                                           real* gmx_restrict sol)
+                                           const rvec* gmx_restrict      x,
+                                           const rvec* gmx_restrict      xp,
+                                           const real* gmx_restrict      bllen,
+                                           const real* gmx_restrict      blc,
+                                           const real*                   pbc_simd,
+                                           rvec* gmx_restrict            r,
+                                           real* gmx_restrict            rhs,
+                                           real* gmx_restrict            sol)
 {
     assert(b0 % GMX_SIMD_REAL_WIDTH == 0);
     alignas(GMX_SIMD_ALIGNMENT) std::int32_t offset2[GMX_SIMD_REAL_WIDTH];
@@ -829,14 +829,14 @@ static void gmx_simdcall calc_dr_x_xp_simd(int                           b0,
 gmx_unused static void calc_dist_iter(int                           b0,
                                       int                           b1,
                                       gmx::ArrayRef<const AtomPair> atoms,
-                                      const rvec* gmx_restrict xp,
-                                      const real* gmx_restrict bllen,
-                                      const real* gmx_restrict blc,
-                                      const t_pbc*             pbc,
-                                      real                     wfac,
-                                      real* gmx_restrict rhs,
-                                      real* gmx_restrict sol,
-                                      bool*              bWarn)
+                                      const rvec* gmx_restrict      xp,
+                                      const real* gmx_restrict      bllen,
+                                      const real* gmx_restrict      blc,
+                                      const t_pbc*                  pbc,
+                                      real                          wfac,
+                                      real* gmx_restrict            rhs,
+                                      real* gmx_restrict            sol,
+                                      bool*                         bWarn)
 {
     for (int b = b0; b < b1; b++)
     {
@@ -876,14 +876,14 @@ gmx_unused static void calc_dist_iter(int                           b0,
 static void gmx_simdcall calc_dist_iter_simd(int                           b0,
                                              int                           b1,
                                              gmx::ArrayRef<const AtomPair> atoms,
-                                             const rvec* gmx_restrict x,
-                                             const real* gmx_restrict bllen,
-                                             const real* gmx_restrict blc,
-                                             const real*              pbc_simd,
-                                             real                     wfac,
-                                             real* gmx_restrict rhs,
-                                             real* gmx_restrict sol,
-                                             bool*              bWarn)
+                                             const rvec* gmx_restrict      x,
+                                             const real* gmx_restrict      bllen,
+                                             const real* gmx_restrict      blc,
+                                             const real*                   pbc_simd,
+                                             real                          wfac,
+                                             real* gmx_restrict            rhs,
+                                             real* gmx_restrict            sol,
+                                             bool*                         bWarn)
 {
     SimdReal min_S(GMX_REAL_MIN);
     SimdReal two_S(2.0);
@@ -968,9 +968,9 @@ static void do_lincs(ArrayRefWithPadding<const RVec> xPadded,
                      bool                            bCalcVir,
                      tensor                          vir_r_m_dr)
 {
-    const rvec* x        = as_rvec_array(xPadded.paddedArrayRef().data());
-    rvec*       xp       = as_rvec_array(xpPadded.paddedArrayRef().data());
-    rvec* gmx_restrict v = as_rvec_array(vRef.data());
+    const rvec*        x  = as_rvec_array(xPadded.paddedArrayRef().data());
+    rvec*              xp = as_rvec_array(xpPadded.paddedArrayRef().data());
+    rvec* gmx_restrict v  = as_rvec_array(vRef.data());
 
     const int b0 = lincsd->task[th].b0;
     const int b1 = lincsd->task[th].b1;
index 96c0b8fc32823ceaf32cbf07841cd1fe845ffb91..761f38a12066e66d1454a9d9271f729e152e53d7 100644 (file)
@@ -128,8 +128,7 @@ LincsGpu::LincsGpu(int                  numIterations,
                    int                  expansionOrder,
                    const DeviceContext& deviceContext,
                    const DeviceStream&  deviceStream) :
-    deviceContext_(deviceContext),
-    deviceStream_(deviceStream)
+    deviceContext_(deviceContext), deviceStream_(deviceStream)
 {
     GMX_RELEASE_ASSERT(GMX_GPU_CUDA, "LINCS GPU is only implemented in CUDA.");
     kernelParams_.numIterations  = numIterations;
index 82ecd24b4b0937e50c0d021c4dbf8e26bae06c22..3749019a9dd95abc1df245f5cc3c6971c434471b 100644 (file)
@@ -217,7 +217,7 @@ void atoms2md(const gmx_mtop_t&  mtop,
 {
     gmx_bool         bLJPME;
     const t_grpopts* opts;
-    int nthreads gmx_unused;
+    int nthreads     gmx_unused;
 
     bLJPME = EVDW_PME(inputrec.vdwtype);
 
index a471a6c828721422171c68b0347fd28556d380b3..be4d76eea5d6f85fe300c36418934a8a7c601915 100644 (file)
@@ -82,10 +82,7 @@ ResetHandler::ResetHandler(compat::not_null<SimulationSignal*> signal,
                            const MDLogger&                     mdlog,
                            gmx_wallcycle*                      wcycle,
                            gmx_walltime_accounting_t           walltime_accounting) :
-    signal_(*signal),
-    rankCanSetSignal_(false),
-    simulationNeedsReset_(false),
-    maximumHoursToRun_(maximumHoursToRun)
+    signal_(*signal), rankCanSetSignal_(false), simulationNeedsReset_(false), maximumHoursToRun_(maximumHoursToRun)
 {
     if (simulationsShareState)
     {
index 24d0d58fb564d929be4dc92785c976258af3e440..5a77a323e6425f4d3e3ba5184cd368faa2213c4f 100644 (file)
@@ -368,13 +368,13 @@ void settle_proj(const SettleData&    settled,
 
 /*! \brief The actual settle code, templated for real/SimdReal and for optimization */
 template<typename T, typename TypeBool, int packSize, typename TypePbc, bool bCorrectVelocity, bool bCalcVirial>
-static void settleTemplate(const SettleData& settled,
-                           int               settleStart,
-                           int               settleEnd,
-                           const TypePbc     pbc,
-                           const real*       x,
-                           real*             xprime,
-                           real              invdt,
+static void settleTemplate(const SettleData&  settled,
+                           int                settleStart,
+                           int                settleEnd,
+                           const TypePbc      pbc,
+                           const real*        x,
+                           real*              xprime,
+                           real               invdt,
                            real* gmx_restrict v,
                            tensor             vir_r_m_dr,
                            bool*              bErrorHasOccurred)
index 0c19d7ad992a81fad5cf8454333471c83611b983..659947ac357873afb6216185a4dadd320a997961 100644 (file)
@@ -123,8 +123,7 @@ void SettleGpu::apply(const DeviceBuffer<Float3> d_x,
 }
 
 SettleGpu::SettleGpu(const gmx_mtop_t& mtop, const DeviceContext& deviceContext, const DeviceStream& deviceStream) :
-    deviceContext_(deviceContext),
-    deviceStream_(deviceStream)
+    deviceContext_(deviceContext), deviceStream_(deviceStream)
 {
     static_assert(sizeof(real) == sizeof(float),
                   "Real numbers should be in single precision in GPU code.");
index 8199dcb450f6b547a8823676a37d8cb36c62e072..db0aec861c0a3d8350afa55dda6190e7d23f8f9d 100644 (file)
@@ -4,7 +4,7 @@
  * Copyright (c) 1991-2000, University of Groningen, The Netherlands.
  * Copyright (c) 2001-2004, The GROMACS development team.
  * Copyright (c) 2013,2014,2015,2016,2017 by the GROMACS development team.
- * Copyright (c) 2018,2019,2020, by the GROMACS development team, led by
+ * Copyright (c) 2018,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.
@@ -72,12 +72,7 @@ SimulationSignaller::SimulationSignaller(SimulationSignals*    signals,
                                          const gmx_multisim_t* ms,
                                          bool                  doInterSim,
                                          bool                  doIntraSim) :
-    signals_(signals),
-    cr_(cr),
-    ms_(ms),
-    doInterSim_(doInterSim),
-    doIntraSim_(doInterSim || doIntraSim),
-    mpiBuffer_{}
+    signals_(signals), cr_(cr), ms_(ms), doInterSim_(doInterSim), doIntraSim_(doInterSim || doIntraSim), mpiBuffer_{}
 {
 }
 
index a82d9fc9e797674f32c1b0ec3ee091b9d9ab8285..a48c90ff74ed22dca089fde83ab25b8ad31c8021 100644 (file)
@@ -82,8 +82,8 @@ void LeapFrogHostTestRunner::integrate(LeapFrogTestData* testData, int numSteps)
                 testData->mdAtoms_.invmass
                         ? gmx::arrayRefFromArray(testData->mdAtoms_.invmass, testData->mdAtoms_.nr)
                         : gmx::ArrayRef<real>{},
-                testData->mdAtoms_.invMassPerDim ? gmx::arrayRefFromArray(testData->mdAtoms_.invMassPerDim,
-                                                                          testData->mdAtoms_.nr)
+                testData->mdAtoms_.invMassPerDim ? gmx::arrayRefFromArray(
+                        testData->mdAtoms_.invMassPerDim, testData->mdAtoms_.nr)
                                                  : gmx::ArrayRef<rvec>{},
                 &testData->state_,
                 testData->f_,
index c75ff3c6146810b1b5452548f5c366d69198d3a2..60c3b03535a8ebbe18d7be9030a5cf6b886bec5c 100644 (file)
@@ -348,10 +348,10 @@ updateMDLeapfrogSimple(int                                 start,
                        gmx::ArrayRef<const t_grp_tcstat>   tcstat,
                        gmx::ArrayRef<const unsigned short> cTC,
                        const rvec                          pRVScaleMatrixDiagonal,
-                       const rvec* gmx_restrict x,
-                       rvec* gmx_restrict xprime,
-                       VelocityType* gmx_restrict v,
-                       const rvec* gmx_restrict f)
+                       const rvec* gmx_restrict            x,
+                       rvec* gmx_restrict                  xprime,
+                       VelocityType* gmx_restrict          v,
+                       const rvec* gmx_restrict            f)
 {
     real lambdaGroup;
 
@@ -467,10 +467,10 @@ updateMDLeapfrogSimpleSimd(int                               start,
                            real                              dt,
                            gmx::ArrayRef<const real>         invMass,
                            gmx::ArrayRef<const t_grp_tcstat> tcstat,
-                           const rvec* gmx_restrict x,
-                           rvec* gmx_restrict xprime,
-                           VelocityType* gmx_restrict v,
-                           const rvec* gmx_restrict f)
+                           const rvec* gmx_restrict          x,
+                           rvec* gmx_restrict                xprime,
+                           VelocityType* gmx_restrict        v,
+                           const rvec* gmx_restrict          f)
 {
     SimdReal timestep(dt);
     SimdReal lambdaSystem(tcstat[0].lambda);
@@ -551,13 +551,13 @@ static void updateMDLeapfrogGeneral(int                                 start,
                                     gmx::ArrayRef<const rvec>           invMassPerDim,
                                     const gmx_ekindata_t*               ekind,
                                     const matrix                        box,
-                                    const rvec* gmx_restrict x,
-                                    rvec* gmx_restrict xprime,
-                                    rvec* gmx_restrict v,
-                                    const rvec* gmx_restrict f,
-                                    const double* gmx_restrict nh_vxi,
-                                    const int                  nsttcouple,
-                                    const matrix               M)
+                                    const rvec* gmx_restrict            x,
+                                    rvec* gmx_restrict                  xprime,
+                                    rvec* gmx_restrict                  v,
+                                    const rvec* gmx_restrict            f,
+                                    const double* gmx_restrict          nh_vxi,
+                                    const int                           nsttcouple,
+                                    const matrix                        M)
 {
     /* This is a version of the leap-frog integrator that supports
      * all combinations of T-coupling, P-coupling and NEMD.
@@ -628,26 +628,26 @@ static void updateMDLeapfrogGeneral(int                                 start,
 }
 
 /*! \brief Handles the Leap-frog MD x and v integration */
-static void do_update_md(int         start,
-                         int         nrend,
-                         real        dt,
-                         int64_t     step,
-                         const rvec* gmx_restrict x,
-                         rvec* gmx_restrict xprime,
-                         rvec* gmx_restrict v,
-                         const rvec* gmx_restrict            f,
-                         const TemperatureCoupling           etc,
-                         const PressureCoupling              epc,
-                         const int                           nsttcouple,
-                         const int                           nstpcouple,
-                         gmx::ArrayRef<const unsigned short> cTC,
+static void do_update_md(int                                  start,
+                         int                                  nrend,
+                         real                                 dt,
+                         int64_t                              step,
+                         const rvec* gmx_restrict             x,
+                         rvec* gmx_restrict                   xprime,
+                         rvec* gmx_restrict                   v,
+                         const rvec* gmx_restrict             f,
+                         const TemperatureCoupling            etc,
+                         const PressureCoupling               epc,
+                         const int                            nsttcouple,
+                         const int                            nstpcouple,
+                         gmx::ArrayRef<const unsigned short>  cTC,
                          gmx::ArrayRef<const real> gmx_unused invmass,
                          gmx::ArrayRef<const rvec>            invMassPerDim,
                          const gmx_ekindata_t*                ekind,
                          const matrix                         box,
-                         const double* gmx_restrict nh_vxi,
-                         const matrix               M,
-                         bool gmx_unused havePartiallyFrozenAtoms)
+                         const double* gmx_restrict           nh_vxi,
+                         const matrix                         M,
+                         bool gmx_unused                      havePartiallyFrozenAtoms)
 {
     GMX_ASSERT(nrend == start || xprime != x,
                "For SIMD optimization certain compilers need to have xprime != x");
@@ -784,14 +784,14 @@ static void do_update_md(int         start,
     }
 }
 /*! \brief Handles the Leap-frog MD x and v integration */
-static void doUpdateMDDoNotUpdateVelocities(int         start,
-                                            int         nrend,
-                                            real        dt,
+static void doUpdateMDDoNotUpdateVelocities(int                      start,
+                                            int                      nrend,
+                                            real                     dt,
                                             const rvec* gmx_restrict x,
-                                            rvec* gmx_restrict xprime,
+                                            rvec* gmx_restrict       xprime,
                                             const rvec* gmx_restrict v,
                                             const rvec* gmx_restrict f,
-                                            bool gmx_unused           havePartiallyFrozenAtoms,
+                                            bool gmx_unused          havePartiallyFrozenAtoms,
                                             gmx::ArrayRef<const real> gmx_unused invmass,
                                             gmx::ArrayRef<const rvec>            invMassPerDim,
                                             const gmx_ekindata_t&                ekind)
@@ -1001,8 +1001,7 @@ void Update::Impl::update_temperature_constants(const t_inputrec& inputRecord)
 }
 
 Update::Impl::Impl(const t_inputrec& inputRecord, BoxDeformation* boxDeformation) :
-    sd_(inputRecord),
-    deform_(boxDeformation)
+    sd_(inputRecord), deform_(boxDeformation)
 {
     update_temperature_constants(inputRecord);
     xp_.resizeWithPadding(0);
@@ -1137,13 +1136,13 @@ static void doSDUpdateGeneral(const gmx_stochd_t&                 sd,
     }
 }
 
-static void do_update_sd(int         start,
-                         int         nrend,
-                         real        dt,
-                         int64_t     step,
-                         const rvec* gmx_restrict x,
-                         rvec* gmx_restrict xprime,
-                         rvec* gmx_restrict v,
+static void do_update_sd(int                                 start,
+                         int                                 nrend,
+                         real                                dt,
+                         int64_t                             step,
+                         const rvec* gmx_restrict            x,
+                         rvec* gmx_restrict                  xprime,
+                         rvec* gmx_restrict                  v,
                          const rvec* gmx_restrict            f,
                          gmx::ArrayRef<const ivec>           nFreeze,
                          gmx::ArrayRef<const real>           invmass,
@@ -1196,13 +1195,13 @@ static void do_update_sd(int         start,
     }
 }
 
-static void do_update_bd(int         start,
-                         int         nrend,
-                         real        dt,
-                         int64_t     step,
-                         const rvec* gmx_restrict x,
-                         rvec* gmx_restrict xprime,
-                         rvec* gmx_restrict v,
+static void do_update_bd(int                                 start,
+                         int                                 nrend,
+                         real                                dt,
+                         int64_t                             step,
+                         const rvec* gmx_restrict            x,
+                         rvec* gmx_restrict                  xprime,
+                         rvec* gmx_restrict                  v,
                          const rvec* gmx_restrict            f,
                          gmx::ArrayRef<const ivec>           nFreeze,
                          gmx::ArrayRef<const real>           invmass,
index bad3898602e0d934482e243a28fab68fd1df7f56..9b260d1a99cc39a0f26d813486338569869eb63b 100644 (file)
@@ -235,12 +235,7 @@ private:
 struct ScalingMatrix
 {
     ScalingMatrix(const matrix m) :
-        xx(m[XX][XX]),
-        yy(m[YY][YY]),
-        zz(m[ZZ][ZZ]),
-        yx(m[YY][XX]),
-        zx(m[ZZ][XX]),
-        zy(m[ZZ][YY])
+        xx(m[XX][XX]), yy(m[YY][YY]), zz(m[ZZ][ZZ]), yx(m[YY][XX]), zx(m[ZZ][XX]), zy(m[ZZ][YY])
     {
     }
     float xx, yy, zz, yx, zx, zy;
index f73ae88de181b515669a5854e42c09fcce05c9dd..412e4cc8eb599f0c22a8ea72f54d843004643977 100644 (file)
@@ -56,8 +56,7 @@ UpdateGroupsCog::UpdateGroupsCog(const gmx_mtop_t&                           mto
                                  gmx::ArrayRef<const gmx::RangePartitioning> updateGroupingsPerMoleculeType,
                                  real                                        temperature,
                                  int                                         numHomeAtoms) :
-    globalToLocalMap_(numHomeAtoms),
-    mtop_(mtop)
+    globalToLocalMap_(numHomeAtoms), mtop_(mtop)
 {
     int firstUpdateGroupInMolecule = 0;
     for (const auto& molblock : mtop.molblock)
index 186d257c486c8a7d1a25080f147bb10aef688ca3..dc6a0a25e1ddd48c1638fa4b6d5b79a73861dda6 100644 (file)
@@ -364,8 +364,8 @@ void gmx::LegacySimulator::do_md()
 
     ForceBuffers     f(fr->useMts,
                    ((useGpuForNonbonded && useGpuForBufferOps) || useGpuForUpdate)
-                           ? PinningPolicy::PinnedIfSupported
-                           : PinningPolicy::CannotBePinned);
+                               ? PinningPolicy::PinnedIfSupported
+                               : PinningPolicy::CannotBePinned);
     const t_mdatoms* md = mdAtoms->mdatoms();
     if (DOMAINDECOMP(cr))
     {
@@ -1297,7 +1297,7 @@ void gmx::LegacySimulator::do_md()
                                               state->v.rvec_array(),
                                               md->homenr,
                                               md->cTC ? gmx::arrayRefFromArray(md->cTC, md->nr)
-                                                      : gmx::ArrayRef<const unsigned short>());
+                                                                      : gmx::ArrayRef<const unsigned short>());
             /* history is maintained in state->dfhist, but state_global is what is sent to trajectory and log output */
             if (MASTER(cr))
             {
index f309a376a2c9edeee6a38c3c856f836bc8ba97dd..8046ef7cf35329b95e4915209dd98746a3d4687e 100644 (file)
@@ -1837,10 +1837,10 @@ int Mdrunner::mdrunner()
                 const DeviceContext* deviceContext = runScheduleWork.simulationWork.useGpuPme
                                                              ? &deviceStreamManager->context()
                                                              : nullptr;
-                const DeviceStream* pmeStream =
+                const DeviceStream*  pmeStream =
                         runScheduleWork.simulationWork.useGpuPme
-                                ? &deviceStreamManager->stream(DeviceStreamType::Pme)
-                                : nullptr;
+                                 ? &deviceStreamManager->stream(DeviceStreamType::Pme)
+                                 : nullptr;
 
                 pmedata = gmx_pme_init(cr,
                                        getNumPmeDomains(cr->dd),
index ae5e2b81c601f25c575703c4f30795a8c5881e58..7bf73b2ab54dfd75bbcc6bd0e3ae9958a49f38bc 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2020, by the GROMACS development team, led by
+ * Copyright (c) 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.
@@ -58,8 +58,7 @@ class SimulationInput
 {
 public:
     SimulationInput(const char* tprFilename, const char* cpiFilename) :
-        tprFilename_(tprFilename),
-        cpiFilename_(cpiFilename)
+        tprFilename_(tprFilename), cpiFilename_(cpiFilename)
     {
     }
 
@@ -112,11 +111,11 @@ detail::SimulationInputHandleImplDeleter::SimulationInputHandleImplDeleter(
 detail::SimulationInputHandleImplDeleter::SimulationInputHandleImplDeleter(
         SimulationInputHandleImplDeleter&&) noexcept = default;
 
-detail::SimulationInputHandleImplDeleter& detail::SimulationInputHandleImplDeleter::
-                                          operator=(const SimulationInputHandleImplDeleter&) noexcept = default;
+detail::SimulationInputHandleImplDeleter& detail::SimulationInputHandleImplDeleter::operator=(
+        const SimulationInputHandleImplDeleter&) noexcept = default;
 
-detail::SimulationInputHandleImplDeleter& detail::SimulationInputHandleImplDeleter::
-                                          operator=(SimulationInputHandleImplDeleter&&) noexcept = default;
+detail::SimulationInputHandleImplDeleter& detail::SimulationInputHandleImplDeleter::operator=(
+        SimulationInputHandleImplDeleter&&) noexcept = default;
 
 void detail::SimulationInputHandleImplDeleter::operator()(SimulationInputHandleImpl* impl) const
 {
index 225072407856981edbf1663ccdcff41a3b7334b2..5d03dbb050c46e8c8d27c2fc5e2ab4d5675da377 100644 (file)
@@ -92,9 +92,7 @@ public:
     SimulatorConfig(const MdrunOptions&    mdrunOptions,
                     StartingBehavior       startingBehavior,
                     MdrunScheduleWorkload* runScheduleWork) :
-        mdrunOptions_(mdrunOptions),
-        startingBehavior_(startingBehavior),
-        runScheduleWork_(runScheduleWork)
+        mdrunOptions_(mdrunOptions), startingBehavior_(startingBehavior), runScheduleWork_(runScheduleWork)
     {
     }
     // TODO: Specify copy and move semantics.
@@ -155,11 +153,7 @@ public:
                  gmx_multisim_t*   multisimCommRec,
                  const MDLogger&   logger,
                  gmx_output_env_t* outputEnv) :
-        fplog_{ fplog },
-        commRec_{ commRec },
-        multisimCommRec_{ multisimCommRec },
-        logger_{ logger },
-        outputEnv_{ outputEnv }
+        fplog_{ fplog }, commRec_{ commRec }, multisimCommRec_{ multisimCommRec }, logger_{ logger }, outputEnv_{ outputEnv }
     {
     }
 
@@ -183,9 +177,7 @@ class Profiling
 public:
     //! Build profiling information collection.
     Profiling(t_nrnb* nrnb, gmx_walltime_accounting* walltimeAccounting, gmx_wallcycle* wallCycle) :
-        nrnb(nrnb),
-        wallCycle(wallCycle),
-        walltimeAccounting(walltimeAccounting)
+        nrnb(nrnb), wallCycle(wallCycle), walltimeAccounting(walltimeAccounting)
     {
     }
 
@@ -205,9 +197,7 @@ class ConstraintsParam
 public:
     //! Build collection with handle to actual objects.
     ConstraintsParam(Constraints* constraints, gmx_enfrot* enforcedRotation, VirtualSitesHandler* vSite) :
-        constr(constraints),
-        enforcedRotation(enforcedRotation),
-        vsite(vSite)
+        constr(constraints), enforcedRotation(enforcedRotation), vsite(vSite)
     {
     }
 
@@ -227,10 +217,7 @@ class LegacyInput
 public:
     //! Build collection from legacy input data.
     LegacyInput(int filenamesSize, const t_filenm* filenamesData, t_inputrec* inputRec, t_forcerec* forceRec) :
-        numFile(filenamesSize),
-        filenames(filenamesData),
-        inputrec(inputRec),
-        forceRec(forceRec)
+        numFile(filenamesSize), filenames(filenamesData), inputrec(inputRec), forceRec(forceRec)
     {
     }
 
@@ -264,8 +251,7 @@ class SimulatorModules
 {
 public:
     SimulatorModules(IMDOutputProvider* mdOutputProvider, const MDModulesNotifiers& notifiers) :
-        outputProvider(mdOutputProvider),
-        mdModulesNotifiers(notifiers)
+        outputProvider(mdOutputProvider), mdModulesNotifiers(notifiers)
     {
     }
 
@@ -306,8 +292,7 @@ class TopologyData
 public:
     //! Build collection from simulation data.
     TopologyData(const gmx_mtop_t& globalTopology, MDAtoms* mdAtoms) :
-        top_global(globalTopology),
-        mdAtoms(mdAtoms)
+        top_global(globalTopology), mdAtoms(mdAtoms)
     {
     }
 
index f046c966e5ad1d3d1b91e6ca8b7824bcd7b233b6..6e46b9841c99961320a6f7a32bdf4ad1f3c6279c 100644 (file)
@@ -573,8 +573,8 @@ static bool detectDefaultAffinityMask(const int nthreads_hw_avail)
  */
 void gmx_check_thread_affinity_set(const gmx::MDLogger& mdlog,
                                    gmx_hw_opt_t*        hw_opt,
-                                   int gmx_unused nthreads_hw_avail,
-                                   gmx_bool       bAfterOpenmpInit)
+                                   int gmx_unused       nthreads_hw_avail,
+                                   gmx_bool             bAfterOpenmpInit)
 {
     GMX_RELEASE_ASSERT(hw_opt, "hw_opt must be a non-NULL pointer");
 
index 74ea8b0867d821e05ebea0a9abcba878608617cb..64d135c4ef40e8fd897bca8969f072465b415558 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2018,2019, by the GROMACS development team, led by
+ * Copyright (c) 2018,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.
@@ -247,16 +247,14 @@ struct extents_analyse<R, dynamic_extent, StaticExtents...>
      */
     template<std::size_t Rank>
     extents_analyse(const std::array<std::ptrdiff_t, Rank>& de, const std::size_t r) :
-        next(de, r + 1),
-        this_extent(de[r])
+        next(de, r + 1), this_extent(de[r])
     {
     }
 
     //! Copy constructor.
     template<std::ptrdiff_t... OtherStaticExtents>
     extents_analyse(extents_analyse<R, OtherStaticExtents...> rhs) :
-        next(rhs.next),
-        this_extent(rhs.extent(R))
+        next(rhs.next), this_extent(rhs.extent(R))
     {
     }
 
@@ -379,7 +377,8 @@ public:
      *
      * \param[in] dynamic_extents array of dynamic rank size containing extents
      */
-    constexpr extents(const std::array<std::ptrdiff_t, extents_analyse_t::rank_dynamic()> dynamic_extents) noexcept :
+    constexpr extents(const std::array<std::ptrdiff_t, extents_analyse_t::rank_dynamic()> dynamic_extents) noexcept
+        :
         impl(dynamic_extents, 0)
     {
     }
index 5b2f5351975ba30d25cc58f63f1c44eb1c397f03..b3eb1b843d6ee427b6af9309503026e4909f75ba 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2018,2019,2020, by the GROMACS development team, led by
+ * Copyright (c) 2018,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.
@@ -145,10 +145,9 @@ public:
     //! Copy constructor
     template<class OtherElementType, class OtherExtents, class OtherLayoutPolicy, class OtherAccessor>
     constexpr basic_mdspan(
-            const basic_mdspan<OtherElementType, OtherExtents, OtherLayoutPolicy, OtherAccessor>& rhs) noexcept :
-        acc_(rhs.acc_),
-        map_(rhs.map_),
-        ptr_(rhs.ptr_)
+            const basic_mdspan<OtherElementType, OtherExtents, OtherLayoutPolicy, OtherAccessor>& rhs) noexcept
+        :
+        acc_(rhs.acc_), map_(rhs.map_), ptr_(rhs.ptr_)
     {
     }
     //! Copy assignment constructor
@@ -169,9 +168,7 @@ public:
      */
     template<class... IndexType>
     explicit constexpr basic_mdspan(pointer ptr, IndexType... DynamicExtents) noexcept :
-        acc_(accessor_type()),
-        map_(extents_type(DynamicExtents...)),
-        ptr_(ptr)
+        acc_(accessor_type()), map_(extents_type(DynamicExtents...)), ptr_(ptr)
     {
     }
     /*! \brief Construct from array describing dynamic extents.
@@ -180,9 +177,7 @@ public:
      */
     constexpr basic_mdspan(pointer                                                    ptr,
                            const std::array<ptrdiff_t, extents_type::rank_dynamic()>& dynamic_extents) :
-        acc_(accessor_type()),
-        map_(extents_type(dynamic_extents)),
-        ptr_(ptr)
+        acc_(accessor_type()), map_(extents_type(dynamic_extents)), ptr_(ptr)
     {
     }
     /*! \brief Construct from pointer and mapping.
@@ -190,9 +185,7 @@ public:
      * \param[in] m Mapping from multidimenisonal indices to one-dimensional offset.
      */
     constexpr basic_mdspan(pointer ptr, const mapping_type& m) noexcept :
-        acc_(accessor_type()),
-        map_(m),
-        ptr_(ptr)
+        acc_(accessor_type()), map_(m), ptr_(ptr)
     {
     }
     /*! \brief Construct with pointer, mapping and accessor.
@@ -201,9 +194,7 @@ public:
      * \param[in] a Accessor implementing memory access model.
      */
     constexpr basic_mdspan(pointer ptr, const mapping_type& m, const accessor_type& a) noexcept :
-        acc_(a),
-        map_(m),
-        ptr_(ptr)
+        acc_(a), map_(m), ptr_(ptr)
     {
     }
     /*! \brief Construct mdspan from multidimensional arrays implemented with mdspan
index 03d3e66f29ab430d99256aab16713efc8f33285c..f125477fdf928cf9f9d51693e34ed04657e7306e 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2020, by the GROMACS development team, led by
+ * Copyright (c) 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.
@@ -50,10 +50,7 @@ namespace gmx
 {
 
 ForceBuffers::ForceBuffers() :
-    force_({}),
-    forceMtsCombined_({}),
-    view_({}, {}, false),
-    useForceMtsCombined_(false)
+    force_({}), forceMtsCombined_({}), view_({}, {}, false), useForceMtsCombined_(false)
 {
 }
 
index 9c49e2f00aeaeadf8deb0300b049b6d4a47e3a4d..caacedbc31169ee04c48e715cb7471c2295b1230 100644 (file)
@@ -72,9 +72,7 @@ public:
     ForceBuffersView(const ArrayRefWithPadding<RVec>& force,
                      const ArrayRefWithPadding<RVec>& forceMtsCombined,
                      const bool                       useForceMtsCombined) :
-        force_(force),
-        forceMtsCombined_(forceMtsCombined),
-        useForceMtsCombined_(useForceMtsCombined)
+        force_(force), forceMtsCombined_(forceMtsCombined), useForceMtsCombined_(useForceMtsCombined)
     {
     }
 
index a9a9ae6b2c563b6c77e3cfd114ad5d99666e7f5b..52300228b4adb73237e2dd38897a9a435a256900 100644 (file)
@@ -129,8 +129,7 @@ public:
      * \param[in] computeVirial  True when algorithms are required to provide their virial contribution (for the current force evaluation)
      */
     ForceWithVirial(const ArrayRef<RVec>& force, const bool computeVirial) :
-        force_(force),
-        computeVirial_(computeVirial)
+        force_(force), computeVirial_(computeVirial)
     {
         for (int dim1 = 0; dim1 < DIM; dim1++)
         {
index 8e708c737d7be5e818ba77b8ab25f461375ab014..1d6960e6c905bb6d6ba215b466ed1019d7f105d0 100644 (file)
@@ -46,8 +46,7 @@
 #include "gromacs/utility/exceptions.h"
 
 gmx_ekindata_t::gmx_ekindata_t(int numTempCoupleGroups, real cos_accel, int numThreads) :
-    ngtc(numTempCoupleGroups),
-    nthreads_(numThreads)
+    ngtc(numTempCoupleGroups), nthreads_(numThreads)
 {
     tcstat.resize(ngtc);
     /* Set Berendsen tcoupl lambda's to 1,
index 3006bf88e971914fe5786a54ed72b97cde1b2a5f..9b65e0fda40bb4c344d2f11a2b701c314172c8ce 100644 (file)
@@ -96,12 +96,7 @@ public:
                        double               time,
                        const matrix         box,
                        const t_commrec&     cr) :
-        x_(x),
-        homenr_(homenr),
-        chargeA_(chargeA),
-        massT_(massT),
-        t_(time),
-        cr_(cr)
+        x_(x), homenr_(homenr), chargeA_(chargeA), massT_(massT), t_(time), cr_(cr)
     {
         copy_mat(box, box_);
     }
@@ -138,8 +133,7 @@ public:
      * \param[in,out]  enerd            Structure containing energy data
      */
     ForceProviderOutput(ForceWithVirial* forceWithVirial, gmx_enerdata_t* enerd) :
-        forceWithVirial_(makeRefFromPointer(forceWithVirial)),
-        enerd_(makeRefFromPointer(enerd))
+        forceWithVirial_(makeRefFromPointer(forceWithVirial)), enerd_(makeRefFromPointer(enerd))
     {
     }
 
index aee0a64ea9eb51782b6f055db6757659fb5d8871..0f377eb347a790a3c3a356712576efc7fbd753bc 100644 (file)
@@ -150,11 +150,11 @@ struct interaction_const_t
     real rcoulomb_switch = 0;
 
     /* PME/Ewald */
-    real ewaldcoeff_q  = 0;
-    real ewaldcoeff_lj = 0;
+    real         ewaldcoeff_q  = 0;
+    real         ewaldcoeff_lj = 0;
     LongRangeVdW ljpme_comb_rule = LongRangeVdW::Geom; /* LJ combination rule for the LJ PME mesh part */
-    real sh_ewald                = 0; /* -sh_ewald is added to the direct space potential */
-    real sh_lj_ewald = 0;             /* sh_lj_ewald is added to the correction potential */
+    real         sh_ewald        = 0; /* -sh_ewald is added to the direct space potential */
+    real         sh_lj_ewald = 0;     /* sh_lj_ewald is added to the correction potential */
 
     /* Dielectric constant resp. multiplication factor for charges */
     real epsilon_r = 1;
index 9637463bb3d17041a212bbcbab901d4e4e32b851..8dabf20ac738c03842717e1e09c24eccabe3fa42 100644 (file)
@@ -84,7 +84,7 @@ typedef struct swaphistory_t
     int* fluxleak_p;                         // Pointer to this data
     bool bFromCpt;                           // Did we start from a checkpoint file?
     gmx::EnumerationArray<Channel, int> nat; // Size of xc_old_whole, i.e. the number of atoms in each channel
-    gmx::EnumerationArray<Channel, rvec*>  xc_old_whole; // Last known whole positions of the two channels (important for multimeric ch.!)
+    gmx::EnumerationArray<Channel, rvec*> xc_old_whole; // Last known whole positions of the two channels (important for multimeric ch.!)
     gmx::EnumerationArray<Channel, rvec**> xc_old_whole_p; // Pointer to these positions
     swapstateIons_t*                       ionType;        // History information for one ion type
 } swaphistory_t;
index 0110bf80900cb311a7619dbc4909d5d5609559a8..369c1bde3ae4b05562ce6f9a3583ed7947a09399 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * 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.
@@ -48,8 +48,7 @@ namespace gmx
 CompositeSimulatorElement::CompositeSimulatorElement(
         std::vector<compat::not_null<ISimulatorElement*>>    elementCallList,
         std::vector<std::unique_ptr<gmx::ISimulatorElement>> elements) :
-    elementCallList_(std::move(elementCallList)),
-    elementOwnershipList_(std::move(elements))
+    elementCallList_(std::move(elementCallList)), elementOwnershipList_(std::move(elements))
 {
 }
 
index 06383b360345531c481df1e3e6d4e25081e5bc94..cbf914d09c2702b5d597c9cf8c87018e0208bcc4 100644 (file)
@@ -94,7 +94,7 @@ void ConstraintsElement<variable>::elementSetup()
         const real lambdaBonded =
                 freeEnergyPerturbationData_
                         ? freeEnergyPerturbationData_->constLambdaView()[static_cast<int>(
-                                  FreeEnergyPerturbationCouplingType::Bonded)]
+                                FreeEnergyPerturbationCouplingType::Bonded)]
                         : 0;
         // Constrain the initial coordinates and velocities
         do_constrain_first(fplog_,
@@ -120,7 +120,7 @@ void ConstraintsElement<variable>::elementSetup()
 }
 
 template<ConstraintVariable variable>
-void ConstraintsElement<variable>::scheduleTask(Step step,
+void ConstraintsElement<variable>::scheduleTask(Step                       step,
                                                 Time gmx_unused            time,
                                                 const RegisterRunFunction& registerRunFunction)
 {
index de8fbdc008645ccb8d1af46c501c9aed427533eb..ac610f06c5491a22809e87ac1b45a650c9d5ad3c 100644 (file)
@@ -83,7 +83,7 @@ FreeEnergyPerturbationData::FreeEnergyPerturbationData(FILE* fplog, const t_inpu
                        lambda_);
 }
 
-void FreeEnergyPerturbationData::Element::scheduleTask(Step step,
+void FreeEnergyPerturbationData::Element::scheduleTask(Step                       step,
                                                        Time gmx_unused            time,
                                                        const RegisterRunFunction& registerRunFunction)
 {
@@ -179,8 +179,7 @@ const std::string& FreeEnergyPerturbationData::Element::clientID()
 
 FreeEnergyPerturbationData::Element::Element(FreeEnergyPerturbationData* freeEnergyPerturbationElement,
                                              double                      deltaLambda) :
-    freeEnergyPerturbationData_(freeEnergyPerturbationElement),
-    lambdasChange_(deltaLambda != 0)
+    freeEnergyPerturbationData_(freeEnergyPerturbationElement), lambdasChange_(deltaLambda != 0)
 {
 }
 
index b06b8744dc1af25c251c38dd80c737ede651dcfe..4bdcff78920276da78f21887d0f9a68b83baa607 100644 (file)
@@ -106,7 +106,7 @@ void ParrinelloRahmanBarostat::connectWithMatchingPropagator(const PropagatorCon
     }
 }
 
-void ParrinelloRahmanBarostat::scheduleTask(Step step,
+void ParrinelloRahmanBarostat::scheduleTask(Step                       step,
                                             Time gmx_unused            time,
                                             const RegisterRunFunction& registerRunFunction)
 {
index 0e56ed06608b66aee1cf4442d8d00c9903c0b157..ad04e4f23a6e2b20b0af339750bcad17e2011ad8 100644 (file)
@@ -73,12 +73,12 @@ constexpr EnumerationArray<IntegrationStage, const char*> integrationStepNames =
 template<NumVelocityScalingValues        numStartVelocityScalingValues,
          ParrinelloRahmanVelocityScaling parrinelloRahmanVelocityScaling,
          NumVelocityScalingValues        numEndVelocityScalingValues>
-static void inline updateVelocities(int         a,
-                                    real        dt,
-                                    real        lambdaStart,
-                                    real        lambdaEnd,
+static void inline updateVelocities(int                      a,
+                                    real                     dt,
+                                    real                     lambdaStart,
+                                    real                     lambdaEnd,
                                     const rvec* gmx_restrict invMassPerDim,
-                                    rvec* gmx_restrict v,
+                                    rvec* gmx_restrict       v,
                                     const rvec* gmx_restrict f,
                                     const rvec               diagPR,
                                     const matrix             matrixPR)
@@ -120,10 +120,10 @@ static void inline updateVelocities(int         a,
 }
 
 //! Update positions
-static void inline updatePositions(int         a,
-                                   real        dt,
+static void inline updatePositions(int                      a,
+                                   real                     dt,
                                    const rvec* gmx_restrict x,
-                                   rvec* gmx_restrict xprime,
+                                   rvec* gmx_restrict       xprime,
                                    const rvec* gmx_restrict v)
 {
     for (int d = 0; d < DIM; d++)
@@ -276,9 +276,9 @@ void Propagator<IntegrationStage::VelocitiesOnly>::run()
     const real lambdaStart = (numStartVelocityScalingValues == NumVelocityScalingValues::Single)
                                      ? startVelocityScaling_[0]
                                      : 1.0;
-    const real lambdaEnd = (numEndVelocityScalingValues == NumVelocityScalingValues::Single)
-                                   ? endVelocityScaling_[0]
-                                   : 1.0;
+    const real lambdaEnd   = (numEndVelocityScalingValues == NumVelocityScalingValues::Single)
+                                     ? endVelocityScaling_[0]
+                                     : 1.0;
 
     const bool isFullScalingMatrixDiagonal =
             diagonalizePRMatrix<parrinelloRahmanVelocityScaling>(matrixPR_, diagPR_);
@@ -359,9 +359,9 @@ void Propagator<IntegrationStage::LeapFrog>::run()
     const real lambdaStart = (numStartVelocityScalingValues == NumVelocityScalingValues::Single)
                                      ? startVelocityScaling_[0]
                                      : 1.0;
-    const real lambdaEnd = (numEndVelocityScalingValues == NumVelocityScalingValues::Single)
-                                   ? endVelocityScaling_[0]
-                                   : 1.0;
+    const real lambdaEnd   = (numEndVelocityScalingValues == NumVelocityScalingValues::Single)
+                                     ? endVelocityScaling_[0]
+                                     : 1.0;
 
     const bool isFullScalingMatrixDiagonal =
             diagonalizePRMatrix<parrinelloRahmanVelocityScaling>(matrixPR_, diagPR_);
@@ -444,9 +444,9 @@ void Propagator<IntegrationStage::VelocityVerletPositionsAndVelocities>::run()
     const real lambdaStart = (numStartVelocityScalingValues == NumVelocityScalingValues::Single)
                                      ? startVelocityScaling_[0]
                                      : 1.0;
-    const real lambdaEnd = (numEndVelocityScalingValues == NumVelocityScalingValues::Single)
-                                   ? endVelocityScaling_[0]
-                                   : 1.0;
+    const real lambdaEnd   = (numEndVelocityScalingValues == NumVelocityScalingValues::Single)
+                                     ? endVelocityScaling_[0]
+                                     : 1.0;
 
     const bool isFullScalingMatrixDiagonal =
             diagonalizePRMatrix<parrinelloRahmanVelocityScaling>(matrixPR_, diagPR_);
@@ -581,7 +581,7 @@ Propagator<integrationStage>::Propagator(double               timestep,
 }
 
 template<IntegrationStage integrationStage>
-void Propagator<integrationStage>::scheduleTask(Step step,
+void Propagator<integrationStage>::scheduleTask(Step                       step,
                                                 Time gmx_unused            time,
                                                 const RegisterRunFunction& registerRunFunction)
 {
index 70ed23d556e1ff147283b9c559ca73a221cec0db..84fadcbb661c46696d050128bfe7560377d9e1b5 100644 (file)
@@ -65,10 +65,7 @@ NeighborSearchSignaller::NeighborSearchSignaller(std::vector<SignallerCallback>
                                                  Step                           nstlist,
                                                  Step                           initStep,
                                                  Time                           initTime) :
-    callbacks_(std::move(callbacks)),
-    nstlist_(nstlist),
-    initStep_(initStep),
-    initTime_(initTime)
+    callbacks_(std::move(callbacks)), nstlist_(nstlist), initStep_(initStep), initTime_(initTime)
 {
 }
 
index 4dd6a899f27f8bd358a543a8e2a4ecec5f22eaea..430dd70dbb19b31617024a1cd3f4505e47d0553d 100644 (file)
@@ -335,7 +335,7 @@ void StatePropagatorData::copyPosition(int start, int end)
     }
 }
 
-void StatePropagatorData::Element::scheduleTask(Step step,
+void StatePropagatorData::Element::scheduleTask(Step                       step,
                                                 Time gmx_unused            time,
                                                 const RegisterRunFunction& registerRunFunction)
 {
index 3f323c1acf04f1651d68632550bc743105eb694e..c2b8b6ab713efc103cbd8df8254e47233f82f8a8 100644 (file)
@@ -124,9 +124,9 @@ class VRescaleTemperatureCoupling final : public ITemperatureCouplingImpl
 {
 public:
     //! Apply the v-rescale temperature control
-    real apply(Step step,
-               int  temperatureGroup,
-               real currentKineticEnergy,
+    real apply(Step                           step,
+               int                            temperatureGroup,
+               real                           currentKineticEnergy,
                real gmx_unused                currentTemperature,
                const TemperatureCouplingData& temperatureCouplingData) override
     {
@@ -516,7 +516,7 @@ void VelocityScalingTemperatureCoupling::elementSetup()
     }
 }
 
-void VelocityScalingTemperatureCoupling::scheduleTask(Step step,
+void VelocityScalingTemperatureCoupling::scheduleTask(Step                       step,
                                                       Time gmx_unused            time,
                                                       const RegisterRunFunction& registerRunFunction)
 {
@@ -568,9 +568,9 @@ void VelocityScalingTemperatureCoupling::setLambda(Step step)
         const real currentKineticEnergy = useFullStepKE_ == UseFullStepKE::Yes
                                                   ? trace(ekind->tcstat[temperatureGroup].ekinf)
                                                   : trace(ekind->tcstat[temperatureGroup].ekinh);
-        const real currentTemperature = useFullStepKE_ == UseFullStepKE::Yes
-                                                ? ekind->tcstat[temperatureGroup].T
-                                                : ekind->tcstat[temperatureGroup].Th;
+        const real currentTemperature   = useFullStepKE_ == UseFullStepKE::Yes
+                                                  ? ekind->tcstat[temperatureGroup].T
+                                                  : ekind->tcstat[temperatureGroup].Th;
 
         temperatureCouplingIntegral_[temperatureGroup] = temperatureCouplingImpl_->apply(
                 step, temperatureGroup, currentKineticEnergy, currentTemperature, thermostatData);
index bce2b142aecf82791e308f0aa93bf12a1af7d0c6..5337c8072e0da9aad4d53541ef4025284ce90432 100644 (file)
@@ -504,7 +504,8 @@ static void nbnxn_atomdata_params_init(const gmx::MDLogger&      mdlog,
                 /* Compare 6*C6 and 12*C12 for geometric cobination rule */
                 bCombGeom =
                         bCombGeom
-                        && gmx_within_tol(c6 * c6, nbfp[(i * ntype + i) * 2] * nbfp[(j * ntype + j) * 2], tol)
+                        && gmx_within_tol(
+                                c6 * c6, nbfp[(i * ntype + i) * 2] * nbfp[(j * ntype + j) * 2], tol)
                         && gmx_within_tol(c12 * c12,
                                           nbfp[(i * ntype + i) * 2 + 1] * nbfp[(j * ntype + j) * 2 + 1],
                                           tol);
@@ -512,18 +513,18 @@ static void nbnxn_atomdata_params_init(const gmx::MDLogger&      mdlog,
                 /* Compare C6 and C12 for Lorentz-Berthelot combination rule */
                 c6 /= 6.0;
                 c12 /= 12.0;
-                bCombLB =
-                        bCombLB
-                        && ((c6 == 0 && c12 == 0
-                             && (params->nbfp_comb[i * 2 + 1] == 0 || params->nbfp_comb[j * 2 + 1] == 0))
-                            || (c6 > 0 && c12 > 0
-                                && gmx_within_tol(gmx::sixthroot(c12 / c6),
-                                                  0.5 * (params->nbfp_comb[i * 2] + params->nbfp_comb[j * 2]),
-                                                  tol)
-                                && gmx_within_tol(0.25 * c6 * c6 / c12,
-                                                  std::sqrt(params->nbfp_comb[i * 2 + 1]
-                                                            * params->nbfp_comb[j * 2 + 1]),
-                                                  tol)));
+                bCombLB = bCombLB
+                          && ((c6 == 0 && c12 == 0
+                               && (params->nbfp_comb[i * 2 + 1] == 0 || params->nbfp_comb[j * 2 + 1] == 0))
+                              || (c6 > 0 && c12 > 0
+                                  && gmx_within_tol(
+                                          gmx::sixthroot(c12 / c6),
+                                          0.5 * (params->nbfp_comb[i * 2] + params->nbfp_comb[j * 2]),
+                                          tol)
+                                  && gmx_within_tol(0.25 * c6 * c6 / c12,
+                                                    std::sqrt(params->nbfp_comb[i * 2 + 1]
+                                                              * params->nbfp_comb[j * 2 + 1]),
+                                                    tol)));
             }
             else
             {
@@ -1052,8 +1053,8 @@ static void nbnxn_atomdata_clear_reals(gmx::ArrayRef<real> dest, int i0, int i1)
     }
 }
 
-gmx_unused static void nbnxn_atomdata_reduce_reals(real* gmx_restrict dest,
-                                                   gmx_bool           bDestSet,
+gmx_unused static void nbnxn_atomdata_reduce_reals(real* gmx_restrict        dest,
+                                                   gmx_bool                  bDestSet,
                                                    const real** gmx_restrict src,
                                                    int                       nsrc,
                                                    int                       i0,
@@ -1085,11 +1086,11 @@ gmx_unused static void nbnxn_atomdata_reduce_reals(real* gmx_restrict dest,
 }
 
 gmx_unused static void nbnxn_atomdata_reduce_reals_simd(real gmx_unused* gmx_restrict dest,
-                                                        gmx_bool gmx_unused bDestSet,
+                                                        gmx_bool gmx_unused           bDestSet,
                                                         const gmx_unused real** gmx_restrict src,
-                                                        int gmx_unused nsrc,
-                                                        int gmx_unused i0,
-                                                        int gmx_unused i1)
+                                                        int gmx_unused                       nsrc,
+                                                        int gmx_unused                       i0,
+                                                        int gmx_unused                       i1)
 {
 #if GMX_SIMD
     /* The SIMD width here is actually independent of that in the kernels,
index 5ac216df225f38e106e55bcdfb2c0ef5943e8a06..e45db48ca3cdfed39295a882719f2763f3b95334 100644 (file)
@@ -179,7 +179,7 @@ static std::unique_ptr<nonbonded_verlet_t> setupNbnxmForBenchInstance(const Kern
                                                                       const gmx::BenchmarkSystem& system)
 {
     const auto pinPolicy  = (options.useGpu ? gmx::PinningPolicy::PinnedIfSupported
-                                           : gmx::PinningPolicy::CannotBePinned);
+                                            : gmx::PinningPolicy::CannotBePinned);
     const int  numThreads = options.numThreads;
     // Note: the options and Nbnxm combination rule enums values should match
     const int combinationRule = static_cast<int>(options.ljCombinationRule);
index b916997a22c6097663814395762edb474e384e65..554748330f24aab23b026b70c688f550c386a945 100644 (file)
@@ -78,7 +78,7 @@ static const float __device__ c_oneTwelveth = 0.08333333f;
 
 /*! Convert LJ sigma,epsilon parameters to C6,C12. */
 static __forceinline__ __device__ void
-                       convert_sigma_epsilon_to_c6_c12(const float sigma, const float epsilon, float* c6, float* c12)
+convert_sigma_epsilon_to_c6_c12(const float sigma, const float epsilon, float* c6, float* c12)
 {
     float sigma2, sigma6;
 
@@ -90,7 +90,7 @@ static __forceinline__ __device__ void
 
 /*! Apply force switch,  force + energy version. */
 static __forceinline__ __device__ void
-                       calculate_force_switch_F(const NBParamGpu nbparam, float c6, float c12, float inv_r, float r2, float* F_invr)
+calculate_force_switch_F(const NBParamGpu nbparam, float c6, float c12, float inv_r, float r2, float* F_invr)
 {
     float r, r_switch;
 
@@ -142,7 +142,7 @@ static __forceinline__ __device__ void calculate_force_switch_F_E(const NBParamG
 
 /*! Apply potential switch, force-only version. */
 static __forceinline__ __device__ void
-                       calculate_potential_switch_F(const NBParamGpu nbparam, float inv_r, float r2, float* F_invr, float* E_lj)
+calculate_potential_switch_F(const NBParamGpu nbparam, float inv_r, float r2, float* F_invr, float* E_lj)
 {
     float r, r_switch;
     float sw, dsw;
@@ -170,7 +170,7 @@ static __forceinline__ __device__ void
 
 /*! Apply potential switch, force + energy version. */
 static __forceinline__ __device__ void
-                       calculate_potential_switch_F_E(const NBParamGpu nbparam, float inv_r, float r2, float* F_invr, float* E_lj)
+calculate_potential_switch_F_E(const NBParamGpu nbparam, float inv_r, float r2, float* F_invr, float* E_lj)
 {
     float r, r_switch;
     float sw, dsw;
@@ -445,7 +445,7 @@ static __forceinline__ __device__ float pmecorrF(float z2)
  *  arbitrary array sizes.
  */
 static __forceinline__ __device__ void
-                       reduce_force_j_generic(float* f_buf, float3* fout, int tidxi, int tidxj, int aidx)
+reduce_force_j_generic(float* f_buf, float3* fout, int tidxi, int tidxj, int aidx)
 {
     if (tidxi < 3)
     {
@@ -463,7 +463,7 @@ static __forceinline__ __device__ void
  *  array sizes.
  */
 static __forceinline__ __device__ void
-                       reduce_force_j_warp_shfl(float3 f, float3* fout, int tidxi, int aidx, const unsigned int activemask)
+reduce_force_j_warp_shfl(float3 f, float3* fout, int tidxi, int aidx, const unsigned int activemask)
 {
     f.x += __shfl_down_sync(activemask, f.x, 1);
     f.y += __shfl_up_sync(activemask, f.y, 1);
@@ -574,7 +574,7 @@ static __forceinline__ __device__ void reduce_force_i_pow2(volatile float* f_buf
  *  on whether the size of the array to be reduced is power of two or not.
  */
 static __forceinline__ __device__ void
-                       reduce_force_i(float* f_buf, float3* f, float* fshift_buf, bool bCalcFshift, int tidxi, int tidxj, int ai)
+reduce_force_i(float* f_buf, float3* f, float* fshift_buf, bool bCalcFshift, int tidxi, int tidxj, int ai)
 {
     if ((c_clSize & (c_clSize - 1)))
     {
@@ -630,7 +630,7 @@ static __forceinline__ __device__ void reduce_force_i_warp_shfl(float3
  *  array sizes.
  */
 static __forceinline__ __device__ void
-                       reduce_energy_pow2(volatile float* buf, float* e_lj, float* e_el, unsigned int tidx)
+reduce_energy_pow2(volatile float* buf, float* e_lj, float* e_el, unsigned int tidx)
 {
     float e1, e2;
 
@@ -665,7 +665,7 @@ static __forceinline__ __device__ void
  *  array sizes.
  */
 static __forceinline__ __device__ void
-                       reduce_energy_warp_shfl(float E_lj, float E_el, float* e_lj, float* e_el, int tidx, const unsigned int activemask)
+reduce_energy_warp_shfl(float E_lj, float E_el, float* e_lj, float* e_el, int tidx, const unsigned int activemask)
 {
     int i, sh;
 
index 3f04782c4f52a95158763a9945bfac2800dc958b..a27ebf07d4f3c46cf852f15e35855e13d01884a7 100644 (file)
@@ -84,7 +84,7 @@ NbnxmGpu* gpu_init(const gmx::DeviceStreamManager gmx_unused& deviceStreamManage
 GPU_FUNC_QUALIFIER
 void gpu_init_pairlist(NbnxmGpu gmx_unused*          nb,
                        const struct NbnxnPairlistGpu gmx_unused* h_nblist,
-                       gmx::InteractionLocality gmx_unused iloc) GPU_FUNC_TERM;
+                       gmx::InteractionLocality gmx_unused       iloc) GPU_FUNC_TERM;
 
 /** Initializes atom-data on the GPU, called at every pair search step. */
 GPU_FUNC_QUALIFIER
index f84ddf3a56f68b3b4a4efe9afed979c7eefb5e5b..acaa19b91214a4f9b3a602d52e5caeae839c1013 100644 (file)
@@ -109,8 +109,8 @@ static void reduceGroupEnergySimdBuffers(int numGroups, int numGroups_2log, nbnx
 
     const real* gmx_restrict vVdwSimd     = out->VSvdw.data();
     const real* gmx_restrict vCoulombSimd = out->VSc.data();
-    real* gmx_restrict vVdw               = out->Vvdw.data();
-    real* gmx_restrict vCoulomb           = out->Vc.data();
+    real* gmx_restrict       vVdw         = out->Vvdw.data();
+    real* gmx_restrict       vCoulomb     = out->Vc.data();
 
     /* The size of the SIMD energy group buffer array is:
      * numGroups*numGroups*numGroupsStorage*unrollj_half*simd_width
index 8d94eaed563a01f4f252ccdc3451fe72f359263e..977b945ce6fc1e82be4447cd27e8d63c4e79af10 100644 (file)
@@ -53,10 +53,10 @@ void nbnxn_kernel_prune_ref(NbnxnPairlistCpu*              nbl,
     nbl->cj.resize(nbl->cjOuter.size());
 
     const nbnxn_ci_t* gmx_restrict ciOuter = nbl->ciOuter.data();
-    nbnxn_ci_t* gmx_restrict ciInner       = nbl->ci.data();
+    nbnxn_ci_t* gmx_restrict       ciInner = nbl->ci.data();
 
     const nbnxn_cj_t* gmx_restrict cjOuter = nbl->cjOuter.data();
-    nbnxn_cj_t* gmx_restrict cjInner       = nbl->cj.data();
+    nbnxn_cj_t* gmx_restrict       cjInner = nbl->cj.data();
 
     const real* gmx_restrict x = nbat->x().data();
 
index 34160ab8c917e3cb01a6b5433f33b996e0dd3213..fff9328a0944d4f77ac59dffc4c6e6e4f376a996 100644 (file)
@@ -2,7 +2,7 @@
  * This file is part of the GROMACS molecular simulation package.
  *
  * Copyright (c) 2012,2013,2014,2015,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.
@@ -104,7 +104,8 @@ static inline void gmx_simdcall gmx_load_simd_2xnn_interactions(int            e
     *interact_S0 = cvtIB2B(testBits(mask_pr_S & filter_S0));
     *interact_S2 = cvtIB2B(testBits(mask_pr_S & filter_S2));
 #elif GMX_SIMD_HAVE_LOGICAL
-    union {
+    union
+    {
 #    if GMX_DOUBLE
         std::int64_t i;
 #    else
index be27518f939fae5c88fc6c377a5341b0abc41a22..bdf2524e519ccfcbdb1510ff7cfd43eefd60d208 100644 (file)
 #if !(defined LJ_COMB_GEOM || defined LJ_COMB_LB || defined FIX_LJ_C)
     /* No combination rule used */
     const real* gmx_restrict nbfp_ptr = nbatParams.nbfp_aligned.data();
-    const int* gmx_restrict type      = nbatParams.type.data();
+    const int* gmx_restrict  type     = nbatParams.type.data();
 #endif
 
     /* Load j-i for the first i */
index eab55185f00ca913e425502c662ecf2593dac4fb..8ca6f06dce886c2a87d782b01936b36793fbd7d6 100644 (file)
@@ -62,10 +62,10 @@ void nbnxn_kernel_prune_2xnn(NbnxnPairlistCpu*              nbl,
     nbl->cj.resize(nbl->cjOuter.size());
 
     const nbnxn_ci_t* gmx_restrict ciOuter = nbl->ciOuter.data();
-    nbnxn_ci_t* gmx_restrict ciInner       = nbl->ci.data();
+    nbnxn_ci_t* gmx_restrict       ciInner = nbl->ci.data();
 
     const nbnxn_cj_t* gmx_restrict cjOuter = nbl->cjOuter.data();
-    nbnxn_cj_t* gmx_restrict cjInner       = nbl->cj.data();
+    nbnxn_cj_t* gmx_restrict       cjInner = nbl->cj.data();
 
     const real* gmx_restrict x = nbat->x().data();
 
index 1ad55177eed52207754c23dbf118f27df7180944..c4af95d65e22f6a4de62f4f5ef3afe1a238dc699 100644 (file)
@@ -97,7 +97,7 @@ typedef gmx::SimdInt32 SimdBitMask;
 typedef gmx::SimdReal SimdBitMask;
 #endif
 
-static inline void gmx_simdcall gmx_load_simd_4xn_interactions(int         excl,
+static inline void gmx_simdcall gmx_load_simd_4xn_interactions(int                    excl,
                                                                SimdBitMask gmx_unused filter_S0,
                                                                SimdBitMask gmx_unused filter_S1,
                                                                SimdBitMask gmx_unused filter_S2,
@@ -117,7 +117,8 @@ static inline void gmx_simdcall gmx_load_simd_4xn_interactions(int         excl,
     *interact_S2 = cvtIB2B(testBits(mask_pr_S & filter_S2));
     *interact_S3 = cvtIB2B(testBits(mask_pr_S & filter_S3));
 #elif GMX_SIMD_HAVE_LOGICAL
-    union {
+    union
+    {
 #    if GMX_DOUBLE
         std::int64_t i;
 #    else
index 1946355f26e6b3b0c5f642983aed49553501c24b..2af0345368940399d85aae7fc1964ff5105b0a6a 100644 (file)
 #if !(defined LJ_COMB_GEOM || defined LJ_COMB_LB || defined FIX_LJ_C)
     /* No combination rule used */
     const real* gmx_restrict nbfp_ptr = nbatParams.nbfp_aligned.data();
-    const int* gmx_restrict type      = nbatParams.type.data();
+    const int* gmx_restrict  type     = nbatParams.type.data();
 #endif
 
     /* Load j-i for the first i */
index cb2059a713230ad8ca8b28200fd6a5201ae7a77b..a623fa5f1783b2cd1795fda0f9458cfe5cd4b924 100644 (file)
@@ -62,10 +62,10 @@ void nbnxn_kernel_prune_4xn(NbnxnPairlistCpu*              nbl,
     nbl->cj.resize(nbl->cjOuter.size());
 
     const nbnxn_ci_t* gmx_restrict ciOuter = nbl->ciOuter.data();
-    nbnxn_ci_t* gmx_restrict ciInner       = nbl->ci.data();
+    nbnxn_ci_t* gmx_restrict       ciInner = nbl->ci.data();
 
     const nbnxn_cj_t* gmx_restrict cjOuter = nbl->cjOuter.data();
-    nbnxn_cj_t* gmx_restrict cjInner       = nbl->cj.data();
+    nbnxn_cj_t* gmx_restrict       cjInner = nbl->cj.data();
 
     const real* gmx_restrict x = nbat->x().data();
 
index a3633c2c7a3394494d83baf5f2dba551ba83af79..74e2f07d516ab9964a8e8b91c02adc54c364dfa5 100644 (file)
@@ -94,7 +94,7 @@ static inline bool useLjCombRule(const enum VdwType vdwType)
 GPU_FUNC_QUALIFIER
 void gpu_copy_xq_to_gpu(NbnxmGpu gmx_unused*          nb,
                         const struct nbnxn_atomdata_t gmx_unused* nbdata,
-                        gmx::AtomLocality gmx_unused aloc) GPU_FUNC_TERM;
+                        gmx::AtomLocality gmx_unused              aloc) GPU_FUNC_TERM;
 
 /*! \brief
  * Launch asynchronously the nonbonded force calculations.
@@ -147,9 +147,9 @@ void gpu_launch_kernel(NbnxmGpu gmx_unused*    nb,
  * \param [in]    numParts  Number of parts the pair list is split into in the rolling kernel.
  */
 GPU_FUNC_QUALIFIER
-void gpu_launch_kernel_pruneonly(NbnxmGpu gmx_unused*     nb,
+void gpu_launch_kernel_pruneonly(NbnxmGpu gmx_unused*                nb,
                                  gmx::InteractionLocality gmx_unused iloc,
-                                 int gmx_unused numParts) GPU_FUNC_TERM;
+                                 int gmx_unused                      numParts) GPU_FUNC_TERM;
 
 /*! \brief
  * Launch asynchronously the download of short-range forces from the GPU
@@ -159,7 +159,7 @@ GPU_FUNC_QUALIFIER
 void gpu_launch_cpyback(NbnxmGpu gmx_unused* nb,
                         nbnxn_atomdata_t gmx_unused* nbatom,
                         const gmx::StepWorkload gmx_unused& stepWork,
-                        gmx::AtomLocality gmx_unused aloc) GPU_FUNC_TERM;
+                        gmx::AtomLocality gmx_unused        aloc) GPU_FUNC_TERM;
 
 /*! \brief Attempts to complete nonbonded GPU task.
  *
@@ -201,11 +201,11 @@ void gpu_launch_cpyback(NbnxmGpu gmx_unused* nb,
 GPU_FUNC_QUALIFIER
 bool gpu_try_finish_task(NbnxmGpu gmx_unused*    nb,
                          const gmx::StepWorkload gmx_unused& stepWork,
-                         gmx::AtomLocality gmx_unused aloc,
+                         gmx::AtomLocality gmx_unused        aloc,
                          real gmx_unused* e_lj,
-                         real gmx_unused*         e_el,
+                         real gmx_unused*                    e_el,
                          gmx::ArrayRef<gmx::RVec> gmx_unused shiftForces,
-                         GpuTaskCompletion gmx_unused completionKind,
+                         GpuTaskCompletion gmx_unused        completionKind,
                          gmx_wallcycle gmx_unused* wcycle) GPU_FUNC_TERM_WITH_RETURN(false);
 
 /*! \brief  Completes the nonbonded GPU task blocking until GPU tasks and data
@@ -225,9 +225,9 @@ bool gpu_try_finish_task(NbnxmGpu gmx_unused*    nb,
 GPU_FUNC_QUALIFIER
 float gpu_wait_finish_task(NbnxmGpu gmx_unused*    nb,
                            const gmx::StepWorkload gmx_unused& stepWork,
-                           gmx::AtomLocality gmx_unused aloc,
+                           gmx::AtomLocality gmx_unused        aloc,
                            real gmx_unused* e_lj,
-                           real gmx_unused*         e_el,
+                           real gmx_unused*                    e_el,
                            gmx::ArrayRef<gmx::RVec> gmx_unused shiftForces,
                            gmx_wallcycle gmx_unused* wcycle) GPU_FUNC_TERM_WITH_RETURN(0.0);
 
@@ -252,12 +252,12 @@ void nbnxn_gpu_init_x_to_nbat_x(const Nbnxm::GridSet gmx_unused& gridSet,
  */
 GPU_FUNC_QUALIFIER
 void nbnxn_gpu_x_to_nbat_x(const Nbnxm::Grid gmx_unused& grid,
-                           NbnxmGpu gmx_unused*    gpu_nbv,
+                           NbnxmGpu gmx_unused*               gpu_nbv,
                            DeviceBuffer<gmx::RVec> gmx_unused d_x,
                            GpuEventSynchronizer gmx_unused* xReadyOnDevice,
-                           gmx::AtomLocality gmx_unused locality,
-                           int gmx_unused gridId,
-                           int gmx_unused numColumnsMax,
+                           gmx::AtomLocality gmx_unused     locality,
+                           int gmx_unused                   gridId,
+                           int gmx_unused                   numColumnsMax,
                            bool gmx_unused mustInsertNonLocalDependency) GPU_FUNC_TERM;
 
 /*! \brief Sync the nonlocal stream with dependent tasks in the local queue.
@@ -271,7 +271,7 @@ void nbnxn_gpu_x_to_nbat_x(const Nbnxm::Grid gmx_unused& grid,
  * \param[in] interactionLocality  Local or NonLocal sync point
  */
 GPU_FUNC_QUALIFIER
-void nbnxnInsertNonlocalGpuDependency(NbnxmGpu gmx_unused* nb,
+void nbnxnInsertNonlocalGpuDependency(NbnxmGpu gmx_unused*                nb,
                                       gmx::InteractionLocality gmx_unused interactionLocality) GPU_FUNC_TERM;
 
 /*! \brief Set up internal flags that indicate what type of short-range work there is.
@@ -288,7 +288,7 @@ void nbnxnInsertNonlocalGpuDependency(NbnxmGpu gmx_unused* nb,
  */
 GPU_FUNC_QUALIFIER
 void setupGpuShortRangeWork(NbnxmGpu gmx_unused* nb,
-                            const gmx::GpuBonded gmx_unused* gpuBonded,
+                            const gmx::GpuBonded gmx_unused*    gpuBonded,
                             gmx::InteractionLocality gmx_unused iLocality) GPU_FUNC_TERM;
 
 /*! \brief Returns true if there is GPU short-range work for the given interaction locality.
index 422840d889afd285cd58ff8419eedaef24f02e1e..b33390c7e25311feb48ce106ae1d8bce6dfd6d4d 100644 (file)
@@ -294,8 +294,7 @@ static KernelSetup pick_nbnxn_kernel(const gmx::MDLogger&     mdlog,
 PairlistSets::PairlistSets(const PairlistParams& pairlistParams,
                            const bool            haveMultipleDomains,
                            const int             minimumIlistCountForGpuBalancing) :
-    params_(pairlistParams),
-    minimumIlistCountForGpuBalancing_(minimumIlistCountForGpuBalancing)
+    params_(pairlistParams), minimumIlistCountForGpuBalancing_(minimumIlistCountForGpuBalancing)
 {
     localSet_ = std::make_unique<PairlistSet>(params_);
 
index 68c1a9df7accde262fbb5633db92bbc7bfbcefd9..8af2f67435ec9601195fe4eb8e705f44e4e11757 100644 (file)
@@ -115,12 +115,12 @@ __kernel void NB_KERNEL_FUNC_NAME(nbnxn_kernel, _F_opencl)
 #ifndef LJ_COMB
                 int ntypes, /* IN  */
 #endif
-                cl_nbparam_params_t nbparam_params,       /* IN  */
-                const __global float4* restrict xq,       /* IN  */
-                __global float* restrict f,               /* OUT stores float3 values */
-                __global float* restrict gmx_unused e_lj, /* OUT */
-                __global float* restrict gmx_unused e_el, /* OUT */
-                __global float* restrict fshift,          /* OUT stores float3 values */
+                cl_nbparam_params_t nbparam_params,         /* IN  */
+                const __global float4* restrict     xq,     /* IN  */
+                __global float* restrict            f,      /* OUT stores float3 values */
+                __global float* restrict gmx_unused e_lj,   /* OUT */
+                __global float* restrict gmx_unused e_el,   /* OUT */
+                __global float* restrict            fshift, /* OUT stores float3 values */
 #ifdef LJ_COMB
                 const __global float2* restrict lj_comb, /* IN stores float2 values */
 #else
@@ -128,9 +128,9 @@ __kernel void NB_KERNEL_FUNC_NAME(nbnxn_kernel, _F_opencl)
 #endif
                 const __global float* restrict shift_vec,          /* IN stores float3 values */
                 __constant const float2* restrict gmx_unused nbfp, /* IN  */
-                __constant const float2* restrict gmx_unused nbfp_comb,  /* IN  */
-                __constant const float* restrict gmx_unused coulomb_tab, /* IN  */
-                const __global nbnxn_sci_t* pl_sci,                      /* IN  */
+                __constant const float2* restrict gmx_unused nbfp_comb,   /* IN  */
+                __constant const float* restrict gmx_unused  coulomb_tab, /* IN  */
+                const __global nbnxn_sci_t* pl_sci,                       /* IN  */
 #ifndef PRUNE_NBL
                 const
 #endif
@@ -558,7 +558,7 @@ __kernel void NB_KERNEL_FUNC_NAME(nbnxn_kernel, _F_opencl)
                                 F_invr += qi * qj_f
                                           * (int_bit * inv_r2
                                              - interpolate_coulomb_force_r(
-                                                       coulomb_tab, r2 * inv_r, coulomb_tab_scale))
+                                                     coulomb_tab, r2 * inv_r, coulomb_tab_scale))
                                           * inv_r;
 #endif /* EL_EWALD_ANA/TAB */
 
index 49d19645a9928b11e134a9858827926b3edd1e99..b4694407250a66fc23e4022eadb0edba66f44ff6 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2016,2017,2018,2019,2020, by the GROMACS development team, led by
+ * Copyright (c) 2016,2017,2018,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.
@@ -65,7 +65,7 @@ nbnxn_kernel_prune_rolling_opencl
 #endif
         (cl_nbparam_params_t nbparam_params,
          const __global float4* restrict xq,
-         const __global float* restrict shift_vec,
+         const __global float* restrict  shift_vec,
          const __global nbnxn_sci_t* pl_sci,
          __global nbnxn_cj4_t* pl_cj4,
 #if !defined HAVE_FRESH_LIST
index 4e2e208d40d9aa8e40ff6f8b57f726d7398e48ef..9344b71a2ece20cb56ef4f784fab17142683c7d9 100644 (file)
@@ -245,7 +245,7 @@ gmx_opencl_inline void preloadCj4Generic(__local int*        sm_cjPreload,
                                          const __global int* gm_cj,
                                          int                 tidxi,
                                          int                 tidxj,
-                                         bool gmx_unused iMaskCond)
+                                         bool gmx_unused     iMaskCond)
 {
     /* Pre-load cj into shared memory */
 #    if defined _AMD_SOURCE_ // TODO: fix by setting c_nbnxnGpuClusterpairSplit properly
@@ -291,9 +291,9 @@ typedef __local int* CjType;
  */
 gmx_opencl_inline void preloadCj4(CjType gmx_unused* cjs,
                                   const __global int gmx_unused* gm_cj,
-                                  int gmx_unused tidxi,
-                                  int gmx_unused tidxj,
-                                  bool gmx_unused iMaskCond)
+                                  int gmx_unused                 tidxi,
+                                  int gmx_unused                 tidxj,
+                                  bool gmx_unused                iMaskCond)
 {
 #    if USE_SUBGROUP_PRELOAD
     *cjs = preloadCj4Subgroup(gm_cj);
@@ -739,14 +739,14 @@ gmx_opencl_inline void reduce_force_i_and_shift_shfl(__private fvec  fci_buf[],
  *  array sizes.
  */
 gmx_opencl_inline void reduce_force_i_and_shift_pow2(volatile __local float* f_buf,
-                                                     __private fvec  fci_buf[],
-                                                     __global float* fout,
-                                                     bool            bCalcFshift,
-                                                     int             tidxi,
-                                                     int             tidxj,
-                                                     int             sci,
-                                                     int             shift,
-                                                     __global float* fshift)
+                                                     __private fvec          fci_buf[],
+                                                     __global float*         fout,
+                                                     bool                    bCalcFshift,
+                                                     int                     tidxi,
+                                                     int                     tidxj,
+                                                     int                     sci,
+                                                     int                     shift,
+                                                     __global float*         fshift)
 {
     float fshift_buf = 0;
     for (int ci_offset = 0; ci_offset < c_nbnxnGpuNumClusterPerSupercluster; ci_offset++)
@@ -818,14 +818,14 @@ gmx_opencl_inline void reduce_force_i_and_shift_pow2(volatile __local float* f_b
 /*! Final i-force reduction
  */
 gmx_opencl_inline void reduce_force_i_and_shift(__local float gmx_unused* f_buf,
-                                                __private fvec  fci_buf[],
-                                                __global float* f,
-                                                bool            bCalcFshift,
-                                                int             tidxi,
-                                                int             tidxj,
-                                                int             sci,
-                                                int             shift,
-                                                __global float* fshift)
+                                                __private fvec            fci_buf[],
+                                                __global float*           f,
+                                                bool                      bCalcFshift,
+                                                int                       tidxi,
+                                                int                       tidxj,
+                                                int                       sci,
+                                                int                       shift,
+                                                __global float*           fshift)
 {
 #    if REDUCE_SHUFFLE
     reduce_force_i_and_shift_shfl(fci_buf, f, bCalcFshift, tidxi, tidxj, sci, shift, fshift);
index 6c8bc8f46de2110504854536bebbe7b3c1b86e24..82ad11778fb189f07c2befeddea481c2e322adac 100644 (file)
@@ -49,10 +49,10 @@ static constexpr int c_xStride2xNN = (GMX_SIMD_REAL_WIDTH >= 2 * c_nbnxnCpuIClus
                                              : c_nbnxnCpuIClusterSize;
 
 //! Copies PBC shifted i-cell packed atom coordinates to working array
-static inline void icell_set_x_simd_2xnn(int  ci,
-                                         real shx,
-                                         real shy,
-                                         real shz,
+static inline void icell_set_x_simd_2xnn(int                   ci,
+                                         real                  shx,
+                                         real                  shy,
+                                         real                  shz,
                                          int gmx_unused        stride,
                                          const real*           x,
                                          NbnxnPairlistCpuWork* work)
@@ -91,20 +91,20 @@ static inline void icell_set_x_simd_2xnn(int  ci,
  * \param[in]     rbb2                The squared cut-off for putting cluster-pairs in the list based on bounding box distance only
  * \param[in,out] numDistanceChecks   The number of distance checks performed
  */
-static inline void makeClusterListSimd2xnn(const Grid&       jGrid,
-                                           NbnxnPairlistCpu* nbl,
-                                           int               icluster,
-                                           int               firstCell,
-                                           int               lastCell,
-                                           bool              excludeSubDiagonal,
+static inline void makeClusterListSimd2xnn(const Grid&              jGrid,
+                                           NbnxnPairlistCpu*        nbl,
+                                           int                      icluster,
+                                           int                      firstCell,
+                                           int                      lastCell,
+                                           bool                     excludeSubDiagonal,
                                            const real* gmx_restrict x_j,
                                            real                     rlist2,
                                            float                    rbb2,
-                                           int* gmx_restrict numDistanceChecks)
+                                           int* gmx_restrict        numDistanceChecks)
 {
     using namespace gmx;
-    const real* gmx_restrict x_ci_simd    = nbl->work->iClusterData.xSimd.data();
-    const BoundingBox* gmx_restrict bb_ci = nbl->work->iClusterData.bb.data();
+    const real* gmx_restrict        x_ci_simd = nbl->work->iClusterData.xSimd.data();
+    const BoundingBox* gmx_restrict bb_ci     = nbl->work->iClusterData.bb.data();
 
     SimdReal jx_S, jy_S, jz_S;
 
index e2328fe49e1718f858fb96b118344925d8c9bb0c..0b86343ce2142ce5b7cf31c076c24e2824a191f5 100644 (file)
@@ -48,10 +48,10 @@ static constexpr int c_xStride4xN =
         (GMX_SIMD_REAL_WIDTH > c_nbnxnCpuIClusterSize ? GMX_SIMD_REAL_WIDTH : c_nbnxnCpuIClusterSize);
 
 //! Copies PBC shifted i-cell packed atom coordinates to working array
-static inline void icell_set_x_simd_4xn(int  ci,
-                                        real shx,
-                                        real shy,
-                                        real shz,
+static inline void icell_set_x_simd_4xn(int                   ci,
+                                        real                  shx,
+                                        real                  shy,
+                                        real                  shz,
                                         int gmx_unused        stride,
                                         const real*           x,
                                         NbnxnPairlistCpuWork* work)
@@ -90,20 +90,20 @@ static inline void icell_set_x_simd_4xn(int  ci,
  * \param[in]     rbb2                The squared cut-off for putting cluster-pairs in the list based on bounding box distance only
  * \param[in,out] numDistanceChecks   The number of distance checks performed
  */
-static inline void makeClusterListSimd4xn(const Grid&       jGrid,
-                                          NbnxnPairlistCpu* nbl,
-                                          int               icluster,
-                                          int               firstCell,
-                                          int               lastCell,
-                                          bool              excludeSubDiagonal,
+static inline void makeClusterListSimd4xn(const Grid&              jGrid,
+                                          NbnxnPairlistCpu*        nbl,
+                                          int                      icluster,
+                                          int                      firstCell,
+                                          int                      lastCell,
+                                          bool                     excludeSubDiagonal,
                                           const real* gmx_restrict x_j,
                                           real                     rlist2,
                                           float                    rbb2,
-                                          int* gmx_restrict numDistanceChecks)
+                                          int* gmx_restrict        numDistanceChecks)
 {
     using namespace gmx;
-    const real* gmx_restrict x_ci_simd    = nbl->work->iClusterData.xSimd.data();
-    const BoundingBox* gmx_restrict bb_ci = nbl->work->iClusterData.bb.data();
+    const real* gmx_restrict        x_ci_simd = nbl->work->iClusterData.xSimd.data();
+    const BoundingBox* gmx_restrict bb_ci     = nbl->work->iClusterData.bb.data();
 
     SimdReal jx_S, jy_S, jz_S;
 
index f9f61db40f6278efca9525be89628076eec66ec6..48f409254af3ccad12d19ae8b6021fa5bbde3c41 100644 (file)
@@ -225,11 +225,10 @@ void increaseNstlist(FILE*               fp,
                        "with an appropriate message above");
 
     const bool  runningOnXeonPhi = (cpuinfo.brandString().find("Xeon Phi") != std::string::npos);
-    const float listfac_ok       = useOrEmulateGpuForNonbondeds
-                                     ? c_nbnxnListSizeFactorGPU
-                                     : runningOnXeonPhi ? c_nbnxnListSizeFactorIntelXeonPhi
-                                                        : c_nbnxnListSizeFactorCpu;
-    float listfac_max = listfac_ok + c_nbnxnListSizeFactorMargin;
+    const float listfac_ok       = useOrEmulateGpuForNonbondeds ? c_nbnxnListSizeFactorGPU
+                                   : runningOnXeonPhi           ? c_nbnxnListSizeFactorIntelXeonPhi
+                                                                : c_nbnxnListSizeFactorCpu;
+    float       listfac_max      = listfac_ok + c_nbnxnListSizeFactorMargin;
 
     const int nstlist_orig = ir->nstlist;
     if (nstlist_cmdline > 0)
index b30f37a50b320b6ba533fcd13102654d92f72f4e..7f3d8eea7ddb9f55dddf82fc9baf1cd8a03edd73 100644 (file)
@@ -120,8 +120,7 @@ struct NbnxnPairlistGpuWork
     };
 
     NbnxnPairlistGpuWork() :
-        distanceBuffer(c_gpuNumClusterPerCell),
-        sci_sort({}, { gmx::PinningPolicy::PinnedIfSupported })
+        distanceBuffer(c_gpuNumClusterPerCell), sci_sort({}, { gmx::PinningPolicy::PinnedIfSupported })
     {
     }
 
index 546b95ff65baf7283103f925d228774d596d1380..a336110b7aa60b7c230f459ef7da8aeb764c4026 100644 (file)
@@ -77,10 +77,7 @@ void SearchCycleCounting::printCycles(FILE* fp, gmx::ArrayRef<const PairsearchWo
 #ifndef DOXYGEN
 
 PairsearchWork::PairsearchWork() :
-    cp0({ { 0 } }),
-    ndistc(0),
-    nbl_fep(std::make_unique<t_nblist>()),
-    cp1({ { 0 } })
+    cp0({ { 0 } }), ndistc(0), nbl_fep(std::make_unique<t_nblist>()), cp1({ { 0 } })
 {
 }
 
index a2bfe59abcba36f92c0c0238d124f4f40553ee20..8b3b81b7f6aa22460852955e42136cbf3537b0c9 100644 (file)
@@ -870,7 +870,7 @@ auto nbnxmKernel(cl::sycl::handler&                                   cgh,
                                 fInvR += qi * qj
                                          * (pairExclMask * r2Inv
                                             - interpolateCoulombForceR(
-                                                      a_coulombTab, coulombTabScale, r2 * rInv))
+                                                    a_coulombTab, coulombTabScale, r2 * rInv))
                                          * rInv;
                             }
 
index 079d4cec8cb78f337b64de83f804c1649bfe2b14..48f749080f371fa75e943c6a739f898527e011b1 100644 (file)
@@ -205,10 +205,7 @@ public:
 };
 
 TextTableFormatter::Impl::Impl() :
-    firstColumnIndent_(0),
-    foldLastColumnToNextLineIndent_(-1),
-    bFirstRow_(true),
-    bPrintHeader_(false)
+    firstColumnIndent_(0), foldLastColumnToNextLineIndent_(-1), bFirstRow_(true), bPrintHeader_(false)
 {
 }
 
index 940d0a94409c02ac71623aefa8147bcf206dc9dc..7c1e54f5f3cf1ca6b07fb64fe0c71a528023cba7 100644 (file)
@@ -277,8 +277,7 @@ public:
     struct LinkItem
     {
         LinkItem(const std::string& linkName, const std::string& replacement) :
-            linkName(linkName),
-            replacement(replacement)
+            linkName(linkName), replacement(replacement)
         {
         }
         std::string linkName;
@@ -343,9 +342,7 @@ public:
     public:
         //! Initializes the state with the given parameters.
         SharedState(TextWriter* writer, HelpOutputFormat format, const HelpLinks* links) :
-            file_(*writer),
-            format_(format),
-            links_(links)
+            file_(*writer), format_(format), links_(links)
         {
         }
 
@@ -389,8 +386,7 @@ public:
     struct ReplaceItem
     {
         ReplaceItem(const std::string& search, const std::string& replace) :
-            search(search),
-            replace(replace)
+            search(search), replace(replace)
         {
         }
         std::string search;
index 7ece420bdc981bbb53351f934441e8458a11fd92..a41643f731cbf39935c1e212ff2dfbeb08a7cfba 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2012,2014,2015,2017,2019, by the GROMACS development team, led by
+ * Copyright (c) 2012,2014,2015,2017,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.
@@ -69,9 +69,7 @@ MockHelpTopic& MockHelpTopic::addSubTopic(gmx::AbstractCompositeHelpTopic* paren
 }
 
 MockHelpTopic::MockHelpTopic(const char* name, const char* title, const char* text) :
-    name_(name),
-    title_(title),
-    text_(text != nullptr ? text : "")
+    name_(name), title_(title), text_(text != nullptr ? text : "")
 {
     if (!isNullOrEmpty(text))
     {
index fa34c5dae44f6794261ac5d043f13f9cb7b24fef..c64e68d78fa15cb6357dae3ee5c615b2b673dd5c 100644 (file)
@@ -105,11 +105,7 @@ protected:
     /*! \cond libapi */
     //! Initializes the name and default values for an option.
     explicit AbstractOption(const char* name) :
-        minValueCount_(1),
-        maxValueCount_(1),
-        name_(name),
-        descr_(nullptr),
-        storeIsSet_(nullptr)
+        minValueCount_(1), maxValueCount_(1), name_(name), descr_(nullptr), storeIsSet_(nullptr)
     {
     }
 
index 2ced2570e46059802190259a4dba40f5ec7fd323..1e0c40b752913560684236e59c3aa3ecf81d770e 100644 (file)
@@ -2,7 +2,7 @@
  * This file is part of the GROMACS molecular simulation package.
  *
  * Copyright (c) 2010-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.
@@ -245,10 +245,7 @@ AbstractOptionStorage* Int64Option::createStorage(const OptionManagerContainer&
  */
 
 DoubleOptionStorage::DoubleOptionStorage(const DoubleOption& settings) :
-    MyBase(settings),
-    info_(this),
-    bTime_(settings.bTime_),
-    factor_(1.0)
+    MyBase(settings), info_(this), bTime_(settings.bTime_), factor_(1.0)
 {
 }
 
@@ -337,10 +334,7 @@ AbstractOptionStorage* DoubleOption::createStorage(const OptionManagerContainer&
  */
 
 FloatOptionStorage::FloatOptionStorage(const FloatOption& settings) :
-    MyBase(settings),
-    info_(this),
-    bTime_(settings.bTime_),
-    factor_(1.0)
+    MyBase(settings), info_(this), bTime_(settings.bTime_), factor_(1.0)
 {
 }
 
@@ -429,8 +423,7 @@ AbstractOptionStorage* FloatOption::createStorage(const OptionManagerContainer&
  */
 
 StringOptionStorage::StringOptionStorage(const StringOption& settings) :
-    MyBase(settings),
-    info_(this)
+    MyBase(settings), info_(this)
 {
     if (settings.defaultEnumIndex_ >= 0 && settings.enumValues_ == nullptr)
     {
@@ -539,8 +532,7 @@ EnumOptionStorage::EnumOptionStorage(const AbstractOption& settings,
                                      int                   defaultValue,
                                      int                   defaultValueIfSet,
                                      StorePointer          store) :
-    MyBase(settings, std::move(store)),
-    info_(this)
+    MyBase(settings, std::move(store)), info_(this)
 {
     if (enumValues == nullptr)
     {
index d432055b261f13ef94bdcfc34c520bda42e7a215..20b34479ed3ff4698d20f559517aacd2aee3070c 100644 (file)
@@ -2,7 +2,7 @@
  * This file is part of the GROMACS molecular simulation package.
  *
  * Copyright (c) 2010-2018, 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.
@@ -313,10 +313,7 @@ public:
 
     //! Initializes an option with the given name.
     explicit StringOption(const char* name) :
-        MyBase(name),
-        enumValues_(nullptr),
-        enumValuesCount_(0),
-        defaultEnumIndex_(-1)
+        MyBase(name), enumValues_(nullptr), enumValuesCount_(0), defaultEnumIndex_(-1)
     {
     }
 
@@ -407,8 +404,7 @@ class EnumIndexStore : public IOptionValueStore<int>
 public:
     //! Initializes the storage for the given actual enum variables.
     EnumIndexStore(EnumType* store, std::vector<EnumType>* storeVector) :
-        store_(store),
-        storeVector_(storeVector)
+        store_(store), storeVector_(storeVector)
     {
         if (storeVector_ != nullptr)
         {
@@ -621,9 +617,7 @@ public:
 
     //! Initializes an option with the given name.
     explicit LegacyEnumOption(const char* name) :
-        MyBase(name),
-        enumValues_(nullptr),
-        enumValuesCount_(0)
+        MyBase(name), enumValues_(nullptr), enumValuesCount_(0)
     {
     }
 
index 41aea4bf508d1d0be445640a042778dfcdba57e7..0c755aeced7e888ef0692ebd46a3a7ec816ac96c 100644 (file)
@@ -136,9 +136,7 @@ private:
 };
 
 FileTypeHandler::FileTypeHandler(int fileType) :
-    fileType_(fileType),
-    extensionCount_(0),
-    genericTypes_(nullptr)
+    fileType_(fileType), extensionCount_(0), genericTypes_(nullptr)
 {
     if (fileType_ >= 0)
     {
index 0ec97a877cd36ced66847a4d3f98229c446c88bd..e8445fd108c4bf0a46d1c7b7a95c4ca5eae3742f 100644 (file)
@@ -2,7 +2,7 @@
  * This file is part of the GROMACS molecular simulation package.
  *
  * Copyright (c) 2010-2018, 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.
@@ -310,15 +310,13 @@ protected:
     template<class U>
     explicit OptionStorageTemplateSimple(const OptionTemplate<T, U>& settings,
                                          OptionFlags                 staticFlags = OptionFlags()) :
-        OptionStorageTemplate<T>(settings, staticFlags),
-        initialized_(false)
+        OptionStorageTemplate<T>(settings, staticFlags), initialized_(false)
     {
     }
     //! Initializes the storage.
     OptionStorageTemplateSimple(const AbstractOption&                           settings,
                                 typename OptionStorageTemplate<T>::StorePointer store) :
-        OptionStorageTemplate<T>(settings, std::move(store)),
-        initialized_(false)
+        OptionStorageTemplate<T>(settings, std::move(store)), initialized_(false)
     {
     }
 
@@ -416,8 +414,7 @@ OptionStorageTemplate<T>::OptionStorageTemplate(const OptionTemplate<T, U>& sett
 
 template<typename T>
 OptionStorageTemplate<T>::OptionStorageTemplate(const AbstractOption& settings, StorePointer store) :
-    AbstractOptionStorage(settings, OptionFlags()),
-    store_(std::move(store))
+    AbstractOptionStorage(settings, OptionFlags()), store_(std::move(store))
 {
 }
 
index 1521ea2b6cd19e4ffa10b5f24a41fcc957c1a838..8325859b37fe015367ac3ecbb51403c7754ce68d 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2016,2018,2019, by the GROMACS development team, led by
+ * Copyright (c) 2016,2018,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.
@@ -81,8 +81,7 @@ public:
 
     //! Creates a section with the given name.
     explicit RepeatingOptionSection(const char* name) :
-        AbstractOptionSection(name),
-        values_(nullptr)
+        AbstractOptionSection(name), values_(nullptr)
     {
     }
 
@@ -114,8 +113,7 @@ class RepeatingOptionSectionStorage : public IOptionSectionStorage
 public:
     //! Initializes the storage for given section properties.
     explicit RepeatingOptionSectionStorage(const RepeatingOptionSection<T>& section) :
-        store_(new OptionValueStoreVector<T>(section.values_)),
-        currentData_()
+        store_(new OptionValueStoreVector<T>(section.values_)), currentData_()
     {
     }
 
index d43ad7d789e1dca4df55147e7c55b54098909231..d8164a11ff0fc67a5ca222d758bbfd83d699bfe9 100644 (file)
@@ -67,8 +67,7 @@ class TreeAssignHelper
 {
 public:
     TreeAssignHelper(Options* options, IKeyValueTreeErrorHandler* errorHandler) :
-        assigner_(options),
-        errorHandler_(errorHandler)
+        assigner_(options), errorHandler_(errorHandler)
     {
         if (errorHandler_ == nullptr)
         {
@@ -151,8 +150,7 @@ class TreeCheckHelper : private OptionsVisitor
 {
 public:
     TreeCheckHelper(const KeyValueTreeObject& root) :
-        currentObject_(&root),
-        currentKnownNames_(nullptr)
+        currentObject_(&root), currentKnownNames_(nullptr)
     {
     }
 
@@ -214,8 +212,7 @@ class TreeAdjustHelper : private OptionsVisitor
 {
 public:
     TreeAdjustHelper(const KeyValueTreeObject& root, KeyValueTreeBuilder* builder) :
-        currentSourceObject_(&root),
-        currentObjectBuilder_(builder->rootObject())
+        currentSourceObject_(&root), currentObjectBuilder_(builder->rootObject())
     {
     }
 
index 1352f63e096258169fa31d78f3deda94e8ca7f3b..b014f63295e4dbf25d8478383e55be6e11a2e8dc 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2016,2017,2018,2019, by the GROMACS development team, led by
+ * Copyright (c) 2016,2017,2018,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.
@@ -56,9 +56,7 @@ class OptionValueStorePlain : public IOptionValueStore<T>
 {
 public:
     OptionValueStorePlain(T* store, int* storeCount, int initialCount) :
-        count_(initialCount),
-        store_(store),
-        storeCount_(storeCount)
+        count_(initialCount), store_(store), storeCount_(storeCount)
     {
     }
 
index 4911850f4f2f100568303ecb8a62040464a91a3a..a2784a6d16012af2734f8558e630fe9e516d6807 100644 (file)
@@ -94,7 +94,7 @@ static inline __device__ int int3ToShiftIndex(int3 iv)
  */
 template<bool returnShift>
 static __forceinline__ __device__ int
-                       pbcDxAiuc(const PbcAiuc& pbcAiuc, const float4 r1, const float4 r2, float3& dr)
+pbcDxAiuc(const PbcAiuc& pbcAiuc, const float4 r1, const float4 r2, float3& dr)
 {
     dr.x = r1.x - r2.x;
     dr.y = r1.y - r2.y;
index 7442b01326dc191f75767d1fd498192fcf733680..b1cbe034f10482406ccdeb8b42bafde570aa318a 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2020, by the GROMACS development team, led by
+ * Copyright (c) 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.
@@ -144,8 +144,7 @@ private:
 };
 
 COMInPlaceTest::COMInPlaceTest() :
-    testCoordinates_(initialCoordinates()),
-    checker_(data_.rootChecker())
+    testCoordinates_(initialCoordinates()), checker_(data_.rootChecker())
 {
     auto& moltype = testTopology_.moltype.emplace_back();
     populateMoleculeType(&moltype);
index e40cecf28c11063bdd62df118f84902ac499f880..2369e5acee3c1f2753097b35001eaf5d9de87e8d 100644 (file)
@@ -264,8 +264,8 @@ static void apply_forces_cyl_grp(const pull_group_work_t& pgrp,
     /* The cylinder group is always a slab in the system, thus large.
      * Therefore we always thread-parallelize this group.
      */
-    const int numAtomsLocal         = localAtomIndices.size();
-    const int gmx_unused numThreads = pgrp.numThreads();
+    const int            numAtomsLocal = localAtomIndices.size();
+    const int gmx_unused numThreads    = pgrp.numThreads();
 #pragma omp parallel for num_threads(numThreads) schedule(static)
     for (int i = 0; i < numAtomsLocal; i++)
     {
index 749d70379c8df9265c726ed9140dd2e49ab3120d..6bffa018d0a7b995d3a36114a574eeb31d65c9e8 100644 (file)
@@ -219,7 +219,7 @@ struct pull_comm_t
 #if GMX_MPI
     MPI_Comm mpi_comm_com; /* Communicator for pulling */
 #endif
-    int  nparticipate; /* The number of ranks participating */
+    int nparticipate; /* The number of ranks participating */
     bool isMasterRank; /* Tells whether our rank is the master rank and thus should add the pull virial */
 
     int64_t setup_count; /* The number of decomposition calls */
index f4e0ba526af8436cdd0ea69d604c32ae8ac3532d..325c3f65b92a6a8fa8d7f7e80df5ad5fdcc0b63c 100644 (file)
@@ -2479,7 +2479,7 @@ static real do_flex_lowlevel(gmx_enfrotgrp* erg,
     return V;
 }
 
-static void sort_collective_coordinates(gmx_enfrotgrp* erg,
+static void sort_collective_coordinates(gmx_enfrotgrp*    erg,
                                         sort_along_vec_t* data) /* Buffer for sorting the positions */
 {
     /* The projection of the position vector on the rotation vector is
index 0b23b04c7949505e1bff14c8df7d30a2c68a30b7..276fd4cf2099427a151158a74702fd0cdd9100de 100644 (file)
@@ -141,8 +141,7 @@ public:
          * \param beta   Second parameter of gamma distribution
          */
         explicit param_type(result_type alpha = 1.0, result_type beta = 1.0) :
-            alpha_(alpha),
-            beta_(beta)
+            alpha_(alpha), beta_(beta)
         {
         }
 
index 4380758705f52d7f9d2fd7e0bdb890efc11d9a02..0925bf268926474e2fbb4ae01bdb00447541cab3 100644 (file)
@@ -126,8 +126,7 @@ public:
          * \param stddev   Standard deviation of normal distribution
          */
         explicit param_type(result_type mean = 0.0, result_type stddev = 1.0) :
-            mean_(mean),
-            stddev_(stddev)
+            mean_(mean), stddev_(stddev)
         {
         }
 
@@ -158,9 +157,7 @@ public:
      * \param stddev   Standard deviation of normal distribution
      */
     explicit NormalDistribution(result_type mean = 0.0, result_type stddev = 1.0) :
-        param_(param_type(mean, stddev)),
-        hot_(false),
-        saved_(0)
+        param_(param_type(mean, stddev)), hot_(false), saved_(0)
     {
     }
 
index 1664c286ca5eb161f736de03a692cff0d444b5e4..fa69e62836b752e2281687c609b2655141fdd50f 100644 (file)
@@ -129,8 +129,7 @@ public:
          *
          */
         explicit param_type(result_type mean = 0.0, result_type stddev = 1.0) :
-            mean_(mean),
-            stddev_(stddev)
+            mean_(mean), stddev_(stddev)
         {
         }
 
@@ -219,9 +218,7 @@ public:
      *  \param stddev  Standard deviation of tabulated normal distribution
      */
     explicit TabulatedNormalDistribution(result_type mean = 0.0, result_type stddev = 1.0) :
-        param_(param_type(mean, stddev)),
-        savedRandomBits_(0),
-        savedRandomBitsLeft_(0)
+        param_(param_type(mean, stddev)), savedRandomBits_(0), savedRandomBitsLeft_(0)
     {
     }
 
@@ -230,9 +227,7 @@ public:
      *  \param param Parameter class containing mean and standard deviation.
      */
     explicit TabulatedNormalDistribution(const param_type& param) :
-        param_(param),
-        savedRandomBits_(0),
-        savedRandomBitsLeft_(0)
+        param_(param), savedRandomBits_(0), savedRandomBitsLeft_(0)
     {
     }
 
index 2e2b4835ea715ffdd8071c3cae28fdbf202ace52..ded231121f12a259147cd6c5b0dd8b962149a50f 100644 (file)
@@ -94,8 +94,7 @@ public:
          * \param b   Upper end of range (inclusive)
          */
         explicit param_type(result_type a = 0, result_type b = std::numeric_limits<result_type>::max()) :
-            a_(a),
-            b_(b)
+            a_(a), b_(b)
         {
             GMX_RELEASE_ASSERT(a <= b, "The uniform integer distribution requires a<=b");
         }
@@ -129,9 +128,7 @@ public:
      */
     explicit UniformIntDistribution(result_type a = 0,
                                     result_type b = std::numeric_limits<result_type>::max()) :
-        param_(param_type(a, b)),
-        savedRandomBits_(0),
-        savedRandomBitsLeft_(0)
+        param_(param_type(a, b)), savedRandomBits_(0), savedRandomBitsLeft_(0)
     {
     }
 
@@ -140,9 +137,7 @@ public:
      * \param param  Parameter class as defined inside gmx::UniformIntDistribution.
      */
     explicit UniformIntDistribution(const param_type& param) :
-        param_(param),
-        savedRandomBits_(0),
-        savedRandomBitsLeft_(0)
+        param_(param), savedRandomBits_(0), savedRandomBitsLeft_(0)
     {
     }
 
index 1596a25be0901cde541a56e92e9ded134ae3a620..04b2c45c75e1673e4f947523806a2a6d30c362c3 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2018,2019, by the GROMACS development team, led by
+ * Copyright (c) 2018,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.
@@ -49,7 +49,7 @@ public:
 
     gmx::PotentialPointData evaluate(gmx::Vector gmx_unused r1,
                                      gmx::Vector gmx_unused r2,
-                                     double gmx_unused t) override
+                                     double gmx_unused      t) override
     {
         return {};
     }
index 693b4e020e0a9cbeddb815f653b34f1f52fef30b..37b2c8cf59342adab446017de4f07d0b243185c3 100644 (file)
@@ -1203,9 +1203,7 @@ public:
      */
     MindistAction(int* closestPoint, real* minDist2, rvec* dx) // NOLINT(readability-non-const-parameter)
         :
-        closestPoint_(*closestPoint),
-        minDist2_(*minDist2),
-        dx_(*dx)
+        closestPoint_(*closestPoint), minDist2_(*minDist2), dx_(*dx)
     {
     }
     //! Copies the action.
index 5a445784b71989d70def7fee9ecec63368473cd4..9fb86b6b33b2509dbbfeee8ffe751d2740bf1666 100644 (file)
@@ -111,33 +111,21 @@ public:
      * to methods that accept positions.
      */
     AnalysisNeighborhoodPositions(const rvec& x) :
-        count_(1),
-        index_(-1),
-        x_(&x),
-        exclusionIds_(nullptr),
-        indices_(nullptr)
+        count_(1), index_(-1), x_(&x), exclusionIds_(nullptr), indices_(nullptr)
     {
     }
     /*! \brief
      * Initializes positions from an array of position vectors.
      */
     AnalysisNeighborhoodPositions(const rvec x[], int count) :
-        count_(count),
-        index_(-1),
-        x_(x),
-        exclusionIds_(nullptr),
-        indices_(nullptr)
+        count_(count), index_(-1), x_(x), exclusionIds_(nullptr), indices_(nullptr)
     {
     }
     /*! \brief
      * Initializes positions from a vector of position vectors.
      */
     AnalysisNeighborhoodPositions(const std::vector<RVec>& x) :
-        count_(ssize(x)),
-        index_(-1),
-        x_(as_rvec_array(x.data())),
-        exclusionIds_(nullptr),
-        indices_(nullptr)
+        count_(ssize(x)), index_(-1), x_(as_rvec_array(x.data())), exclusionIds_(nullptr), indices_(nullptr)
     {
     }
 
@@ -335,10 +323,7 @@ public:
     AnalysisNeighborhoodPair() : refIndex_(-1), testIndex_(0), distance2_(0.0), dx_() {}
     //! Initializes a pair object with the given data.
     AnalysisNeighborhoodPair(int refIndex, int testIndex, real distance2, const rvec dx) :
-        refIndex_(refIndex),
-        testIndex_(testIndex),
-        distance2_(distance2),
-        dx_()
+        refIndex_(refIndex), testIndex_(testIndex), distance2_(distance2), dx_()
     {
         copy_rvec(dx, dx_);
     }
index 9f78139847f1668f1f16900a4e4e6a23a9aa1543..421e16f3198e3c0ff659d7f1a4d769e59cbb1a6d 100644 (file)
@@ -3,7 +3,7 @@
  *
  * Copyright (c) 2009,2010,2011,2012,2013 by the GROMACS development team.
  * Copyright (c) 2014,2015,2016,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.
@@ -330,16 +330,13 @@ namespace gmx
  */
 
 SelectionParserValue::SelectionParserValue(e_selvalue_t type, const SelectionLocation& location) :
-    type(type),
-    location_(location)
+    type(type), location_(location)
 {
     memset(&u, 0, sizeof(u));
 }
 
 SelectionParserValue::SelectionParserValue(const SelectionTreeElementPointer& expr) :
-    type(expr->v.type),
-    expr(expr),
-    location_(expr->location())
+    type(expr->v.type), expr(expr), location_(expr->location())
 {
     memset(&u, 0, sizeof(u));
 }
index d65ac8885d5f847edfadd246a4081b0ae3f9f3c1..7c46ea0009f67cdb8444c93980f8135f2094f3c9 100644 (file)
@@ -2,7 +2,7 @@
  * This file is part of the GROMACS molecular simulation package.
  *
  * Copyright (c) 2009-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.
@@ -237,7 +237,8 @@ public:
     //! String value for \a type ::STR_VALUE.
     std::string str;
     //! The actual value if \a expr is NULL and \a type is not ::STR_VALUE.
-    union {
+    union
+    {
         //! The integer value/range (\a type ::INT_VALUE).
         struct
         {
@@ -295,9 +296,7 @@ public:
     // Default move constructor and assignment. Only needed for old compilers.
     //! \cond
     SelectionParserParameter(SelectionParserParameter&& o) noexcept :
-        name_(std::move(o.name_)),
-        location_(o.location_),
-        values_(std::move(o.values_))
+        name_(std::move(o.name_)), location_(o.location_), values_(std::move(o.values_))
     {
     }
 
index 4e5995608413ece25eb925fa789892efdfc4e8cc..f64be4c2eb786168a43d5d50d4296f1a8985a4b3 100644 (file)
@@ -3,7 +3,7 @@
  *
  * Copyright (c) 2009,2010,2011,2012,2013 by the GROMACS development team.
  * Copyright (c) 2014,2015,2016,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.
@@ -361,10 +361,7 @@ PositionCalculationCollection::requiredTopologyInfoForType(const char* post, boo
  */
 
 PositionCalculationCollection::Impl::Impl() :
-    top_(nullptr),
-    first_(nullptr),
-    last_(nullptr),
-    bInit_(false)
+    top_(nullptr), first_(nullptr), last_(nullptr), bInit_(false)
 {
 }
 
index ed13f9c69fea8bbc2bb0318ce1934148bd8ac466..1baaa46985f597e836136ab8c12652991d943f1d 100644 (file)
@@ -85,9 +85,7 @@ namespace gmx
  */
 
 SelectionCollection::Impl::Impl() :
-    debugLevel_(DebugLevel::None),
-    bExternalGroupsSet_(false),
-    grps_(nullptr)
+    debugLevel_(DebugLevel::None), bExternalGroupsSet_(false), grps_(nullptr)
 {
     sc_.nvars   = 0;
     sc_.varstrs = nullptr;
index 8ae77c809b587444c1fc239f82e269cd00f85f66..039423c7e8b35ea59c66d47e98bee3eb7d0fe9ab 100644 (file)
@@ -2,7 +2,7 @@
  * This file is part of the GROMACS molecular simulation package.
  *
  * Copyright (c) 2010,2012,2013,2014,2015 by the GROMACS development team.
- * Copyright (c) 2016,2018,2019,2020, by the GROMACS development team, led by
+ * Copyright (c) 2016,2018,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.
@@ -107,8 +107,7 @@ struct SelectionTopologyProperties
     SelectionTopologyProperties() : needsTopology(false), needsMasses(false) {}
     //! Initializes properties with the given flags.
     SelectionTopologyProperties(bool needsTopology, bool needsMasses) :
-        needsTopology(needsTopology),
-        needsMasses(needsMasses)
+        needsTopology(needsTopology), needsMasses(needsMasses)
     {
     }
 
index a69b0ba1b108f0e1f132a908940703ec2339bc0f..c213d8e6506ac18dadee268917d6ca2de219df6a 100644 (file)
@@ -2,7 +2,7 @@
  * This file is part of the GROMACS molecular simulation package.
  *
  * Copyright (c) 2010,2011,2012,2013,2014 by the GROMACS development team.
- * Copyright (c) 2015,2018,2019,2020, by the GROMACS development team, led by
+ * Copyright (c) 2015,2018,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.
@@ -84,9 +84,7 @@ public:
 
     //! Initializes an option with the given name.
     explicit SelectionOption(const char* name) :
-        MyBase(name),
-        defaultText_(""),
-        selectionFlags_(efSelection_DisallowEmpty)
+        MyBase(name), defaultText_(""), selectionFlags_(efSelection_DisallowEmpty)
     {
     }
 
index 3da677e2b12ae2488989730bd18f7091a66be3f8..e45fb468c5a0aa335323b7da9208e6f909a30c3d 100644 (file)
@@ -76,10 +76,7 @@ class SelectionOptionBehavior::Impl
 {
 public:
     Impl(SelectionCollection* selections, ITopologyProvider* topologyProvider) :
-        selections_(*selections),
-        topologyProvider_(*topologyProvider),
-        manager_(selections),
-        grps_(nullptr)
+        selections_(*selections), topologyProvider_(*topologyProvider), manager_(selections), grps_(nullptr)
     {
     }
     ~Impl()
index b53bfca8709ba0452e50d79647e86ef4b23363a5..dfaeca25fa64a7b8f211135b422b676b3c63f96d 100644 (file)
@@ -2,7 +2,7 @@
  * This file is part of the GROMACS molecular simulation package.
  *
  * Copyright (c) 2009-2017, 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.
@@ -426,7 +426,8 @@ public:
      */
     int flags;
     //! Data required by the evaluation function.
-    union {
+    union
+    {
         /*! \brief Index group data for several element types.
          *
          *  - \ref SEL_CONST : if the value type is \ref GROUP_VALUE,
index 9e6362b579b0244514fac1b488c773133af62da0..69d93c37179445f7a0c8f5bd71c817fc6a1a684f 100644 (file)
@@ -541,8 +541,7 @@ class KeywordDetailsHelpTopic : public AbstractSimpleHelpTopic
 public:
     //! Initialize help topic for the given selection method.
     KeywordDetailsHelpTopic(const std::string& name, const gmx_ana_selmethod_t& method) :
-        name_(name),
-        method_(method)
+        name_(name), method_(method)
     {
     }
 
index 8836db641111f17fb9a4e61cd2d653a6de7283f9..669f49c7913384def47604fab1ee918df2e05c26 100644 (file)
@@ -2,7 +2,7 @@
  * This file is part of the GROMACS molecular simulation package.
  *
  * Copyright (c) 2009-2016, 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.
@@ -330,9 +330,7 @@ struct SelMethodEvalContext
 {
     //! Initializes the context with given values.
     SelMethodEvalContext(const gmx_mtop_t* top, t_trxframe* fr, const t_pbc* pbc) :
-        top(top),
-        fr(fr),
-        pbc(pbc)
+        top(top), fr(fr), pbc(pbc)
     {
     }
 
index 08872a29a9cb7117f8bcb961fd8f2fbb881ae7d6..d2a51c7d5e56d1ce5c66a6a603e69f63cdfa67d4 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2009,2010,2011,2014,2019, by the GROMACS development team, led by
+ * Copyright (c) 2009,2010,2011,2014,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.
@@ -79,7 +79,8 @@ typedef struct gmx_ana_selvalue_t
      */
     int nr;
     /** Pointer to the value. */
-    union {
+    union
+    {
         /*! \brief
          * Generic pointer for operations that do not need type information.
          *
index abcd1745cdd29eceaa1c86a89ba7321cec6d753d..ac3bc7f41b4d0457e1f4ec381f70d9c9311f326e 100644 (file)
@@ -3,7 +3,7 @@
  *
  * Copyright (c) 2009,2010,2011,2012,2013 by the GROMACS development team.
  * Copyright (c) 2014,2015,2016,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.
@@ -68,7 +68,8 @@
 typedef struct
 {
     /** Value for each atom to match. */
-    union {
+    union
+    {
         int*   i;
         char** s;
         void*  ptr;
@@ -81,7 +82,8 @@ typedef struct
      */
     int nas;
     /** Values to match against. */
-    union {
+    union
+    {
         int*   i;
         char** s;
         void*  ptr;
index 4601e45fd5ab9526a84a0d8da766f991ee0bd986..fcc084b2dce4f41cf5a31fd488e4868cee4a48c7 100644 (file)
@@ -2,7 +2,7 @@
  * This file is part of the GROMACS molecular simulation package.
  *
  * Copyright (c) 2013,2014,2015,2016,2017 by the GROMACS development team.
- * Copyright (c) 2018,2019,2020, by the GROMACS development team, led by
+ * Copyright (c) 2018,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.
@@ -85,11 +85,7 @@ public:
     struct RefPair
     {
         RefPair(int refIndex, real distance) :
-            refIndex(refIndex),
-            distance(distance),
-            bFound(false),
-            bExcluded(false),
-            bIndexed(true)
+            refIndex(refIndex), distance(distance), bFound(false), bExcluded(false), bIndexed(true)
         {
         }
 
@@ -194,9 +190,7 @@ private:
 typedef std::vector<NeighborhoodSearchTestData::RefPair> RefPairList;
 
 NeighborhoodSearchTestData::NeighborhoodSearchTestData(uint64_t seed, real cutoff) :
-    rng_(seed),
-    cutoff_(cutoff),
-    refPosCount_(0)
+    rng_(seed), cutoff_(cutoff), refPosCount_(0)
 {
     clear_mat(box_);
     set_pbc(&pbc_, PbcType::No, box_);
@@ -354,8 +348,7 @@ void ExclusionsHelper::markExcludedPairs(RefPairList* refPairs, int testIndex, c
 }
 
 ExclusionsHelper::ExclusionsHelper(int refPosCount, int testPosCount) :
-    refPosCount_(refPosCount),
-    testPosCount_(testPosCount)
+    refPosCount_(refPosCount), testPosCount_(testPosCount)
 {
     // Generate an array of 0, 1, 2, ...
     // TODO: Make the tests work also with non-trivial exclusion IDs,
index f4f2fcafe3bb775256943b82ce33722e834b49fa..8a558f89b06b02d39a4f2efa2d08e20c3f043e03 100644 (file)
@@ -2,7 +2,7 @@
  * This file is part of the GROMACS molecular simulation package.
  *
  * Copyright (c) 2013,2014,2015,2016,2017 by the GROMACS development team.
- * Copyright (c) 2018,2019,2020, by the GROMACS development team, led by
+ * Copyright (c) 2018,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.
@@ -110,9 +110,7 @@ private:
     struct PositionTest
     {
         PositionTest(PositionPointer pos, gmx_ana_poscalc_t* pc, const char* name) :
-            pos(std::move(pos)),
-            pc(pc),
-            name(name)
+            pos(std::move(pos)), pc(pc), name(name)
         {
         }
 
index 90ab9ef5a45810027dd27a7f45f1f62fa8b046d6..aaaf80f8d4b98dec7b8691c28d0f17b2d57585d7 100644 (file)
@@ -303,7 +303,7 @@ static inline SimdFloat gmx_simdcall frexp(SimdFloat value, SimdFInt32* exponent
     const int32x4_t exponentMask = vdupq_n_s32(0x7F800000);
     const int32x4_t mantissaMask = vdupq_n_s32(0x807FFFFF);
     const int32x4_t exponentBias = vdupq_n_s32(126); // add 1 to make our definition identical to frexp()
-    const float32x4_t half = vdupq_n_f32(0.5F);
+    const float32x4_t half       = vdupq_n_f32(0.5F);
     int32x4_t         iExponent;
 
     iExponent = vandq_s32(vreinterpretq_s32_f32(value.simdInternal_), exponentMask);
index a3d7454c877b39578b1663d492de55fff724a2ea..3e4363517bab6d3c1eef6a7a3d368b6fed0bcca2 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2014,2015,2017,2018,2019, by the GROMACS development team, led by
+ * Copyright (c) 2014,2015,2017,2018,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.
@@ -75,7 +75,7 @@ static inline void gmx_simdcall gatherLoadTranspose(const double*      base,
 
 template<int align>
 static inline void gmx_simdcall
-                   gatherLoadTranspose(const double* base, const std::int32_t offset[], SimdDouble* v0, SimdDouble* v1)
+gatherLoadTranspose(const double* base, const std::int32_t offset[], SimdDouble* v0, SimdDouble* v1)
 {
     float64x2_t t1, t2;
 
@@ -133,7 +133,7 @@ static inline void gmx_simdcall transposeScatterStoreU(double*            base,
 
 template<int align>
 static inline void gmx_simdcall
-                   transposeScatterIncrU(double* base, const std::int32_t offset[], SimdDouble v0, SimdDouble v1, SimdDouble v2)
+transposeScatterIncrU(double* base, const std::int32_t offset[], SimdDouble v0, SimdDouble v1, SimdDouble v2)
 {
     float64x2_t t0, t1, t2;
     float64x1_t t3;
@@ -162,7 +162,7 @@ static inline void gmx_simdcall
 
 template<int align>
 static inline void gmx_simdcall
-                   transposeScatterDecrU(double* base, const std::int32_t offset[], SimdDouble v0, SimdDouble v1, SimdDouble v2)
+transposeScatterDecrU(double* base, const std::int32_t offset[], SimdDouble v0, SimdDouble v1, SimdDouble v2)
 {
     float64x2_t t0, t1, t2;
     float64x1_t t3;
@@ -219,7 +219,7 @@ static inline void gmx_simdcall gatherLoadBySimdIntTranspose(const double* base,
 
 template<int align>
 static inline void gmx_simdcall
-                   gatherLoadBySimdIntTranspose(const double* base, SimdDInt32 offset, SimdDouble* v0, SimdDouble* v1)
+gatherLoadBySimdIntTranspose(const double* base, SimdDInt32 offset, SimdDouble* v0, SimdDouble* v1)
 {
     alignas(GMX_SIMD_ALIGNMENT) std::int32_t ioffset[GMX_SIMD_DINT32_WIDTH];
 
@@ -232,7 +232,7 @@ static inline void gmx_simdcall
 
 template<int align>
 static inline void gmx_simdcall
-                   gatherLoadUBySimdIntTranspose(const double* base, SimdDInt32 offset, SimdDouble* v0, SimdDouble* v1)
+gatherLoadUBySimdIntTranspose(const double* base, SimdDInt32 offset, SimdDouble* v0, SimdDouble* v1)
 {
     alignas(GMX_SIMD_ALIGNMENT) std::int32_t ioffset[GMX_SIMD_DINT32_WIDTH];
 
@@ -248,7 +248,7 @@ static inline void gmx_simdcall
 
 
 static inline double gmx_simdcall
-                     reduceIncr4ReturnSum(double* m, SimdDouble v0, SimdDouble v1, SimdDouble v2, SimdDouble v3)
+reduceIncr4ReturnSum(double* m, SimdDouble v0, SimdDouble v1, SimdDouble v2, SimdDouble v3)
 {
     float64x2_t t1, t2, t3, t4;
 
index 25bd43b07118d6f4f079fdbada1171a503475e1e..34815ccb3aef354a18d248ef552da460b242907f 100644 (file)
@@ -78,7 +78,7 @@ static inline void gmx_simdcall gatherLoadTranspose(const float*       base,
 
 template<int align>
 static inline void gmx_simdcall
-                   gatherLoadTranspose(const float* base, const std::int32_t offset[], SimdFloat* v0, SimdFloat* v1)
+gatherLoadTranspose(const float* base, const std::int32_t offset[], SimdFloat* v0, SimdFloat* v1)
 {
     assert(std::size_t(offset) % 16 == 0);
     assert(std::size_t(base) % 8 == 0);
@@ -120,7 +120,7 @@ static inline void gmx_simdcall gatherLoadUTranspose(const float*       base,
 
 template<int align>
 static inline void gmx_simdcall
-                   transposeScatterStoreU(float* base, const std::int32_t offset[], SimdFloat v0, SimdFloat v1, SimdFloat v2)
+transposeScatterStoreU(float* base, const std::int32_t offset[], SimdFloat v0, SimdFloat v1, SimdFloat v2)
 {
     assert(std::size_t(offset) % 16 == 0);
 
@@ -140,7 +140,7 @@ static inline void gmx_simdcall
 
 template<int align>
 static inline void gmx_simdcall
-                   transposeScatterIncrU(float* base, const std::int32_t offset[], SimdFloat v0, SimdFloat v1, SimdFloat v2)
+transposeScatterIncrU(float* base, const std::int32_t offset[], SimdFloat v0, SimdFloat v1, SimdFloat v2)
 {
     assert(std::size_t(offset) % 16 == 0);
 
@@ -191,7 +191,7 @@ static inline void gmx_simdcall
 
 template<int align>
 static inline void gmx_simdcall
-                   transposeScatterDecrU(float* base, const std::int32_t offset[], SimdFloat v0, SimdFloat v1, SimdFloat v2)
+transposeScatterDecrU(float* base, const std::int32_t offset[], SimdFloat v0, SimdFloat v1, SimdFloat v2)
 {
     assert(std::size_t(offset) % 16 == 0);
 
@@ -281,7 +281,7 @@ static inline void gmx_simdcall gatherLoadBySimdIntTranspose(const float* base,
 
 template<int align>
 static inline void gmx_simdcall
-                   gatherLoadBySimdIntTranspose(const float* base, SimdFInt32 offset, SimdFloat* v0, SimdFloat* v1)
+gatherLoadBySimdIntTranspose(const float* base, SimdFInt32 offset, SimdFloat* v0, SimdFloat* v1)
 {
     alignas(GMX_SIMD_ALIGNMENT) std::int32_t ioffset[GMX_SIMD_FINT32_WIDTH];
 
@@ -292,7 +292,7 @@ static inline void gmx_simdcall
 
 template<int align>
 static inline void gmx_simdcall
-                   gatherLoadUBySimdIntTranspose(const float* base, SimdFInt32 offset, SimdFloat* v0, SimdFloat* v1)
+gatherLoadUBySimdIntTranspose(const float* base, SimdFInt32 offset, SimdFloat* v0, SimdFloat* v1)
 {
     alignas(GMX_SIMD_ALIGNMENT) std::int32_t ioffset[GMX_SIMD_FINT32_WIDTH];
 
index 2945ea66a03df0b95445dfc3bdd2ad37a8da11a5..4af421f27b784d33747013861935c56053f5a22d 100644 (file)
@@ -2,7 +2,7 @@
  * This file is part of the GROMACS molecular simulation package.
  *
  * Copyright (c) 2020 Research Organization for Information Science and Technology (RIST).
- * Copyright (c) 2020, by the GROMACS development team, led by
+ * Copyright (c) 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.
@@ -386,7 +386,7 @@ static inline SimdFloat gmx_simdcall frexp(SimdFloat value, SimdFInt32* exponent
     const svint32_t exponentMask = svdup_n_s32(0x7F800000);
     const svint32_t mantissaMask = svdup_n_s32(0x807FFFFF);
     const svint32_t exponentBias = svdup_n_s32(126); // add 1 to make our definition identical to frexp()
-    const svfloat32_t half = svdup_n_f32(0.5f);
+    const svfloat32_t half       = svdup_n_f32(0.5f);
     svint32_t         iExponent;
 
     iExponent = svand_s32_x(pg, svreinterpret_s32_f32(value.simdInternal_), exponentMask);
index d3d054c97d1b17e4a9151645bec3bc73d998299b..d7c839303edea7d5fab58b6a4feef89358ad984b 100644 (file)
@@ -104,7 +104,7 @@ static inline void gmx_simdcall gatherLoadTranspose(const double*      base,
 
 template<int align>
 static inline void gmx_simdcall
-                   gatherLoadBySimdIntTranspose(const double* base, SimdDInt32 offset, SimdDouble* v0, SimdDouble* v1)
+gatherLoadBySimdIntTranspose(const double* base, SimdDInt32 offset, SimdDouble* v0, SimdDouble* v1)
 {
     // Base pointer must be aligned to the smaller of 2 elements and float SIMD width
     assert(std::size_t(base) % 8 == 0);
@@ -121,7 +121,7 @@ static inline void gmx_simdcall
 
 template<int align>
 static inline void gmx_simdcall
-                   gatherLoadTranspose(const double* base, const std::int32_t offset[], SimdDouble* v0, SimdDouble* v1)
+gatherLoadTranspose(const double* base, const std::int32_t offset[], SimdDouble* v0, SimdDouble* v1)
 {
     assert(std::size_t(offset) % 64 == 0);
     assert(std::size_t(base) % 8 == 0);
@@ -183,7 +183,7 @@ static inline void gmx_simdcall transposeScatterStoreU(double*            base,
 
 template<int align>
 static inline void gmx_simdcall
-                   transposeScatterIncrU(double* base, const std::int32_t offset[], SimdDouble v0, SimdDouble v1, SimdDouble v2)
+transposeScatterIncrU(double* base, const std::int32_t offset[], SimdDouble v0, SimdDouble v1, SimdDouble v2)
 {
     assert(std::size_t(offset) % 32 == 0);
 
@@ -214,7 +214,7 @@ static inline void gmx_simdcall
 
 template<int align>
 static inline void gmx_simdcall
-                   transposeScatterDecrU(double* base, const std::int32_t offset[], SimdDouble v0, SimdDouble v1, SimdDouble v2)
+transposeScatterDecrU(double* base, const std::int32_t offset[], SimdDouble v0, SimdDouble v1, SimdDouble v2)
 {
     assert(std::size_t(offset) % 16 == 0);
 
@@ -284,7 +284,7 @@ static inline void gmx_simdcall gatherLoadBySimdIntTranspose(const double* base,
 
 template<int align>
 static inline void gmx_simdcall
-                   gatherLoadUBySimdIntTranspose(const double* base, SimdDInt32 offset, SimdDouble* v0, SimdDouble* v1)
+gatherLoadUBySimdIntTranspose(const double* base, SimdDInt32 offset, SimdDouble* v0, SimdDouble* v1)
 {
     svbool_t  pg      = svptrue_b64();
     svint64_t offsets = svmul_n_s64_x(pg, offset.simdInternal_, align * sizeof(double));
@@ -294,7 +294,7 @@ static inline void gmx_simdcall
 }
 
 static inline double gmx_simdcall
-                     reduceIncr4ReturnSum(double* m, SimdDouble v0, SimdDouble v1, SimdDouble v2, SimdDouble v3)
+reduceIncr4ReturnSum(double* m, SimdDouble v0, SimdDouble v1, SimdDouble v2, SimdDouble v3)
 {
     assert(std::size_t(m) % 16 == 0);
     svbool_t    pg = svptrue_b64();
index fc9fe741711eb110a9f649266542aabfbc67e93b..126e27b7b2646dfcac3c558e8e6162bd52831423 100644 (file)
@@ -65,7 +65,7 @@ namespace gmx
 
 template<int align>
 static inline void gmx_simdcall
-                   gatherLoadBySimdIntTranspose(const float* base, SimdFInt32 offset, SimdFloat* v0, SimdFloat* v1)
+gatherLoadBySimdIntTranspose(const float* base, SimdFInt32 offset, SimdFloat* v0, SimdFloat* v1)
 {
     // Base pointer must be aligned to the smaller of 2 elements and float SIMD width
     assert(std::size_t(base) % 8 == 0);
@@ -123,7 +123,7 @@ static inline void gmx_simdcall gatherLoadTranspose(const float*       base,
 
 template<int align>
 static inline void gmx_simdcall
-                   gatherLoadTranspose(const float* base, const std::int32_t offset[], SimdFloat* v0, SimdFloat* v1)
+gatherLoadTranspose(const float* base, const std::int32_t offset[], SimdFloat* v0, SimdFloat* v1)
 {
     assert(std::size_t(offset) % 64 == 0);
     assert(std::size_t(base) % 8 == 0);
@@ -159,7 +159,7 @@ static inline void gmx_simdcall gatherLoadUTranspose(const float*       base,
 
 template<int align>
 static inline void gmx_simdcall
-                   transposeScatterStoreU(float* base, const std::int32_t offset[], SimdFloat v0, SimdFloat v1, SimdFloat v2)
+transposeScatterStoreU(float* base, const std::int32_t offset[], SimdFloat v0, SimdFloat v1, SimdFloat v2)
 {
     assert(std::size_t(offset) % 16 == 0);
 
@@ -176,7 +176,7 @@ static inline void gmx_simdcall
 
 template<int align>
 static inline void gmx_simdcall
-                   transposeScatterIncrU(float* base, const std::int32_t offset[], SimdFloat v0, SimdFloat v1, SimdFloat v2)
+transposeScatterIncrU(float* base, const std::int32_t offset[], SimdFloat v0, SimdFloat v1, SimdFloat v2)
 {
     assert(std::size_t(offset) % 64 == 0);
 
@@ -197,7 +197,7 @@ static inline void gmx_simdcall
 
 template<int align>
 static inline void gmx_simdcall
-                   transposeScatterDecrU(float* base, const std::int32_t offset[], SimdFloat v0, SimdFloat v1, SimdFloat v2)
+transposeScatterDecrU(float* base, const std::int32_t offset[], SimdFloat v0, SimdFloat v1, SimdFloat v2)
 {
     assert(std::size_t(offset) % 16 == 0);
 
@@ -262,7 +262,7 @@ static inline void gmx_simdcall gatherLoadBySimdIntTranspose(const float* base,
 
 template<int align>
 static inline void gmx_simdcall
-                   gatherLoadUBySimdIntTranspose(const float* base, SimdFInt32 offset, SimdFloat* v0, SimdFloat* v1)
+gatherLoadUBySimdIntTranspose(const float* base, SimdFInt32 offset, SimdFloat* v0, SimdFloat* v1)
 {
     svbool_t  pg      = svptrue_b32();
     svint32_t offsets = svmul_n_s32_x(pg, offset.simdInternal_, align * 4);
index a84317a3edb6d9b6ca46e258460507f9c27829b4..fda07d674e2d8a4f5c78a08818e1956dffe972ea 100644 (file)
@@ -2,7 +2,7 @@
  * This file is part of the GROMACS molecular simulation package.
  *
  * Copyright (c) 2014,2015,2016,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.
@@ -69,7 +69,7 @@ static inline void gmx_simdcall gatherLoadTranspose(const double*      base,
 
 template<int align>
 static inline void gmx_simdcall
-                   gatherLoadTranspose(const double* base, const std::int32_t offset[], SimdDouble* v0, SimdDouble* v1)
+gatherLoadTranspose(const double* base, const std::int32_t offset[], SimdDouble* v0, SimdDouble* v1)
 {
     __vector double t1, t2;
 
@@ -101,10 +101,10 @@ static inline void gmx_simdcall gatherLoadUTranspose(const double*      base,
 
 // gcc-4.9 fails to recognize that the argument to vec_extract() is used
 template<int align>
-static inline void gmx_simdcall transposeScatterStoreU(double*            base,
-                                                       const std::int32_t offset[],
-                                                       SimdDouble         v0,
-                                                       SimdDouble         v1,
+static inline void gmx_simdcall transposeScatterStoreU(double*               base,
+                                                       const std::int32_t    offset[],
+                                                       SimdDouble            v0,
+                                                       SimdDouble            v1,
                                                        SimdDouble gmx_unused v2)
 {
     SimdDouble t1, t2;
@@ -120,7 +120,7 @@ static inline void gmx_simdcall transposeScatterStoreU(double*            base,
 
 template<int align>
 static inline void gmx_simdcall
-                   transposeScatterIncrU(double* base, const std::int32_t offset[], SimdDouble v0, SimdDouble v1, SimdDouble v2)
+transposeScatterIncrU(double* base, const std::int32_t offset[], SimdDouble v0, SimdDouble v1, SimdDouble v2)
 {
     if (align % 4 == 0)
     {
@@ -168,7 +168,7 @@ static inline void gmx_simdcall
 
 template<int align>
 static inline void gmx_simdcall
-                   transposeScatterDecrU(double* base, const std::int32_t offset[], SimdDouble v0, SimdDouble v1, SimdDouble v2)
+transposeScatterDecrU(double* base, const std::int32_t offset[], SimdDouble v0, SimdDouble v1, SimdDouble v2)
 {
     if (align % 4 == 0)
     {
@@ -240,7 +240,7 @@ static inline void gmx_simdcall gatherLoadBySimdIntTranspose(const double* base,
 
 template<int align>
 static inline void gmx_simdcall
-                   gatherLoadBySimdIntTranspose(const double* base, SimdDInt32 offset, SimdDouble* v0, SimdDouble* v1)
+gatherLoadBySimdIntTranspose(const double* base, SimdDInt32 offset, SimdDouble* v0, SimdDouble* v1)
 {
     alignas(GMX_SIMD_ALIGNMENT) std::int32_t ioffset[GMX_SIMD_DINT32_WIDTH];
 
@@ -251,7 +251,7 @@ static inline void gmx_simdcall
 
 template<int align>
 static inline void gmx_simdcall
-                   gatherLoadUBySimdIntTranspose(const double* base, SimdDInt32 offset, SimdDouble* v0, SimdDouble* v1)
+gatherLoadUBySimdIntTranspose(const double* base, SimdDInt32 offset, SimdDouble* v0, SimdDouble* v1)
 {
     alignas(GMX_SIMD_ALIGNMENT) std::int32_t ioffset[GMX_SIMD_DINT32_WIDTH];
 
@@ -264,7 +264,7 @@ static inline void gmx_simdcall
 }
 
 static inline double gmx_simdcall
-                     reduceIncr4ReturnSum(double* m, SimdDouble v0, SimdDouble v1, SimdDouble v2, SimdDouble v3)
+reduceIncr4ReturnSum(double* m, SimdDouble v0, SimdDouble v1, SimdDouble v2, SimdDouble v3)
 {
     __vector double t1, t2, t3, t4;
 
index da57a8ae669bac7494134c257f4c06973ffbf67b..17a5688d8d921bc7600236e76738dca4fecc279a 100644 (file)
@@ -2,7 +2,7 @@
  * This file is part of the GROMACS molecular simulation package.
  *
  * Copyright (c) 2014,2015,2016,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.
@@ -74,7 +74,7 @@ static inline void gmx_simdcall gatherLoadTranspose(const float*       base,
 
 template<int align>
 static inline void gmx_simdcall
-                   gatherLoadTranspose(const float* base, const std::int32_t offset[], SimdFloat* v0, SimdFloat* v1)
+gatherLoadTranspose(const float* base, const std::int32_t offset[], SimdFloat* v0, SimdFloat* v1)
 {
     __vector float t0, t1, t2, t3;
 
@@ -141,10 +141,10 @@ static inline void gmx_simdcall gatherLoadUTranspose(const float*       base,
 
 // gcc-4.9 does not recognize that the argument to vec_extract() is used
 template<int align>
-static inline void gmx_simdcall transposeScatterStoreU(float*             base,
-                                                       const std::int32_t offset[],
-                                                       SimdFloat          v0,
-                                                       SimdFloat          v1,
+static inline void gmx_simdcall transposeScatterStoreU(float*               base,
+                                                       const std::int32_t   offset[],
+                                                       SimdFloat            v0,
+                                                       SimdFloat            v1,
                                                        SimdFloat gmx_unused v2)
 {
     __vector float t1, t2;
@@ -167,7 +167,7 @@ static inline void gmx_simdcall transposeScatterStoreU(float*             base,
 
 template<int align>
 static inline void gmx_simdcall
-                   transposeScatterIncrU(float* base, const std::int32_t offset[], SimdFloat v0, SimdFloat v1, SimdFloat v2)
+transposeScatterIncrU(float* base, const std::int32_t offset[], SimdFloat v0, SimdFloat v1, SimdFloat v2)
 {
     if (align < 4)
     {
@@ -242,7 +242,7 @@ static inline void gmx_simdcall
 
 template<int align>
 static inline void gmx_simdcall
-                   transposeScatterDecrU(float* base, const std::int32_t offset[], SimdFloat v0, SimdFloat v1, SimdFloat v2)
+transposeScatterDecrU(float* base, const std::int32_t offset[], SimdFloat v0, SimdFloat v1, SimdFloat v2)
 {
     if (align < 4)
     {
@@ -355,7 +355,7 @@ static inline void gmx_simdcall gatherLoadBySimdIntTranspose(const float* base,
 
 template<int align>
 static inline void gmx_simdcall
-                   gatherLoadBySimdIntTranspose(const float* base, SimdFInt32 offset, SimdFloat* v0, SimdFloat* v1)
+gatherLoadBySimdIntTranspose(const float* base, SimdFInt32 offset, SimdFloat* v0, SimdFloat* v1)
 {
     alignas(GMX_SIMD_ALIGNMENT) std::int32_t ioffset[GMX_SIMD_FINT32_WIDTH];
 
@@ -365,7 +365,7 @@ static inline void gmx_simdcall
 
 template<int align>
 static inline void gmx_simdcall
-                   gatherLoadUBySimdIntTranspose(const float* base, SimdFInt32 offset, SimdFloat* v0, SimdFloat* v1)
+gatherLoadUBySimdIntTranspose(const float* base, SimdFInt32 offset, SimdFloat* v0, SimdFloat* v1)
 {
     alignas(GMX_SIMD_ALIGNMENT) std::int32_t ioffset[GMX_SIMD_FINT32_WIDTH];
 
index 6511c96b5dc06253a070ad03d206fbf665a3a117..e1f92051cc91fbea282848812b0fbfb293b01d0a 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2014,2015,2019, by the GROMACS development team, led by
+ * Copyright (c) 2014,2015,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.
@@ -200,7 +200,8 @@ static inline Simd4Double gmx_simdcall operator&(Simd4Double a, Simd4Double b)
 {
     Simd4Double res;
 
-    union {
+    union
+    {
         double       r;
         std::int64_t i;
     } conv1, conv2;
@@ -228,7 +229,8 @@ static inline Simd4Double gmx_simdcall andNot(Simd4Double a, Simd4Double b)
 {
     Simd4Double res;
 
-    union {
+    union
+    {
         double       r;
         std::int64_t i;
     } conv1, conv2;
@@ -256,7 +258,8 @@ static inline Simd4Double gmx_simdcall operator|(Simd4Double a, Simd4Double b)
 {
     Simd4Double res;
 
-    union {
+    union
+    {
         double       r;
         std::int64_t i;
     } conv1, conv2;
@@ -283,7 +286,8 @@ static inline Simd4Double gmx_simdcall operator^(Simd4Double a, Simd4Double b)
 {
     Simd4Double res;
 
-    union {
+    union
+    {
         double       r;
         std::int64_t i;
     } conv1, conv2;
index 81f81d2d839d22330a29620ef3e7b8a364088662..bd6d240e3f8e8e9d6abf706bb4f6366215873f7e 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2014,2015,2019, by the GROMACS development team, led by
+ * Copyright (c) 2014,2015,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.
@@ -200,7 +200,8 @@ static inline Simd4Float gmx_simdcall operator&(Simd4Float a, Simd4Float b)
 {
     Simd4Float res;
 
-    union {
+    union
+    {
         float        r;
         std::int32_t i;
     } conv1, conv2;
@@ -228,7 +229,8 @@ static inline Simd4Float gmx_simdcall andNot(Simd4Float a, Simd4Float b)
 {
     Simd4Float res;
 
-    union {
+    union
+    {
         float        r;
         std::int32_t i;
     } conv1, conv2;
@@ -256,7 +258,8 @@ static inline Simd4Float gmx_simdcall operator|(Simd4Float a, Simd4Float b)
 {
     Simd4Float res;
 
-    union {
+    union
+    {
         float        r;
         std::int32_t i;
     } conv1, conv2;
@@ -283,7 +286,8 @@ static inline Simd4Float gmx_simdcall operator^(Simd4Float a, Simd4Float b)
 {
     Simd4Float res;
 
-    union {
+    union
+    {
         float        r;
         std::int32_t i;
     } conv1, conv2;
index 6640eb82f275eee5ec40425c3f70e2e02820060b..a2377f808c30500f306b98f7725f3416d0e1733d 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2014,2015,2016,2017,2019,2020, by the GROMACS development team, led by
+ * Copyright (c) 2014,2015,2016,2017,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.
@@ -364,7 +364,8 @@ static inline SimdDouble gmx_simdcall operator&(SimdDouble a, SimdDouble b)
 {
     SimdDouble res;
 
-    union {
+    union
+    {
         double       r;
         std::int64_t i;
     } conv1, conv2;
@@ -391,7 +392,8 @@ static inline SimdDouble gmx_simdcall andNot(SimdDouble a, SimdDouble b)
 {
     SimdDouble res;
 
-    union {
+    union
+    {
         double       r;
         std::int64_t i;
     } conv1, conv2;
@@ -418,7 +420,8 @@ static inline SimdDouble gmx_simdcall operator|(SimdDouble a, SimdDouble b)
 {
     SimdDouble res;
 
-    union {
+    union
+    {
         double       r;
         std::int64_t i;
     } conv1, conv2;
@@ -445,7 +448,8 @@ static inline SimdDouble gmx_simdcall operator^(SimdDouble a, SimdDouble b)
 {
     SimdDouble res;
 
-    union {
+    union
+    {
         double       r;
         std::int64_t i;
     } conv1, conv2;
@@ -975,7 +979,8 @@ static inline SimdDBool gmx_simdcall testBits(SimdDouble a)
 
     for (std::size_t i = 0; i < res.simdInternal_.size(); i++)
     {
-        union {
+        union
+        {
             std::uint64_t i;
             double        d;
         } conv;
index aa740c7fecb7b5aa980e3a4821b2e61c12bea94a..4e05599007cbe0ce0d283a083f4e2c476687809b 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2014,2015,2016,2017,2019,2020, by the GROMACS development team, led by
+ * Copyright (c) 2014,2015,2016,2017,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.
@@ -363,7 +363,8 @@ static inline SimdFloat gmx_simdcall operator&(SimdFloat a, SimdFloat b)
 {
     SimdFloat res;
 
-    union {
+    union
+    {
         float        r;
         std::int32_t i;
     } conv1, conv2;
@@ -390,7 +391,8 @@ static inline SimdFloat gmx_simdcall andNot(SimdFloat a, SimdFloat b)
 {
     SimdFloat res;
 
-    union {
+    union
+    {
         float        r;
         std::int32_t i;
     } conv1, conv2;
@@ -417,7 +419,8 @@ static inline SimdFloat gmx_simdcall operator|(SimdFloat a, SimdFloat b)
 {
     SimdFloat res;
 
-    union {
+    union
+    {
         float        r;
         std::int32_t i;
     } conv1, conv2;
@@ -444,7 +447,8 @@ static inline SimdFloat gmx_simdcall operator^(SimdFloat a, SimdFloat b)
 {
     SimdFloat res;
 
-    union {
+    union
+    {
         float        r;
         std::int32_t i;
     } conv1, conv2;
@@ -968,7 +972,8 @@ static inline SimdFBool gmx_simdcall testBits(SimdFloat a)
 
     for (std::size_t i = 0; i < res.simdInternal_.size(); i++)
     {
-        union {
+        union
+        {
             std::uint32_t i;
             float         f;
         } conv;
index 7c051f7e1c64c7145de8a9015d2a28eb02ed12a8..777af5ba1a837d0aca8b65fa7a9663a701899c4f 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2014,2015,2017,2019,2020, by the GROMACS development team, led by
+ * Copyright (c) 2014,2015,2017,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.
@@ -150,7 +150,7 @@ static inline void gmx_simdcall gatherLoadTranspose(const double*      base,
  */
 template<int align>
 static inline void gmx_simdcall
-                   gatherLoadTranspose(const double* base, const std::int32_t offset[], SimdDouble* v0, SimdDouble* v1)
+gatherLoadTranspose(const double* base, const std::int32_t offset[], SimdDouble* v0, SimdDouble* v1)
 {
     // Offset list must be aligned for SIMD DINT32
     assert(std::size_t(offset) % (GMX_SIMD_DINT32_WIDTH * sizeof(std::int32_t)) == 0);
@@ -326,7 +326,7 @@ static inline void gmx_simdcall transposeScatterStoreU(double*            base,
  */
 template<int align>
 static inline void gmx_simdcall
-                   transposeScatterIncrU(double* base, const std::int32_t offset[], SimdDouble v0, SimdDouble v1, SimdDouble v2)
+transposeScatterIncrU(double* base, const std::int32_t offset[], SimdDouble v0, SimdDouble v1, SimdDouble v2)
 {
     // Offset list must be aligned for SIMD DINT32
     assert(std::size_t(offset) % (GMX_SIMD_DINT32_WIDTH * sizeof(std::int32_t)) == 0);
@@ -381,7 +381,7 @@ static inline void gmx_simdcall
  */
 template<int align>
 static inline void gmx_simdcall
-                   transposeScatterDecrU(double* base, const std::int32_t offset[], SimdDouble v0, SimdDouble v1, SimdDouble v2)
+transposeScatterDecrU(double* base, const std::int32_t offset[], SimdDouble v0, SimdDouble v1, SimdDouble v2)
 {
     // Offset list must be aligned for SIMD DINT32
     assert(std::size_t(offset) % (GMX_SIMD_DINT32_WIDTH * sizeof(std::int32_t)) == 0);
@@ -504,7 +504,7 @@ static inline void gmx_simdcall gatherLoadBySimdIntTranspose(const double* base,
  */
 template<int align>
 static inline void gmx_simdcall
-                   gatherLoadUBySimdIntTranspose(const double* base, SimdDInt32 offset, SimdDouble* v0, SimdDouble* v1)
+gatherLoadUBySimdIntTranspose(const double* base, SimdDInt32 offset, SimdDouble* v0, SimdDouble* v1)
 {
     for (std::size_t i = 0; i < v0->simdInternal_.size(); i++)
     {
@@ -539,7 +539,7 @@ static inline void gmx_simdcall
  */
 template<int align>
 static inline void gmx_simdcall
-                   gatherLoadBySimdIntTranspose(const double* base, SimdDInt32 offset, SimdDouble* v0, SimdDouble* v1)
+gatherLoadBySimdIntTranspose(const double* base, SimdDInt32 offset, SimdDouble* v0, SimdDouble* v1)
 {
     // Base pointer must be aligned to the smaller of 2 elements and double SIMD width
     assert(std::size_t(base) % (std::min(GMX_SIMD_DOUBLE_WIDTH, 2) * sizeof(double)) == 0);
@@ -580,7 +580,7 @@ static inline void gmx_simdcall
  * just ignore the return value (Checked with gcc-4.9.1 and clang-3.6 for AVX).
  */
 static inline double gmx_simdcall
-                     reduceIncr4ReturnSum(double* m, SimdDouble v0, SimdDouble v1, SimdDouble v2, SimdDouble v3)
+reduceIncr4ReturnSum(double* m, SimdDouble v0, SimdDouble v1, SimdDouble v2, SimdDouble v3)
 {
     double sum[4]; // Note that the 4 here corresponds to the 4 m-elements, not any SIMD width
 
index 5e2ac95fd5154398add59961cb43bd7f667c96bd..c7e52fbe4afa341c1ea5501b9832dc6e87d30843 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2014,2015,2017,2019,2020, by the GROMACS development team, led by
+ * Copyright (c) 2014,2015,2017,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.
@@ -157,7 +157,7 @@ static inline void gmx_simdcall gatherLoadTranspose(const float*       base,
  */
 template<int align>
 static inline void gmx_simdcall
-                   gatherLoadTranspose(const float* base, const std::int32_t offset[], SimdFloat* v0, SimdFloat* v1)
+gatherLoadTranspose(const float* base, const std::int32_t offset[], SimdFloat* v0, SimdFloat* v1)
 {
     // Offset list must be aligned for SIMD FINT32
     assert(std::size_t(offset) % (GMX_SIMD_FINT32_WIDTH * sizeof(std::int32_t)) == 0);
@@ -286,7 +286,7 @@ static inline void gmx_simdcall gatherLoadUTranspose(const float*       base,
  */
 template<int align>
 static inline void gmx_simdcall
-                   transposeScatterStoreU(float* base, const std::int32_t offset[], SimdFloat v0, SimdFloat v1, SimdFloat v2)
+transposeScatterStoreU(float* base, const std::int32_t offset[], SimdFloat v0, SimdFloat v1, SimdFloat v2)
 {
     // Offset list must be aligned for SIMD FINT32
     assert(std::size_t(offset) % (GMX_SIMD_FINT32_WIDTH * sizeof(std::int32_t)) == 0);
@@ -342,7 +342,7 @@ static inline void gmx_simdcall
  */
 template<int align>
 static inline void gmx_simdcall
-                   transposeScatterIncrU(float* base, const std::int32_t offset[], SimdFloat v0, SimdFloat v1, SimdFloat v2)
+transposeScatterIncrU(float* base, const std::int32_t offset[], SimdFloat v0, SimdFloat v1, SimdFloat v2)
 {
     // Offset list must be aligned for SIMD FINT32
     assert(std::size_t(offset) % (GMX_SIMD_FINT32_WIDTH * sizeof(std::int32_t)) == 0);
@@ -398,7 +398,7 @@ static inline void gmx_simdcall
  */
 template<int align>
 static inline void gmx_simdcall
-                   transposeScatterDecrU(float* base, const std::int32_t offset[], SimdFloat v0, SimdFloat v1, SimdFloat v2)
+transposeScatterDecrU(float* base, const std::int32_t offset[], SimdFloat v0, SimdFloat v1, SimdFloat v2)
 {
     // Offset list must be aligned for SIMD FINT32
     assert(std::size_t(offset) % (GMX_SIMD_FINT32_WIDTH * sizeof(std::int32_t)) == 0);
@@ -520,7 +520,7 @@ static inline void gmx_simdcall gatherLoadBySimdIntTranspose(const float* base,
  */
 template<int align>
 static inline void gmx_simdcall
-                   gatherLoadUBySimdIntTranspose(const float* base, SimdFInt32 offset, SimdFloat* v0, SimdFloat* v1)
+gatherLoadUBySimdIntTranspose(const float* base, SimdFInt32 offset, SimdFloat* v0, SimdFloat* v1)
 {
     for (std::size_t i = 0; i < v0->simdInternal_.size(); i++)
     {
@@ -555,7 +555,7 @@ static inline void gmx_simdcall
  */
 template<int align>
 static inline void gmx_simdcall
-                   gatherLoadBySimdIntTranspose(const float* base, SimdFInt32 offset, SimdFloat* v0, SimdFloat* v1)
+gatherLoadBySimdIntTranspose(const float* base, SimdFInt32 offset, SimdFloat* v0, SimdFloat* v1)
 {
     // Base pointer must be aligned to the smaller of 2 elements and float SIMD width
     assert(std::size_t(base) % (std::min(GMX_SIMD_FLOAT_WIDTH, 2) * sizeof(float)) == 0);
index 7c027b10aff34522cedf8789bb3361e188748242..1c8809029ad61a527ff519f47d77c5ec02505062 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2014,2015,2017,2019,2020, by the GROMACS development team, led by
+ * Copyright (c) 2014,2015,2017,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.
@@ -92,10 +92,10 @@ static inline SimdFBool gmx_simdcall testBits(SimdFloat a)
 template<MathOptimization opt = MathOptimization::Safe>
 static inline SimdFloat gmx_simdcall frexp(SimdFloat value, SimdFInt32* exponent)
 {
-    const __m256  exponentMask = _mm256_castsi256_ps(_mm256_set1_epi32(0x7F800000));
-    const __m256  mantissaMask = _mm256_castsi256_ps(_mm256_set1_epi32(0x807FFFFF));
+    const __m256 exponentMask = _mm256_castsi256_ps(_mm256_set1_epi32(0x7F800000));
+    const __m256 mantissaMask = _mm256_castsi256_ps(_mm256_set1_epi32(0x807FFFFF));
     const __m256i exponentBias = _mm256_set1_epi32(126); // add 1 to make our definition identical to frexp()
-    const __m256  half = _mm256_set1_ps(0.5);
+    const __m256 half = _mm256_set1_ps(0.5);
 
     __m256i iExponent = _mm256_castps_si256(_mm256_and_ps(value.simdInternal_, exponentMask));
     iExponent         = _mm256_sub_epi32(_mm256_srli_epi32(iExponent, 23), exponentBias);
index d404eb783f033d55876e832c8186c49e5e725e8b..19e6bc812e79908e55ebb0e87172ea0416cfacd1 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2014,2015,2017,2018,2019, by the GROMACS development team, led by
+ * Copyright (c) 2014,2015,2017,2018,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.
@@ -85,7 +85,7 @@ static inline void gmx_simdcall gatherLoadTranspose(const double*      base,
 
 template<int align>
 static inline void gmx_simdcall
-                   gatherLoadTranspose(const double* base, const std::int32_t offset[], SimdDouble* v0, SimdDouble* v1)
+gatherLoadTranspose(const double* base, const std::int32_t offset[], SimdDouble* v0, SimdDouble* v1)
 {
     __m128d t1, t2, t3, t4;
     __m256d tA, tB;
@@ -176,7 +176,7 @@ static inline void gmx_simdcall transposeScatterStoreU(double*            base,
 
 template<int align>
 static inline void gmx_simdcall
-                   transposeScatterIncrU(double* base, const std::int32_t offset[], SimdDouble v0, SimdDouble v1, SimdDouble v2)
+transposeScatterIncrU(double* base, const std::int32_t offset[], SimdDouble v0, SimdDouble v1, SimdDouble v2)
 {
     __m256d t0, t1;
     __m128d t2, tA, tB;
@@ -238,7 +238,7 @@ static inline void gmx_simdcall
 }
 template<int align>
 static inline void gmx_simdcall
-                   transposeScatterDecrU(double* base, const std::int32_t offset[], SimdDouble v0, SimdDouble v1, SimdDouble v2)
+transposeScatterDecrU(double* base, const std::int32_t offset[], SimdDouble v0, SimdDouble v1, SimdDouble v2)
 {
     __m256d t0, t1;
     __m128d t2, tA, tB;
@@ -336,7 +336,7 @@ static inline void gmx_simdcall gatherLoadBySimdIntTranspose(const double* base,
 
 template<int align>
 static inline void gmx_simdcall
-                   gatherLoadBySimdIntTranspose(const double* base, SimdDInt32 offset, SimdDouble* v0, SimdDouble* v1)
+gatherLoadBySimdIntTranspose(const double* base, SimdDInt32 offset, SimdDouble* v0, SimdDouble* v1)
 {
     __m128d t1, t2, t3, t4;
     __m256d tA, tB;
@@ -360,7 +360,7 @@ static inline void gmx_simdcall
 
 template<int align>
 static inline void gmx_simdcall
-                   gatherLoadUBySimdIntTranspose(const double* base, SimdDInt32 offset, SimdDouble* v0, SimdDouble* v1)
+gatherLoadUBySimdIntTranspose(const double* base, SimdDInt32 offset, SimdDouble* v0, SimdDouble* v1)
 {
     __m128d t1, t2, t3, t4;
     __m256d tA, tB;
@@ -381,7 +381,7 @@ static inline void gmx_simdcall
 }
 
 static inline double gmx_simdcall
-                     reduceIncr4ReturnSum(double* m, SimdDouble v0, SimdDouble v1, SimdDouble v2, SimdDouble v3)
+reduceIncr4ReturnSum(double* m, SimdDouble v0, SimdDouble v1, SimdDouble v2, SimdDouble v3)
 {
     __m256d t0, t1, t2;
     __m128d a0, a1;
index 532dd2eb1e451d4b47f91fbb47b9a13a38ee2fd2..606bbcce97732b4d50ea481a80a155e1f34e79db 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2014,2015,2017,2018,2019,2020, by the GROMACS development team, led by
+ * Copyright (c) 2014,2015,2017,2018,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.
@@ -128,7 +128,7 @@ static inline void gmx_simdcall gatherLoadTranspose(const float*       base,
 
 template<int align>
 static inline void gmx_simdcall
-                   gatherLoadTranspose(const float* base, const std::int32_t offset[], SimdFloat* v0, SimdFloat* v1)
+gatherLoadTranspose(const float* base, const std::int32_t offset[], SimdFloat* v0, SimdFloat* v1)
 {
     __m128 t1, t2, t3, t4, t5, t6, t7, t8;
     __m256 tA, tB, tC, tD;
@@ -219,7 +219,7 @@ static inline void gmx_simdcall gatherLoadUTranspose(const float*       base,
 
 template<int align>
 static inline void gmx_simdcall
-                   transposeScatterStoreU(float* base, const std::int32_t offset[], SimdFloat v0, SimdFloat v1, SimdFloat v2)
+transposeScatterStoreU(float* base, const std::int32_t offset[], SimdFloat v0, SimdFloat v1, SimdFloat v2)
 {
     __m256  tv3;
     __m128i mask = _mm_set_epi32(0, -1, -1, -1);
@@ -239,7 +239,7 @@ static inline void gmx_simdcall
 
 template<int align>
 static inline void gmx_simdcall
-                   transposeScatterIncrU(float* base, const std::int32_t offset[], SimdFloat v0, SimdFloat v1, SimdFloat v2)
+transposeScatterIncrU(float* base, const std::int32_t offset[], SimdFloat v0, SimdFloat v1, SimdFloat v2)
 {
     __m256 t1, t2, t3, t4, t5, t6, t7, t8, t9, t10;
     __m128 tA, tB, tC, tD, tE, tF, tG, tH, tX;
@@ -371,7 +371,7 @@ static inline void gmx_simdcall
 
 template<int align>
 static inline void gmx_simdcall
-                   transposeScatterDecrU(float* base, const std::int32_t offset[], SimdFloat v0, SimdFloat v1, SimdFloat v2)
+transposeScatterDecrU(float* base, const std::int32_t offset[], SimdFloat v0, SimdFloat v1, SimdFloat v2)
 {
     __m256 t1, t2, t3, t4, t5, t6, t7, t8, t9, t10;
     __m128 tA, tB, tC, tD, tE, tF, tG, tH, tX;
@@ -530,7 +530,7 @@ static inline void gmx_simdcall gatherLoadBySimdIntTranspose(const float* base,
 
 template<int align>
 static inline void gmx_simdcall
-                   gatherLoadBySimdIntTranspose(const float* base, SimdFInt32 simdoffset, SimdFloat* v0, SimdFloat* v1)
+gatherLoadBySimdIntTranspose(const float* base, SimdFInt32 simdoffset, SimdFloat* v0, SimdFloat* v1)
 {
     alignas(GMX_SIMD_ALIGNMENT) std::int32_t offset[GMX_SIMD_FLOAT_WIDTH];
     _mm256_store_si256(reinterpret_cast<__m256i*>(offset), simdoffset.simdInternal_);
@@ -540,7 +540,7 @@ static inline void gmx_simdcall
 
 template<int align>
 static inline void gmx_simdcall
-                   gatherLoadUBySimdIntTranspose(const float* base, SimdFInt32 simdoffset, SimdFloat* v0, SimdFloat* v1)
+gatherLoadUBySimdIntTranspose(const float* base, SimdFInt32 simdoffset, SimdFloat* v0, SimdFloat* v1)
 {
     __m128 t1, t2, t3, t4, t5, t6, t7, t8;
     __m256 tA, tB, tC, tD;
index acde31b609bf00510a1e0854d7cc685186fff762..9ae6999ce5c4046cba51285c2ce303a42ebef200 100644 (file)
@@ -2,7 +2,7 @@
  * This file is part of the GROMACS molecular simulation package.
  *
  * Copyright (c) 2014-2018, 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.
@@ -105,7 +105,7 @@ inline void gmx_simdcall decrHsimd(double* m, SimdDouble a)
 
 template<int align, typename... Targs>
 static inline void gmx_simdcall
-                   gatherLoadBySimdIntTranspose(const double* base, SimdDInt32 offset, SimdDouble* v, Targs... Fargs)
+gatherLoadBySimdIntTranspose(const double* base, SimdDInt32 offset, SimdDouble* v, Targs... Fargs)
 {
     if (align > 1)
     {
@@ -118,21 +118,21 @@ static inline void gmx_simdcall
 
 template<int align, typename... Targs>
 static inline void gmx_simdcall
-                   gatherLoadUBySimdIntTranspose(const double* base, SimdDInt32 offset, SimdDouble* v, Targs... Fargs)
+gatherLoadUBySimdIntTranspose(const double* base, SimdDInt32 offset, SimdDouble* v, Targs... Fargs)
 {
     gatherLoadBySimdIntTranspose<align>(base, offset, v, Fargs...);
 }
 
 template<int align, typename... Targs>
 static inline void gmx_simdcall
-                   gatherLoadTranspose(const double* base, const std::int32_t offset[], SimdDouble* v, Targs... Fargs)
+gatherLoadTranspose(const double* base, const std::int32_t offset[], SimdDouble* v, Targs... Fargs)
 {
     gatherLoadBySimdIntTranspose<align>(base, simdLoad(offset, SimdDInt32Tag()), v, Fargs...);
 }
 
 template<int align, typename... Targs>
 static inline void gmx_simdcall
-                   gatherLoadUTranspose(const double* base, const std::int32_t offset[], SimdDouble* v, Targs... Fargs)
+gatherLoadUTranspose(const double* base, const std::int32_t offset[], SimdDouble* v, Targs... Fargs)
 {
     gatherLoadBySimdIntTranspose<align>(base, simdLoad(offset, SimdDInt32Tag()), v, Fargs...);
 }
@@ -159,7 +159,7 @@ static inline void gmx_simdcall transposeScatterStoreU(double*            base,
 
 template<int align>
 static inline void gmx_simdcall
-                   transposeScatterIncrU(double* base, const std::int32_t offset[], SimdDouble v0, SimdDouble v1, SimdDouble v2)
+transposeScatterIncrU(double* base, const std::int32_t offset[], SimdDouble v0, SimdDouble v1, SimdDouble v2)
 {
     __m512d                                  t[4], t5, t6, t7, t8;
     alignas(GMX_SIMD_ALIGNMENT) std::int64_t o[8];
@@ -221,7 +221,7 @@ static inline void gmx_simdcall
 
 template<int align>
 static inline void gmx_simdcall
-                   transposeScatterDecrU(double* base, const std::int32_t offset[], SimdDouble v0, SimdDouble v1, SimdDouble v2)
+transposeScatterDecrU(double* base, const std::int32_t offset[], SimdDouble v0, SimdDouble v1, SimdDouble v2)
 {
     __m512d                                  t[4], t5, t6, t7, t8;
     alignas(GMX_SIMD_ALIGNMENT) std::int64_t o[8];
@@ -299,7 +299,7 @@ static inline void gmx_simdcall expandScalarsToTriplets(SimdDouble  scalar,
 
 
 static inline double gmx_simdcall
-                     reduceIncr4ReturnSum(double* m, SimdDouble v0, SimdDouble v1, SimdDouble v2, SimdDouble v3)
+reduceIncr4ReturnSum(double* m, SimdDouble v0, SimdDouble v1, SimdDouble v2, SimdDouble v3)
 {
     __m512d t0, t2;
     __m256d t3, t4;
index 65d1320d6760476ca20e6a0030d6064dfaba774f..06c648d4bb7cc7d41f728284460d36233acfeb29 100644 (file)
@@ -2,7 +2,7 @@
  * This file is part of the GROMACS molecular simulation package.
  *
  * Copyright (c) 2014,2015,2016,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.
@@ -104,7 +104,7 @@ inline void gmx_simdcall decrHsimd(float* m, SimdFloat a)
 
 template<int align, typename... Targs>
 static inline void gmx_simdcall
-                   gatherLoadBySimdIntTranspose(const float* base, SimdFInt32 offset, SimdFloat* v, Targs... Fargs)
+gatherLoadBySimdIntTranspose(const float* base, SimdFInt32 offset, SimdFloat* v, Targs... Fargs)
 {
     // For align 1 or 2: No multiplication of offset is needed
     if (align > 2)
@@ -120,28 +120,28 @@ static inline void gmx_simdcall
 
 template<int align, typename... Targs>
 static inline void gmx_simdcall
-                   gatherLoadUBySimdIntTranspose(const float* base, SimdFInt32 offset, SimdFloat* v, Targs... Fargs)
+gatherLoadUBySimdIntTranspose(const float* base, SimdFInt32 offset, SimdFloat* v, Targs... Fargs)
 {
     gatherLoadBySimdIntTranspose<align>(base, offset, v, Fargs...);
 }
 
 template<int align, typename... Targs>
 static inline void gmx_simdcall
-                   gatherLoadTranspose(const float* base, const std::int32_t offset[], SimdFloat* v, Targs... Fargs)
+gatherLoadTranspose(const float* base, const std::int32_t offset[], SimdFloat* v, Targs... Fargs)
 {
     gatherLoadBySimdIntTranspose<align>(base, simdLoad(offset, SimdFInt32Tag()), v, Fargs...);
 }
 
 template<int align, typename... Targs>
 static inline void gmx_simdcall
-                   gatherLoadUTranspose(const float* base, const std::int32_t offset[], SimdFloat* v, Targs... Fargs)
+gatherLoadUTranspose(const float* base, const std::int32_t offset[], SimdFloat* v, Targs... Fargs)
 {
     gatherLoadBySimdIntTranspose<align>(base, simdLoad(offset, SimdFInt32Tag()), v, Fargs...);
 }
 
 template<int align>
 static inline void gmx_simdcall
-                   transposeScatterStoreU(float* base, const std::int32_t offset[], SimdFloat v0, SimdFloat v1, SimdFloat v2)
+transposeScatterStoreU(float* base, const std::int32_t offset[], SimdFloat v0, SimdFloat v1, SimdFloat v2)
 {
     SimdFInt32 simdoffset = simdLoad(offset, SimdFInt32Tag());
     if (align > 2)
@@ -157,7 +157,7 @@ static inline void gmx_simdcall
 
 template<int align>
 static inline void gmx_simdcall
-                   transposeScatterIncrU(float* base, const std::int32_t offset[], SimdFloat v0, SimdFloat v1, SimdFloat v2)
+transposeScatterIncrU(float* base, const std::int32_t offset[], SimdFloat v0, SimdFloat v1, SimdFloat v2)
 {
     __m512                                   t[4], t5, t6, t7, t8;
     int                                      i;
@@ -235,7 +235,7 @@ static inline void gmx_simdcall
 
 template<int align>
 static inline void gmx_simdcall
-                   transposeScatterDecrU(float* base, const std::int32_t offset[], SimdFloat v0, SimdFloat v1, SimdFloat v2)
+transposeScatterDecrU(float* base, const std::int32_t offset[], SimdFloat v0, SimdFloat v1, SimdFloat v2)
 {
     __m512                                   t[4], t5, t6, t7, t8;
     int                                      i;
index 01b2ca20592095c98cc6184470fa649dabe311f1..e610bf273feab83ac9268889789f82bcd90a9ea2 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2014,2015,2016,2017,2019,2020, by the GROMACS development team, led by
+ * Copyright (c) 2014,2015,2016,2017,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.
@@ -318,7 +318,7 @@ static inline SimdDouble frexp(SimdDouble value, SimdDInt32* exponent)
     const __m128d mantissaMask =
             _mm_castsi128_pd(_mm_set_epi32(0x800FFFFF, 0xFFFFFFFF, 0x800FFFFF, 0xFFFFFFFF));
     const __m128i exponentBias = _mm_set1_epi32(1022); // add 1 to make our definition identical to frexp()
-    const __m128d half = _mm_set1_pd(0.5);
+    const __m128d half         = _mm_set1_pd(0.5);
 
     __m128i iExponent = _mm_castpd_si128(_mm_and_pd(value.simdInternal_, exponentMask));
     iExponent         = _mm_sub_epi32(_mm_srli_epi64(iExponent, 52), exponentBias);
index 7bc392c5e8eb9e7a577d44eb012a13e996051621..dd8c6c47cc4fbec4b22b689ece7b824347452698 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2014,2015,2016,2017,2019,2020, by the GROMACS development team, led by
+ * Copyright (c) 2014,2015,2016,2017,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.
@@ -310,7 +310,7 @@ static inline SimdFloat gmx_simdcall frexp(SimdFloat value, SimdFInt32* exponent
     const __m128 exponentMask = _mm_castsi128_ps(_mm_set1_epi32(0x7F800000));
     const __m128 mantissaMask = _mm_castsi128_ps(_mm_set1_epi32(0x807FFFFF));
     const __m128i exponentBias = _mm_set1_epi32(126); // add 1 to make our definition identical to frexp()
-    const __m128 half = _mm_set1_ps(0.5F);
+    const __m128 half          = _mm_set1_ps(0.5F);
 
     __m128i iExponent = _mm_castps_si128(_mm_and_ps(value.simdInternal_, exponentMask));
     iExponent         = _mm_sub_epi32(_mm_srli_epi32(iExponent, 23), exponentBias);
index 5183cb8fc6544148f99c0c7926286c02a414d555..6ffb8ad65c3d9179d9bae5625e7a53a92966b7cc 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2014,2015,2019, by the GROMACS development team, led by
+ * Copyright (c) 2014,2015,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.
@@ -73,7 +73,7 @@ static inline void gmx_simdcall gatherLoadTranspose(const double*      base,
 
 template<int align>
 static inline void gmx_simdcall
-                   gatherLoadTranspose(const double* base, const std::int32_t offset[], SimdDouble* v0, SimdDouble* v1)
+gatherLoadTranspose(const double* base, const std::int32_t offset[], SimdDouble* v0, SimdDouble* v1)
 {
     __m128d t1, t2;
 
@@ -123,7 +123,7 @@ static inline void gmx_simdcall transposeScatterStoreU(double*            base,
 
 template<int align>
 static inline void gmx_simdcall
-                   transposeScatterIncrU(double* base, const std::int32_t offset[], SimdDouble v0, SimdDouble v1, SimdDouble v2)
+transposeScatterIncrU(double* base, const std::int32_t offset[], SimdDouble v0, SimdDouble v1, SimdDouble v2)
 {
     __m128d t1, t2, t3, t4, t5, t6, t7;
 
@@ -148,7 +148,7 @@ static inline void gmx_simdcall
 
 template<int align>
 static inline void gmx_simdcall
-                   transposeScatterDecrU(double* base, const std::int32_t offset[], SimdDouble v0, SimdDouble v1, SimdDouble v2)
+transposeScatterDecrU(double* base, const std::int32_t offset[], SimdDouble v0, SimdDouble v1, SimdDouble v2)
 {
     // This implementation is identical to the increment version, apart from using subtraction instead
     __m128d t1, t2, t3, t4, t5, t6, t7;
@@ -247,7 +247,7 @@ static inline void gmx_simdcall gatherLoadBySimdIntTranspose(const double* base,
 
 template<int align>
 static inline void gmx_simdcall
-                   gatherLoadBySimdIntTranspose(const double* base, SimdDInt32 offset, SimdDouble* v0, SimdDouble* v1)
+gatherLoadBySimdIntTranspose(const double* base, SimdDInt32 offset, SimdDouble* v0, SimdDouble* v1)
 {
     __m128d t1, t2;
 
@@ -306,7 +306,7 @@ static inline void gmx_simdcall
 
 template<int align>
 static inline void gmx_simdcall
-                   gatherLoadUBySimdIntTranspose(const double* base, SimdDInt32 offset, SimdDouble* v0, SimdDouble* v1)
+gatherLoadUBySimdIntTranspose(const double* base, SimdDInt32 offset, SimdDouble* v0, SimdDouble* v1)
 {
     __m128d t1, t2;
     // Use optimized bit-shift multiply for the most common alignments.
@@ -338,7 +338,7 @@ static inline void gmx_simdcall
 // Override for AVX-128-FMA and higher
 #if GMX_SIMD_X86_SSE2 || GMX_SIMD_X86_SSE4_1
 static inline double gmx_simdcall
-                     reduceIncr4ReturnSum(double* m, SimdDouble v0, SimdDouble v1, SimdDouble v2, SimdDouble v3)
+reduceIncr4ReturnSum(double* m, SimdDouble v0, SimdDouble v1, SimdDouble v2, SimdDouble v3)
 {
     __m128d t1, t2, t3, t4;
 
index 0c4de5265abc8add58096c14a5ad05bc01b6ec1b..7d7be0b8a898f81517c978b0ed353fbd0bb7ffde 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2014,2015,2017,2018,2019, by the GROMACS development team, led by
+ * Copyright (c) 2014,2015,2017,2018,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.
@@ -74,7 +74,7 @@ static inline void gmx_simdcall gatherLoadTranspose(const float*       base,
 
 template<int align>
 static inline void gmx_simdcall
-                   gatherLoadTranspose(const float* base, const std::int32_t offset[], SimdFloat* v0, SimdFloat* v1)
+gatherLoadTranspose(const float* base, const std::int32_t offset[], SimdFloat* v0, SimdFloat* v1)
 {
     __m128 t1, t2;
 
@@ -129,7 +129,7 @@ static inline void gmx_simdcall gatherLoadUTranspose(const float*       base,
 
 template<int align>
 static inline void gmx_simdcall
-                   transposeScatterStoreU(float* base, const std::int32_t offset[], SimdFloat v0, SimdFloat v1, SimdFloat v2)
+transposeScatterStoreU(float* base, const std::int32_t offset[], SimdFloat v0, SimdFloat v1, SimdFloat v2)
 {
     __m128 t1, t2;
 
@@ -152,7 +152,7 @@ static inline void gmx_simdcall
 
 template<int align>
 static inline void gmx_simdcall
-                   transposeScatterIncrU(float* base, const std::int32_t offset[], SimdFloat v0, SimdFloat v1, SimdFloat v2)
+transposeScatterIncrU(float* base, const std::int32_t offset[], SimdFloat v0, SimdFloat v1, SimdFloat v2)
 {
     __m128 t1, t2, t3, t4, t5, t6, t7, t8, t9, t10;
 
@@ -227,7 +227,7 @@ static inline void gmx_simdcall
 
 template<int align>
 static inline void gmx_simdcall
-                   transposeScatterDecrU(float* base, const std::int32_t offset[], SimdFloat v0, SimdFloat v1, SimdFloat v2)
+transposeScatterDecrU(float* base, const std::int32_t offset[], SimdFloat v0, SimdFloat v1, SimdFloat v2)
 {
     // This implementation is identical to the increment version, apart from using subtraction instead
     __m128 t1, t2, t3, t4, t5, t6, t7, t8, t9, t10;
@@ -338,7 +338,7 @@ static inline void gmx_simdcall gatherLoadBySimdIntTranspose(const float* base,
 
 template<int align>
 static inline void gmx_simdcall
-                   gatherLoadBySimdIntTranspose(const float* base, SimdFInt32 offset, SimdFloat* v0, SimdFloat* v1)
+gatherLoadBySimdIntTranspose(const float* base, SimdFInt32 offset, SimdFloat* v0, SimdFloat* v1)
 {
     // For present-generation x86 CPUs it appears to be faster to simply
     // store the SIMD integer to memory and then use the normal load operations.
@@ -353,7 +353,7 @@ static inline void gmx_simdcall
 
 template<int align>
 static inline void gmx_simdcall
-                   gatherLoadUBySimdIntTranspose(const float* base, SimdFInt32 offset, SimdFloat* v0, SimdFloat* v1)
+gatherLoadUBySimdIntTranspose(const float* base, SimdFInt32 offset, SimdFloat* v0, SimdFloat* v1)
 {
     // For present-generation x86 CPUs it appears to be faster to simply
     // store the SIMD integer to memory and then use the normal load operations.
index 6beb22595dcbf960f37130d23c49b644a928f493..9343602534e04bc872f5fed248df3b0f4bd29763 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2016,2017,2018,2019,2020, by the GROMACS development team, led by
+ * Copyright (c) 2016,2017,2018,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.
@@ -325,7 +325,8 @@ static inline float reduce(float a)
  */
 static inline float andNot(float a, float b)
 {
-    union {
+    union
+    {
         float         r;
         std::uint32_t i;
     } conv1, conv2;
@@ -353,7 +354,8 @@ static inline float andNot(float a, float b)
  */
 static inline bool testBits(float a)
 {
-    union {
+    union
+    {
         std::uint32_t i;
         float         f;
     } conv;
@@ -731,7 +733,8 @@ static inline double reduce(double a)
  */
 static inline double andNot(double a, double b)
 {
-    union {
+    union
+    {
         double        r;
         std::uint64_t i;
     } conv1, conv2;
@@ -759,7 +762,8 @@ static inline double andNot(double a, double b)
  */
 static inline bool testBits(double a)
 {
-    union {
+    union
+    {
         std::uint64_t i;
         double        f;
     } conv;
index 5642c45e32ac8caa588919c61151bcdadfb43c08..c919b3648bb4b4fe204fc658bab506dd3d844c57 100644 (file)
@@ -1030,7 +1030,8 @@ static inline SimdFloat gmx_simdcall erfc(SimdFloat x)
     const int                         isieve = 0xFFFFF000;
     alignas(GMX_SIMD_ALIGNMENT) float mem[GMX_SIMD_FLOAT_WIDTH];
 
-    union {
+    union
+    {
         float f;
         int   i;
     } conv;
index 31a39a3864ca962a154073dfb105e1c8d8b8b17e..eb33c09e9f16d453fdd258a2c81ddc6aae35f0be 100644 (file)
@@ -81,7 +81,8 @@ int SimdBaseTest::s_nPoints = 10000;
     bool                      allOk;
     size_t                    i;
 
-    union {
+    union
+    {
 #if GMX_DOUBLE
         double       r;
         std::int64_t i;
index 52ba8e396b8415a7b3fa260cfcf9d1d9be63ee29..8d64617b45fc6a9a9d0220308e4fa351cf699cc9 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2014,2015,2017,2018,2019, by the GROMACS development team, led by
+ * Copyright (c) 2014,2015,2017,2018,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.
@@ -84,9 +84,9 @@ namespace
  */
 template<typename T, typename TSimd, int simdWidth>
 void loadStoreTester(TSimd gmx_simdcall loadFn(const T* mem),
-                     void gmx_simdcall storeFn(T* mem, TSimd),
-                     const int         loadOffset,
-                     const int         storeOffset)
+                     void gmx_simdcall  storeFn(T* mem, TSimd),
+                     const int          loadOffset,
+                     const int          storeOffset)
 {
     /* We need simdWidth storage in the first place, another simdWidth elements
      * so we can create (deliberately) offset un-aligned pointers, and finally
index dc5d157b1adf3be4df1fea0804ae4a478b33a5ac..62f9574f95fcd8f714b47be9fefb8e5317cf5448 100644 (file)
@@ -517,9 +517,9 @@ TEST_F(SimdFloatingpointTest, cvtDouble2Float)
 {
     alignas(GMX_SIMD_ALIGNMENT) float f[GMX_SIMD_FLOAT_WIDTH];
     alignas(GMX_SIMD_ALIGNMENT) double d[GMX_SIMD_FLOAT_WIDTH]; // Yes, double array length should be same as float
-    int                    i;
-    SimdFloat              vf;
-    SimdDouble             vd0;
+    int                                i;
+    SimdFloat                          vf;
+    SimdDouble                         vd0;
     FloatingPointTolerance tolerance(defaultRealTolerance());
 
     // This fills elements for pd1 too when double width is 2*single width
index 463790cb4773971be4d6f8b70f36d767e752d73f..f7bad07115290475c790d6f9434e012039e563f0 100644 (file)
@@ -115,10 +115,10 @@ public:
         MatchRule    matchRule; //!< Decide what we consider a match
     };
 
-    ::testing::AssertionResult compareSimdMathFunction(const char* refFuncExpr,
-                                                       const char* simdFuncExpr,
-                                                       const char* compareSettingsExpr,
-                                                       real        refFunc(real x),
+    ::testing::AssertionResult compareSimdMathFunction(const char*            refFuncExpr,
+                                                       const char*            simdFuncExpr,
+                                                       const char*            compareSettingsExpr,
+                                                       real                   refFunc(real x),
                                                        SimdReal gmx_simdcall  simdFunc(SimdReal x),
                                                        const CompareSettings& compareSettings);
 
@@ -208,7 +208,8 @@ std::vector<real> SimdMathTest::generateTestPoints(Range inputRange, std::size_t
             points--; // Used one point
         }
 
-        union {
+        union
+        {
             real                                                                               r;
             std::conditional<sizeof(real) == sizeof(double), std::int64_t, std::int32_t>::type i;
         } low, high, x;
@@ -282,7 +283,8 @@ std::vector<real> SimdMathTest::generateTestPoints(Range inputRange, std::size_t
     real              refValMaxUlpDiff, simdValMaxUlpDiff;
     const int         niter = s_nPoints / GMX_SIMD_REAL_WIDTH;
 
-    union {
+    union
+    {
         real                                                                               r;
         std::conditional<sizeof(real) == sizeof(double), std::int64_t, std::int32_t>::type i;
     } conv0, conv1;
index b97e21b302ac6105743ae4bd17ddb626b3945e97..a3fcc658f41219a0730fa53a27c13faf0b1ded13 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2013,2014,2015,2017,2019, by the GROMACS development team, led by
+ * Copyright (c) 2013,2014,2015,2017,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.
@@ -81,7 +81,7 @@ namespace gmx
  * \note The SIMD part is that we calculate many scalar products in one call.
  */
 static inline SimdFloat gmx_simdcall
-                        iprod(SimdFloat ax, SimdFloat ay, SimdFloat az, SimdFloat bx, SimdFloat by, SimdFloat bz)
+iprod(SimdFloat ax, SimdFloat ay, SimdFloat az, SimdFloat bx, SimdFloat by, SimdFloat bz)
 {
     SimdFloat ret;
 
@@ -168,7 +168,7 @@ static inline void gmx_simdcall cprod(SimdFloat  ax,
  * \note The SIMD part is that we calculate many scalar products in one call.
  */
 static inline SimdDouble gmx_simdcall
-                         iprod(SimdDouble ax, SimdDouble ay, SimdDouble az, SimdDouble bx, SimdDouble by, SimdDouble bz)
+iprod(SimdDouble ax, SimdDouble ay, SimdDouble az, SimdDouble bx, SimdDouble by, SimdDouble bz)
 {
     SimdDouble ret;
 
index 947218eed179aee71a2be6a6bafb5596d0682bdc..172d4024a04564bbf0a7fbad675d3ab00adae171 100644 (file)
@@ -192,7 +192,7 @@ typedef struct swap_group
     gmx::EnumerationArray<Compartment, t_compartment> comp; /**< Distribution of particles of this
                                        group across the two compartments */
     gmx::EnumerationArray<Compartment, real> vacancy; /**< How many molecules need to be swapped in? */
-    gmx::EnumerationArray<Channel, int> fluxfromAtoB; /**< Net flux of ions per channel */
+    gmx::EnumerationArray<Channel, int>      fluxfromAtoB; /**< Net flux of ions per channel */
     gmx::EnumerationArray<Channel, int> nCyl; /**< Number of ions residing in a channel         */
     int nCylBoth = 0; /**< Ions assigned to cyl0 and cyl1. Not good.             */
 } t_swapgrp;
index dcbdbfe7a2a8d6c83b6b710679f5a0da097cbf07..740296624ba825ec394e2aa5f91bf2de64ad9491 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2016,2017,2018,2019,2020, by the GROMACS development team, led by
+ * Copyright (c) 2016,2017,2018,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.
@@ -306,8 +306,7 @@ const real CubicSplineTable::defaultTolerance = 10.0 * GMX_FLOAT_EPS;
 CubicSplineTable::CubicSplineTable(std::initializer_list<AnalyticalSplineTableInput> analyticalInputList,
                                    const std::pair<real, real>&                      range,
                                    real                                              tolerance) :
-    numFuncInTable_(analyticalInputList.size()),
-    range_(range)
+    numFuncInTable_(analyticalInputList.size()), range_(range)
 {
     // Sanity check on input values
     if (range_.first < 0.0 || (range_.second - range_.first) < 0.001)
@@ -395,8 +394,7 @@ CubicSplineTable::CubicSplineTable(std::initializer_list<AnalyticalSplineTableIn
 CubicSplineTable::CubicSplineTable(std::initializer_list<NumericalSplineTableInput> numericalInputList,
                                    const std::pair<real, real>&                     range,
                                    real                                             tolerance) :
-    numFuncInTable_(numericalInputList.size()),
-    range_(range)
+    numFuncInTable_(numericalInputList.size()), range_(range)
 {
     // Sanity check on input values
     if (range.first < 0.0 || (range.second - range.first) < 0.001)
index 0705e7db7912dc6cc5cd41f01021c4d0094b6031..6614b8f9b006aa50606ca55c30a0253b906dee14 100644 (file)
@@ -432,9 +432,7 @@ static void copy2table(int                         n,
 }
 
 t_tabledata::t_tabledata(int n, int nx0, double tabscale, bool bAlloc) :
-    nx(n),
-    nx0(nx0),
-    tabscale(tabscale)
+    nx(n), nx0(nx0), tabscale(tabscale)
 {
     if (bAlloc)
     {
@@ -1449,14 +1447,7 @@ makeDispersionCorrectionTable(FILE* fp, const interaction_const_t* ic, real rtab
 }
 
 t_forcetable::t_forcetable(enum gmx_table_interaction interaction, enum gmx_table_format format) :
-    interaction(interaction),
-    format(format),
-    r(0),
-    n(0),
-    scale(0),
-    formatsize(0),
-    ninteractions(0),
-    stride(0)
+    interaction(interaction), format(format), r(0), n(0), scale(0), formatsize(0), ninteractions(0), stride(0)
 {
 }
 
index af5129f2a3d4930f7206bd2f1f8a437c4ce80490..fe90075a99bb738151c3cc5c98ff1327ba0c5c70 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2016,2017,2018,2019,2020, by the GROMACS development team, led by
+ * Copyright (c) 2016,2017,2018,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.
@@ -274,8 +274,7 @@ const real QuadraticSplineTable::defaultTolerance = 10.0 * GMX_FLOAT_EPS;
 QuadraticSplineTable::QuadraticSplineTable(std::initializer_list<AnalyticalSplineTableInput> analyticalInputList,
                                            const std::pair<real, real>&                      range,
                                            real tolerance) :
-    numFuncInTable_(analyticalInputList.size()),
-    range_(range)
+    numFuncInTable_(analyticalInputList.size()), range_(range)
 {
     // Sanity check on input values
     if (range_.first < 0.0 || (range_.second - range_.first) < 0.001)
@@ -371,8 +370,7 @@ QuadraticSplineTable::QuadraticSplineTable(std::initializer_list<AnalyticalSplin
 QuadraticSplineTable::QuadraticSplineTable(std::initializer_list<NumericalSplineTableInput> numericalInputList,
                                            const std::pair<real, real>&                     range,
                                            real tolerance) :
-    numFuncInTable_(numericalInputList.size()),
-    range_(range)
+    numFuncInTable_(numericalInputList.size()), range_(range)
 {
     // Sanity check on input values
     if (range.first < 0.0 || (range.second - range.first) < 0.001)
index 878dcc937ddf6f76e837e840b1d8c3e620e05c04..26b13bde1456a957eaccdce1be808b11a4167f1d 100644 (file)
@@ -3,7 +3,7 @@
  *
  * Copyright (c) 1991-2006 David van der Spoel, Erik Lindahl, Berk Hess, University of Groningen.
  * Copyright (c) 2013,2014,2015,2016,2017 by the GROMACS development team.
- * Copyright (c) 2018,2019,2020, by the GROMACS development team, led by
+ * Copyright (c) 2018,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.
@@ -82,10 +82,10 @@ double gmx_cycles_calibrate(double sampletime)
          && defined(__x86_64__) && !defined(__ILP32__) && !defined(_CRAYC))
     long gmx_unused tmp;
     int             cpuid1;
-    int gmx_unused cpuid2;
-    const int      l0  = 0x0;
-    const int      l16 = 0x16;
-    gmx_cycles_t   cycles;
+    int gmx_unused  cpuid2;
+    const int       l0  = 0x0;
+    const int       l16 = 0x16;
+    gmx_cycles_t    cycles;
 
     /* cpuid clobbers ebx but it must be restored for -fPIC so save
      * then restore ebx */
index 4516c324e0c63da6a70249585875bf20fcc8998f..b3d140ca2938d7401f5bdc51216a3416d9ab6eb3 100644 (file)
@@ -72,10 +72,7 @@ struct BaseEntry
 {
     //! Default constructor.
     BaseEntry(const std::string& aName, const std::string& rName) :
-        atomName(aName),
-        residueName(rName),
-        isAvailable(false),
-        value(0.0)
+        atomName(aName), residueName(rName), isAvailable(false), value(0.0)
     {
     }
     //! Name for atom.
index 9d33f271a6febd93e6e43a1fd47b576cfa222033..b54d73c4f5cb11c8ffa1e124e4ca04f30b2fc902 100644 (file)
@@ -501,9 +501,7 @@ void init_idef(t_idef* idef)
 }
 
 InteractionDefinitions::InteractionDefinitions(const gmx_ffparams_t& ffparams) :
-    iparams(ffparams.iparams),
-    functype(ffparams.functype),
-    cmap_grid(ffparams.cmap_grid)
+    iparams(ffparams.iparams), functype(ffparams.functype), cmap_grid(ffparams.cmap_grid)
 {
 }
 
index 1fb0a2fc2d7bb97a9589add2f0359b906c7408cc..84ba6e8a5839986204d001524b3464cdd773a253 100644 (file)
@@ -49,7 +49,8 @@
 
 struct gmx_ffparams_t;
 
-typedef union t_iparams {
+typedef union t_iparams
+{
     /* Some parameters have A and B values for free energy calculations.
      * The B values are not used for regular simulations of course.
      * Free Energy for nonbondeds can be computed by changing the atom type.
index b60dd118022d512dba586ad6ef49a03d46af4534..02a5ff6f174e7e338aa9f93e07ac701140edf485 100644 (file)
@@ -2,7 +2,7 @@
  * This file is part of the GROMACS molecular simulation package.
  *
  * Copyright (c) 2010,2013,2014,2015,2016 by the GROMACS development team.
- * Copyright (c) 2017,2018,2019,2020, by the GROMACS development team, led by
+ * Copyright (c) 2017,2018,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.
@@ -60,8 +60,7 @@ struct ResidueTypeEntry
 {
     //! Default constructor creates complete object.
     ResidueTypeEntry(const std::string& rName, const std::string& rType) :
-        residueName(rName),
-        residueType(rType)
+        residueName(rName), residueType(rType)
     {
     }
     //! Name of the residue in the entry.
index ea48eb29cf5bc5b8f25e6ce81931b920adf0d5b2..bf377d930c25beb89ceee8eb052b3ba05f81aeac 100644 (file)
@@ -54,8 +54,7 @@ namespace gmx
 {
 
 EnergyFrame::EnergyFrame(const t_enxframe& enxframe, const std::map<std::string, int>& indicesOfEnergyFields) :
-    step_(enxframe.step),
-    time_(enxframe.t)
+    step_(enxframe.step), time_(enxframe.t)
 {
     for (const auto& index : indicesOfEnergyFields)
     {
index a83eb39777a8aece5b963f8e047c862229f4478b..4fa009ee9e6c4b724c672ae85befa80945fef755 100644 (file)
@@ -2,7 +2,7 @@
  * This file is part of the GROMACS molecular simulation package.
  *
  * Copyright (c) 2010,2011,2012,2014,2015 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.
@@ -64,12 +64,7 @@ class TrajectoryAnalysisSettings::Impl
 public:
     //! Initializes the default values for the settings object.
     Impl() :
-        timeUnit(TimeUnit::Default),
-        flags(0),
-        frflags(0),
-        bRmPBC(true),
-        bPBC(true),
-        optionsModuleSettings_(nullptr)
+        timeUnit(TimeUnit::Default), flags(0), frflags(0), bRmPBC(true), bPBC(true), optionsModuleSettings_(nullptr)
     {
     }
 
index fb0d2e17bf538ae4b596e22257edc54338f674e6..ec83323e58fb63340c436454291b59284c55a4d0 100644 (file)
@@ -2,7 +2,7 @@
  * This file is part of the GROMACS molecular simulation package.
  *
  * Copyright (c) 2010-2018, 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.
@@ -76,8 +76,7 @@ class RunnerModule : public ICommandLineOptionsModule
 {
 public:
     explicit RunnerModule(TrajectoryAnalysisModulePointer module) :
-        module_(std::move(module)),
-        common_(&settings_)
+        module_(std::move(module)), common_(&settings_)
     {
     }
 
index e94d5afd13c6cd1ec6766d66998eb2e73cc84c18..4e6dc802c0125fc4a7f8ebeeaa39113026417ef5 100644 (file)
@@ -121,10 +121,7 @@ public:
      * called, but values cannot be accessed.
      */
     AnglePositionIterator(const SelectionList& selections, int posCountPerValue) :
-        selections_(selections),
-        posCountPerValue_(posCountPerValue),
-        currentSelection_(0),
-        nextPosition_(0)
+        selections_(selections), posCountPerValue_(posCountPerValue), currentSelection_(0), nextPosition_(0)
     {
     }
 
index 52a89476efae0db5990208cfa80052461d3b3bf0..2c7479bc388d191d53b03767e7da41d614aa903f 100644 (file)
@@ -281,10 +281,7 @@ public:
     MsdCoordinateManager(const int                    numAtoms,
                          ArrayRef<const MoleculeData> molecules,
                          ArrayRef<const int>          moleculeIndexMapping) :
-        current_(numAtoms),
-        previous_(numAtoms),
-        molecules_(molecules),
-        moleculeIndexMapping_(moleculeIndexMapping)
+        current_(numAtoms), previous_(numAtoms), molecules_(molecules), moleculeIndexMapping_(moleculeIndexMapping)
     {
     }
     /*! \brief Prepares coordinates for the current frame.
index 360e68c7a351ca8269afff1489b84b625489d227..2ea05667e8dafd2b5d4b08e52cc0f9ac22ea3984 100644 (file)
@@ -401,12 +401,7 @@ private:
 };
 
 Sasa::Sasa() :
-    solsize_(0.14),
-    ndots_(24),
-    dgsDefault_(0),
-    bIncludeSolute_(true),
-    mtop_(nullptr),
-    atoms_(nullptr)
+    solsize_(0.14), ndots_(24), dgsDefault_(0), bIncludeSolute_(true), mtop_(nullptr), atoms_(nullptr)
 {
     // minarea_ = 0.5;
     registerAnalysisDataset(&area_, "area");
index 0ec05b077fb132179a70f2e75c101b2be004980e..fef4745d7c6118d55ffb7efe3dd29d1ef921db70 100644 (file)
@@ -138,10 +138,7 @@ private:
  */
 
 IndexFileWriterModule::IndexFileWriterModule() :
-    fp_(nullptr),
-    currentGroup_(-1),
-    currentSize_(0),
-    bAnyWritten_(false)
+    fp_(nullptr), currentGroup_(-1), currentSize_(0), bAnyWritten_(false)
 {
 }
 
index bb1e0594f0136aaecdd0b6c0cd06e639589d43be..cadc4c9d3989296d085d08db67dc68d492892e02 100644 (file)
@@ -2,7 +2,7 @@
  * This file is part of the GROMACS molecular simulation package.
  *
  * Copyright (c) 2012,2013,2014,2015,2017 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.
@@ -92,8 +92,7 @@ public:
 };
 
 AbstractTrajectoryAnalysisModuleTestFixture::Impl::Impl(AbstractTrajectoryAnalysisModuleTestFixture* parent) :
-    parent_(*parent),
-    bDatasetsIncluded_(false)
+    parent_(*parent), bDatasetsIncluded_(false)
 {
 }
 
index d860414771b9310e6380adedb766f344b278c72a..da2735e44734d5922cd34427e95cf77902536699 100644 (file)
@@ -72,13 +72,7 @@ class SurfaceAreaTest : public ::testing::Test
 {
 public:
     SurfaceAreaTest() :
-        box_(),
-        rng_(12345),
-        area_(0.0),
-        volume_(0.0),
-        atomArea_(nullptr),
-        dotCount_(0),
-        dots_(nullptr)
+        box_(), rng_(12345), area_(0.0), volume_(0.0), atomArea_(nullptr), dotCount_(0), dots_(nullptr)
     {
     }
     ~SurfaceAreaTest() override
index d387e8b9dc941b5c6e4f980f107a038acd5ff26d..1ab936f1a2fddbb51d9f746ad4e957355dc24258 100644 (file)
@@ -61,11 +61,7 @@ namespace gmx
 {
 
 TopologyInformation::TopologyInformation() :
-    hasLoadedMtop_(false),
-    expandedTopology_(nullptr),
-    atoms_(nullptr),
-    bTop_(false),
-    pbcType_(PbcType::Unset)
+    hasLoadedMtop_(false), expandedTopology_(nullptr), atoms_(nullptr), bTop_(false), pbcType_(PbcType::Unset)
 {
 }
 
index 4eda8b3afd52cd8de3cde402f05a87865c4fe8c4..45e4c70133ba8bb3bcc02945fef74e38c751573c 100644 (file)
@@ -91,9 +91,7 @@ public:
     }
     //! \copydoc DataFileOptions(const char *)
     DataFileOptions(const std::string& filename) :
-        filename_(filename.c_str()),
-        bCurrentDir_(true),
-        bThrow_(true)
+        filename_(filename.c_str()), bCurrentDir_(true), bThrow_(true)
     {
     }
 
@@ -131,9 +129,7 @@ struct DataFileInfo
 {
     //! Initializes the structure with given values.
     DataFileInfo(const std::string& dir, const std::string& name, bool bDefault) :
-        dir(dir),
-        name(name),
-        bFromDefaultDir(bDefault)
+        dir(dir), name(name), bFromDefaultDir(bDefault)
     {
     }
 
index 838bdee3d407a05144c49a60cc902637013978e9..79bd062542ab77cc3a0856f52c04543a138ef4e7 100644 (file)
@@ -2,7 +2,7 @@
  * This file is part of the GROMACS molecular simulation package.
  *
  * Copyright (c) 2010,2011,2014,2015,2016 by the GROMACS development team.
- * Copyright (c) 2017,2019,2020, by the GROMACS development team, led by
+ * Copyright (c) 2017,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.
@@ -112,9 +112,7 @@ public:
         return new Impl(handle, finddata);
     }
     Impl(intptr_t handle, _finddata_t finddata) :
-        windows_handle(handle),
-        finddata(finddata),
-        bFirst_(true)
+        windows_handle(handle), finddata(finddata), bFirst_(true)
     {
     }
     ~Impl() { _findclose(windows_handle); }
index cdfc6ad9d26004f89c8388c8ca9d013c4e46ebdf..8f23e41cbf793573e14f915f1d532dd7323578e3 100644 (file)
@@ -71,7 +71,8 @@ public:
     }
 
 private:
-    union {
+    union
+    {
         char c[ValueSize];
         T    v;
     } u;
@@ -81,7 +82,8 @@ private:
 template<typename T>
 T swapEndian(const T& value)
 {
-    union {
+    union
+    {
         T                           value_;
         std::array<char, sizeof(T)> valueAsCharArray_;
     } endianessSwappedValue;
index 028939954fd02c174433e7aa8fe0becafc6976cf..a4569e5e13ae5eeaea114ccf9cb0a844a4fadb7c 100644 (file)
@@ -169,9 +169,7 @@ class CompareHelper
 {
 public:
     CompareHelper(TextWriter* writer, real ftol, real abstol) :
-        writer_(writer),
-        ftol_(ftol),
-        abstol_(abstol)
+        writer_(writer), ftol_(ftol), abstol_(abstol)
     {
     }
     void compareObjects(const KeyValueTreeObject& obj1, const KeyValueTreeObject& obj2)
index 6c72642c69b995f91a6fbf0d5e77753fde72eca0..e3060b14a831401af9eb6c097a98539f1066918d 100644 (file)
@@ -65,8 +65,7 @@ class KeyValueTreeTransformRulesScoped::Impl : public IKeyValueTreeTransformRule
 {
 public:
     Impl(internal::KeyValueTreeTransformerImpl* impl, const KeyValueTreePath& prefix) :
-        impl_(impl),
-        prefix_(prefix)
+        impl_(impl), prefix_(prefix)
     {
     }
 
@@ -97,8 +96,8 @@ KeyValueTreeTransformRulesScoped::KeyValueTreeTransformRulesScoped(internal::Key
 
 KeyValueTreeTransformRulesScoped::KeyValueTreeTransformRulesScoped(KeyValueTreeTransformRulesScoped&&) noexcept = default;
 
-KeyValueTreeTransformRulesScoped& KeyValueTreeTransformRulesScoped::
-                                  operator=(KeyValueTreeTransformRulesScoped&&) noexcept = default;
+KeyValueTreeTransformRulesScoped&
+KeyValueTreeTransformRulesScoped::operator=(KeyValueTreeTransformRulesScoped&&) noexcept = default;
 
 KeyValueTreeTransformRulesScoped::~KeyValueTreeTransformRulesScoped() {}
 
@@ -198,8 +197,7 @@ public:
         typedef std::map<std::string, Rule, StringCompare> ChildRuleMap;
 
         explicit Rule(StringCompareType keyMatchType) :
-            expectedType_(typeid(void)),
-            childRules_(keyMatchType)
+            expectedType_(typeid(void)), childRules_(keyMatchType)
         {
         }
 
@@ -257,8 +255,7 @@ public:
     {
     public:
         explicit Transformer(IKeyValueTreeErrorHandler* errorHandler) :
-            errorHandler_(errorHandler),
-            backMapping_(new KeyValueTreeBackMapping)
+            errorHandler_(errorHandler), backMapping_(new KeyValueTreeBackMapping)
         {
             if (errorHandler_ == nullptr)
             {
@@ -507,8 +504,7 @@ public:
 
 KeyValueTreeTransformRuleBuilder::KeyValueTreeTransformRuleBuilder(internal::KeyValueTreeTransformerImpl* impl,
                                                                    const KeyValueTreePath& prefix) :
-    impl_(impl),
-    data_(new Data(prefix))
+    impl_(impl), data_(new Data(prefix))
 {
 }
 
index 27b6f7dc4225adf2a5c1169634200945f2670806..b6931860f7516a79dfe1f5893186936b74ccc076 100644 (file)
@@ -372,8 +372,7 @@ private:
     typedef std::unique_ptr<IKeyValueTreeBackMapping> MappingPointer;
 
     KeyValueTreeTransformResult(KeyValueTreeObject&& object, MappingPointer&& mapping) :
-        object_(std::move(object)),
-        mapping_(std::move(mapping))
+        object_(std::move(object)), mapping_(std::move(mapping))
     {
     }
 
index 14d73b13e6afcdaddd0c8be2f1379d8eae9934bf..46cdc3a8cc6098191733edd77456d5d40c649fdd 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2016,2018,2019, by the GROMACS development team, led by
+ * Copyright (c) 2016,2018,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.
@@ -68,11 +68,7 @@ LogEntryWriter& LogEntryWriter::appendTextFormatted(gmx_fmtstr const char* fmt,
 }
 
 MDLogger::MDLogger() :
-    warning(nullptr),
-    error(nullptr),
-    debug(nullptr),
-    verboseDebug(nullptr),
-    info(nullptr)
+    warning(nullptr), error(nullptr), debug(nullptr), verboseDebug(nullptr), info(nullptr)
 {
 }
 
index 91e366f2f0af6bb345fe64c0ef40865845213048..7a0467b2dd404702d28206bd7f0660d75fd60644 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2016,2018,2019, by the GROMACS development team, led by
+ * Copyright (c) 2016,2018,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.
@@ -108,14 +108,12 @@ public:
  */
 
 LoggerOwner::LoggerOwner(std::unique_ptr<Impl> impl) :
-    impl_(impl.release()),
-    logger_(&impl_->logger_)
+    impl_(impl.release()), logger_(&impl_->logger_)
 {
 }
 
 LoggerOwner::LoggerOwner(LoggerOwner&& other) noexcept :
-    impl_(std::move(other.impl_)),
-    logger_(&impl_->logger_)
+    impl_(std::move(other.impl_)), logger_(&impl_->logger_)
 {
 }
 
index 354ae7ea80bbc55054eb7aea63608502d0f6d801..9e1596c943b0d9a52e95363c0de3408eb1ff2550 100644 (file)
@@ -2,7 +2,7 @@
  * This file is part of the GROMACS molecular simulation package.
  *
  * Copyright (c) 2011,2012,2013,2014,2015 by the GROMACS development team.
- * Copyright (c) 2016,2018,2019,2020, by the GROMACS development team, led by
+ * Copyright (c) 2016,2018,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.
@@ -110,11 +110,7 @@ public:
     struct NotFoundInfo
     {
         NotFoundInfo(const char* filename, const char* message, const char* call, bool wasError, int err) :
-            filename(filename),
-            message(message),
-            call(call),
-            wasError(wasError),
-            err(err)
+            filename(filename), message(message), call(call), wasError(wasError), err(err)
         {
         }
 
index 1219ea34701750db491a321ab79533a0556da90f..1cefb1e216e96293f806a699bb39a2b94c7481c6 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2015,2017,2018,2019, by the GROMACS development team, led by
+ * Copyright (c) 2015,2017,2018,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.
@@ -61,15 +61,13 @@ void StringOutputStream::close() {}
 StringInputStream::StringInputStream(const std::string& input) : input_(input), pos_(0) {}
 
 StringInputStream::StringInputStream(const std::vector<std::string>& input) :
-    input_(joinStrings(input.begin(), input.end(), "\n")),
-    pos_(0)
+    input_(joinStrings(input.begin(), input.end(), "\n")), pos_(0)
 {
     input_.append("\n");
 }
 
 StringInputStream::StringInputStream(ArrayRef<const char* const> const& input) :
-    input_(joinStrings(input.begin(), input.end(), "\n")),
-    pos_(0)
+    input_(joinStrings(input.begin(), input.end(), "\n")), pos_(0)
 {
     input_.append("\n");
 }
index c818320e2ec82ccd32352676a10b01a4dd34bd62..779fa9ad7fd2e497f2dc33df4327914aba5c5790 100644 (file)
@@ -338,11 +338,7 @@ bool equalCaseInsensitive(const std::string& source, const std::string& target,
  */
 
 TextLineWrapperSettings::TextLineWrapperSettings() :
-    maxLength_(0),
-    indent_(0),
-    firstLineIndent_(-1),
-    bKeepFinalSpaces_(false),
-    continuationChar_('\0')
+    maxLength_(0), indent_(0), firstLineIndent_(-1), bKeepFinalSpaces_(false), continuationChar_('\0')
 {
 }
 
index ed502096d3165267865a82929efd145dbbb65262..0fb8cbfe7c22841fa53f77191afb4183b192b098 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * 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.
@@ -53,12 +53,14 @@ namespace test
 {
 namespace
 {
-union IntAndFloat32 {
+union IntAndFloat32
+{
     std::int32_t int32Value_;
     float        floatValue_;
 };
 
-union IntAndFloat64 {
+union IntAndFloat64
+{
     std::int64_t int64Value_;
     double       doubleValue_;
 };
@@ -88,8 +90,9 @@ constexpr int integerSizeDependentTestingValue()
 //! Return the endianess-swapped integer used for testing, depending on the size of int.
 constexpr int integerSizeDependentTestingValueEndianessSwapped()
 {
-    return sizeof(int) == 4 ? c_int32ValueSwapped
-                            : sizeof(int) == 8 ? c_int64ValueSwapped : c_int16ValueSwapped;
+    return sizeof(int) == 4   ? c_int32ValueSwapped
+           : sizeof(int) == 8 ? c_int64ValueSwapped
+                              : c_int16ValueSwapped;
 }
 
 class InMemorySerializerTest : public ::testing::Test
index 3f99ed5f9d111ba34e2f3ec2fce5493fe308a29f..18be9ad467534a1006df57f766ccc19e2a39edc3 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2015,2016,2017,2018,2019, by the GROMACS development team, led by
+ * Copyright (c) 2015,2016,2017,2018,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.
@@ -57,10 +57,7 @@ class TextWriter::Impl
 {
 public:
     explicit Impl(const TextOutputStreamPointer& stream) :
-        stream_(stream),
-        newLineCount_(2),
-        currentLineLength_(0),
-        pendingNewLine_(false)
+        stream_(stream), newLineCount_(2), currentLineLength_(0), pendingNewLine_(false)
     {
         wrapper_.settings().setKeepFinalSpaces(true);
     }
index fa9823675ab1b7b81dc4f9bc85a582ad71a2a982..da828c0f5608ab10277ecbf8efe2336ccdbb0971 100644 (file)
@@ -79,8 +79,7 @@ EnergyTermsToCompare EnergyComparison::defaultEnergyTermsToCompare()
 
 EnergyComparison::EnergyComparison(const EnergyTermsToCompare& energyTermsToCompare,
                                    MaxNumFrames                maxNumFrames) :
-    energyTermsToCompare_(energyTermsToCompare),
-    maxNumFrames_(maxNumFrames)
+    energyTermsToCompare_(energyTermsToCompare), maxNumFrames_(maxNumFrames)
 {
 }
 
index 58809a1f542e496f5a52d7685370fa96f271a8d9..e9dcbe11a8a9f1db7307de0fc23372036f991b05 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2016,2018,2019, by the GROMACS development team, led by
+ * Copyright (c) 2016,2018,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.
@@ -69,8 +69,7 @@ public:
     typedef std::unique_ptr<FrameReader> FrameReaderPtr;
     //! Constructor
     FramePairManager(FrameReaderPtr first, FrameReaderPtr second) :
-        first_(std::move(first)),
-        second_(std::move(second))
+        first_(std::move(first)), second_(std::move(second))
     {
     }
 
index 6851b7bdc19f8aaabf4d13094d6c03208b6e9e02..b663fd733ae392e5e62ef14b6473efe8b84c0f09 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2020, by the GROMACS development team, led by
+ * Copyright (c) 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.
@@ -126,31 +126,31 @@ TEST_P(MtsComparisonTest, WithinTolerances)
     const int nstfout       = 2 * numSteps;
     auto      refMdpOptions = sharedMdpOptions
                          + gmx::formatString(
-                                   "mts       = no\n"
-                                   "nstcalcenergy = %d\n"
-                                   "nstenergy = %d\n"
-                                   "nstxout   = 0\n"
-                                   "nstvout   = 0\n"
-                                   "nstfout   = %d\n",
-                                   numSteps,
-                                   numSteps,
-                                   nstfout);
+                                 "mts       = no\n"
+                                 "nstcalcenergy = %d\n"
+                                 "nstenergy = %d\n"
+                                 "nstxout   = 0\n"
+                                 "nstvout   = 0\n"
+                                 "nstfout   = %d\n",
+                                 numSteps,
+                                 numSteps,
+                                 nstfout);
 
     auto mtsMdpOptions = sharedMdpOptions
                          + gmx::formatString(
-                                   "mts        = yes\n"
-                                   "mts-levels = 2\n"
-                                   "mts-level2-forces = %s\n"
-                                   "mts-level2-factor = 2\n"
-                                   "nstcalcenergy = %d\n"
-                                   "nstenergy  = %d\n"
-                                   "nstxout    = 0\n"
-                                   "nstvout    = 0\n"
-                                   "nstfout    = %d\n",
-                                   mtsScheme.c_str(),
-                                   numSteps,
-                                   numSteps,
-                                   nstfout);
+                                 "mts        = yes\n"
+                                 "mts-levels = 2\n"
+                                 "mts-level2-forces = %s\n"
+                                 "mts-level2-factor = 2\n"
+                                 "nstcalcenergy = %d\n"
+                                 "nstenergy  = %d\n"
+                                 "nstxout    = 0\n"
+                                 "nstvout    = 0\n"
+                                 "nstfout    = %d\n",
+                                 mtsScheme.c_str(),
+                                 numSteps,
+                                 numSteps,
+                                 nstfout);
 
     // At step 0 the energy and virial should only differ due to rounding errors
     EnergyTermsToCompare energyTermsToCompareStep0 = energyTermsToCompare(0.001, 0.01);
index 06afc5b65844b3a40e95f7a8f6e4ba4028061b7d..180f2e7e7958cc4ec4f66036c6807e8f97f2a6b9 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2016,2018,2019, by the GROMACS development team, led by
+ * Copyright (c) 2016,2018,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.
@@ -58,8 +58,7 @@ namespace test
 TerminationHelper::TerminationHelper(TestFileManager*  fileManager,
                                      CommandLine*      mdrunCaller,
                                      SimulationRunner* runner) :
-    mdrunCaller_(mdrunCaller),
-    runner_(runner)
+    mdrunCaller_(mdrunCaller), runner_(runner)
 {
     runner_->cptFileName_ = fileManager->getTemporaryFilePath(".cpt");
     runner_->useTopGroAndNdxFromDatabase("spc2");
index c4df99d9103c90ccf925548ce8dece6962ffd852..653fca6fedaa27d76d6817f549939184469200e5 100644 (file)
@@ -251,8 +251,7 @@ const TrajectoryTolerances TrajectoryComparison::s_defaultTrajectoryTolerances{
 
 TrajectoryComparison::TrajectoryComparison(const TrajectoryFrameMatchSettings& matchSettings,
                                            const TrajectoryTolerances&         tolerances) :
-    matchSettings_(matchSettings),
-    tolerances_(tolerances)
+    matchSettings_(matchSettings), tolerances_(tolerances)
 {
 }
 
index a4e0fff0f25388e0da8705002a131629450475ba..31ea19daf687b8e3e76e660ba092d529f416c37d 100644 (file)
@@ -3,7 +3,7 @@
  *
  * Copyright (c) 1991-2000, University of Groningen, The Netherlands.
  * Copyright (c) 2001-2004, The GROMACS development team.
- * Copyright (c) 2013,2014,2019, by the GROMACS development team, led by
+ * Copyright (c) 2013,2014,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.
@@ -119,7 +119,8 @@ typedef struct t_dlgitem
     char *    set, *get, *help;
     edlgitem  type;
     int (*WndProc)(t_x11* x11, struct t_dlgitem* dlgitem, XEvent* event);
-    union {
+    union
+    {
         t_button      button;
         t_radiobutton radiobutton;
         t_groupbox    groupbox;
index ab2b4c0b2eb9a8dc75d0fd4d784e657d4c2d2b49..a03b895abb3cf4de20cd90889f74cf0543ba7fe0 100644 (file)
@@ -2,7 +2,7 @@
  * This file is part of the GROMACS molecular simulation package.
  *
  * Copyright (c) 2012,2013,2014,2015,2016 by the GROMACS development team.
- * Copyright (c) 2017,2018,2019,2020, by the GROMACS development team, led by
+ * Copyright (c) 2017,2018,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.
@@ -267,9 +267,7 @@ public:
     struct OutputFileInfo
     {
         OutputFileInfo(const char* option, const std::string& path, FileMatcherPointer matcher) :
-            option(option),
-            path(path),
-            matcher(move(matcher))
+            option(option), path(path), matcher(move(matcher))
         {
         }
 
index e28dbd751df4fefd94e9fecadfdd6475f02db40d..20ce19ea7fba99448e1cfa3ceb96ccf7d07e6288 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2015,2016,2017,2018,2019,2020, by the GROMACS development team, led by
+ * Copyright (c) 2015,2016,2017,2018,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.
@@ -84,10 +84,7 @@ class InteractiveTestHelper::Impl
 {
 public:
     explicit Impl(TestReferenceChecker checker) :
-        checker_(std::move(checker)),
-        bLastNewline_(true),
-        currentLine_(0),
-        bHasOutput_(false)
+        checker_(std::move(checker)), bLastNewline_(true), currentLine_(0), bHasOutput_(false)
     {
         using ::testing::_;
         using ::testing::Invoke;
index 15778e154febb627b7b1dec7816df45c37b878f4..7d3a5b7abf63839a57a190ff7731d10c24442515 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2013,2014,2015,2016,2019, by the GROMACS development team, led by
+ * Copyright (c) 2013,2014,2015,2016,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.
@@ -75,9 +75,7 @@ class MPIEventForward : public ::testing::TestEventListener
 {
 public:
     MPIEventForward(TestEventListener* defaultPrinter, int rank, int size) :
-        defaultPrinter_(defaultPrinter),
-        rank_(rank),
-        size_(size)
+        defaultPrinter_(defaultPrinter), rank_(rank), size_(size)
     {
     }
 
index cfc320c04bec680ac92fdf0645b0a1f1ec2e8815..ba119355582df7668eebbd5f8fac110632ebe68f 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,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.
@@ -288,12 +288,10 @@ namespace internal
 {
 
 TestReferenceDataImpl::TestReferenceDataImpl(ReferenceDataMode mode, bool bSelfTestMode) :
-    updateMismatchingEntries_(false),
-    bSelfTestMode_(bSelfTestMode),
-    bInUse_(false)
+    updateMismatchingEntries_(false), bSelfTestMode_(bSelfTestMode), bInUse_(false)
 {
-    const std::string dirname = bSelfTestMode ? TestFileManager::getGlobalOutputTempDirectory()
-                                              : TestFileManager::getInputDataDirectory();
+    const std::string dirname  = bSelfTestMode ? TestFileManager::getGlobalOutputTempDirectory()
+                                               : TestFileManager::getInputDataDirectory();
     const std::string filename = TestFileManager::getTestSpecificFileName(".xml");
     fullFilename_              = Path::join(dirname, "refdata", filename);
 
index 9b5c7c2faa7dfe6b1eab4bae2981a53f44a34607..6400f1f2f2091ba2a2930938679fcf3968ea2ef9 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2015,2016,2017,2018,2019,2020, by the GROMACS development team, led by
+ * Copyright (c) 2015,2016,2017,2018,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.
@@ -148,8 +148,7 @@ class FloatingPointChecker : public IReferenceDataEntryChecker
 {
 public:
     FloatingPointChecker(FloatType value, const FloatingPointTolerance& tolerance) :
-        value_(value),
-        tolerance_(tolerance)
+        value_(value), tolerance_(tolerance)
     {
     }
 
@@ -183,8 +182,7 @@ class FloatingPointFromStringChecker : public IReferenceDataEntryChecker
 {
 public:
     FloatingPointFromStringChecker(const std::string& value, const FloatingPointTolerance& tolerance) :
-        value_(value),
-        tolerance_(tolerance)
+        value_(value), tolerance_(tolerance)
     {
     }
 
index e88d74c92a062fabfbb415c4b6e04fb1b971064e..834aa5cffa6df9b34ba280e3ed37bb5d048200e0 100644 (file)
@@ -102,8 +102,7 @@ public:
      * \param[in] context  Current \Gromacs program context.
      */
     explicit TestProgramContext(const IProgramContext& context) :
-        context_(context),
-        dataPath_(CMAKE_SOURCE_DIR)
+        context_(context), dataPath_(CMAKE_SOURCE_DIR)
     {
     }
 
index 93bfb2f1782bac45d86e15bc45b95482c60ab9f7..108456cd49d001d1854565f16ae4f769f4bb8b09 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2015,2016,2019,2020, by the GROMACS development team, led by
+ * Copyright (c) 2015,2016,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.
@@ -63,9 +63,7 @@ class InteractiveSession
 {
 public:
     explicit InteractiveSession(ReferenceDataMode mode) :
-        data_(mode),
-        helper_(data_.rootChecker()),
-        nextInputLine_(0)
+        data_(mode), helper_(data_.rootChecker()), nextInputLine_(0)
     {
     }