Apply clang-format to source tree
[alexxy/gromacs.git] / src / gromacs / domdec / localatomsetdata.h
index 5665370fbd48c42ee9177a76822533e92e5ec4f0..c6dd2cb85e68da8e9794a44860ad34317af22cc7 100644 (file)
@@ -60,64 +60,64 @@ namespace internal
  */
 class LocalAtomSetData
 {
-    public:
-        /*! \brief Store the data for an atom set with an index group.
-         *
-         * Prior to domain decomposition, local atom indices are global atom indices
-         * and the collective index runs from 0..numberOfAtoms-1.
-         * local and collective indices will be updated in setLocalAndCollectiveIndices
-         * to match domain decompostion if domain decomposition is performed.
-         *
-         * \todo remove this constructor once all indices are represented
-         *       as gmx::index instead of int.
-         *
-         * \note Not created if the internal int type does match gmx::index
-         *
-         * \param[in] globalAtomIndex Indices of the atoms to be managed
-         */
-        template <typename T = void, typename U = std::enable_if_t<!std::is_same<int, index>::value, T> >
-        explicit LocalAtomSetData(ArrayRef<const int> globalAtomIndex) :
-            globalIndex_(globalAtomIndex.begin(), globalAtomIndex.end()),
-            localIndex_(globalAtomIndex.begin(), globalAtomIndex.end())
-        {
-            collectiveIndex_.resize(localIndex_.size());
-            std::iota(collectiveIndex_.begin(), collectiveIndex_.end(), 0);
-        }
+public:
+    /*! \brief Store the data for an atom set with an index group.
+     *
+     * Prior to domain decomposition, local atom indices are global atom indices
+     * and the collective index runs from 0..numberOfAtoms-1.
+     * local and collective indices will be updated in setLocalAndCollectiveIndices
+     * to match domain decompostion if domain decomposition is performed.
+     *
+     * \todo remove this constructor once all indices are represented
+     *       as gmx::index instead of int.
+     *
+     * \note Not created if the internal int type does match gmx::index
+     *
+     * \param[in] globalAtomIndex Indices of the atoms to be managed
+     */
+    template<typename T = void, typename U = std::enable_if_t<!std::is_same<int, index>::value, T>>
+    explicit LocalAtomSetData(ArrayRef<const int> globalAtomIndex) :
+        globalIndex_(globalAtomIndex.begin(), globalAtomIndex.end()),
+        localIndex_(globalAtomIndex.begin(), globalAtomIndex.end())
+    {
+        collectiveIndex_.resize(localIndex_.size());
+        std::iota(collectiveIndex_.begin(), collectiveIndex_.end(), 0);
+    }
 
-        /*! \brief Store the data for an atom set with an index group.
-         *
-         * Prior to domain decomposition, local atom indices are global atom indices
-         * and the collective index runs from 0..numberOfAtoms-1.
-         * local and collective indices will be updated in setLocalAndCollectiveIndices
-         * to match domain decompostion if domain decomposition is performed.
-         *
-         * \param[in] globalAtomIndex Indices of the atoms to be managed
-         */
-        explicit LocalAtomSetData(ArrayRef<const index> globalAtomIndex);
+    /*! \brief Store the data for an atom set with an index group.
+     *
+     * Prior to domain decomposition, local atom indices are global atom indices
+     * and the collective index runs from 0..numberOfAtoms-1.
+     * local and collective indices will be updated in setLocalAndCollectiveIndices
+     * to match domain decompostion if domain decomposition is performed.
+     *
+     * \param[in] globalAtomIndex Indices of the atoms to be managed
+     */
+    explicit LocalAtomSetData(ArrayRef<const index> globalAtomIndex);
 
-        /*! \brief Sets the local and collective indices from a lookup in ga2la.
-         *
-         * Calculate local and collective indices of home atoms, assuming a valid
-         * global atom to local atom look-up table.
-         *
-         * \param[in] ga2la lookup table that reports if an atom is local.
-         */
-        void setLocalAndCollectiveIndices(const gmx_ga2la_t &ga2la);
-        /*! \brief Global indices of the atoms in this set. */
-        const std::vector<int> globalIndex_;
-        /*! \brief Maps indices on this rank [0..num_atoms_local_) to global atom indicices,
-         * so that localIndex[i] = globalIndex[collectiveIndex[i]].
-         *
-         * This translation of locally dense atom data to global representation,
-         * allows to adresses per-atom properties, e.g., scattering factors,
-         * that are stored in a global continuous array for each atom of the atom set.
-         */
-        std::vector<int> collectiveIndex_;
-        /*! \brief Local indices of the atoms.
-         * Access the i-th local atom coordinate of this set by x[local_index_[i]].
-         * Constructed and updated every domain-decomposition step.
-         */
-        std::vector<int> localIndex_;
+    /*! \brief Sets the local and collective indices from a lookup in ga2la.
+     *
+     * Calculate local and collective indices of home atoms, assuming a valid
+     * global atom to local atom look-up table.
+     *
+     * \param[in] ga2la lookup table that reports if an atom is local.
+     */
+    void setLocalAndCollectiveIndices(const gmx_ga2la_t& ga2la);
+    /*! \brief Global indices of the atoms in this set. */
+    const std::vector<int> globalIndex_;
+    /*! \brief Maps indices on this rank [0..num_atoms_local_) to global atom indicices,
+     * so that localIndex[i] = globalIndex[collectiveIndex[i]].
+     *
+     * This translation of locally dense atom data to global representation,
+     * allows to adresses per-atom properties, e.g., scattering factors,
+     * that are stored in a global continuous array for each atom of the atom set.
+     */
+    std::vector<int> collectiveIndex_;
+    /*! \brief Local indices of the atoms.
+     * Access the i-th local atom coordinate of this set by x[local_index_[i]].
+     * Constructed and updated every domain-decomposition step.
+     */
+    std::vector<int> localIndex_;
 };
 
 } // namespace internal
@@ -125,6 +125,4 @@ class LocalAtomSetData
 } // namespace gmx
 
 
-
-
 #endif