Apply clang-format to source tree
[alexxy/gromacs.git] / src / gromacs / mdtypes / mdatom.h
index 41fbe70e4bc91d3ddadac86d8c35385f2e53eb2f..56b323106363db5c3d28b44f05e82432ad7cb6bf 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) 2012,2013,2014,2015,2016,2017, by the GROMACS development team, led by
+ * Copyright (c) 2012,2013,2014,2015,2016,2017,2019, 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.
 #include "gromacs/utility/basedefinitions.h"
 #include "gromacs/utility/real.h"
 
-typedef struct t_mdatoms {
+typedef struct t_mdatoms
+{
     //! Total mass in state A
-    real                   tmassA;
+    real tmassA;
     //! Total mass in state B
-    real                   tmassB;
+    real tmassB;
     //! Total mass
-    real                   tmass;
+    real tmass;
     //! Number of atoms in arrays
-    int                    nr;
+    int nr;
     //! Number of elements in arrays
-    int                    nalloc;
+    int nalloc;
     //! Number of energy groups
-    int                    nenergrp;
+    int nenergrp;
     //! Do we have multiple center of mass motion removal groups
-    gmx_bool               bVCMgrps;
+    gmx_bool bVCMgrps;
     //! Do we have any virtual sites?
-    gmx_bool               haveVsites;
+    gmx_bool haveVsites;
     //! Do we have atoms that are frozen along 1 or 2 (not 3) dimensions?
-    gmx_bool               havePartiallyFrozenAtoms;
+    gmx_bool havePartiallyFrozenAtoms;
     //! Number of perturbed atoms
-    int                    nPerturbed;
+    int nPerturbed;
     //! Number of atoms for which the mass is perturbed
-    int                    nMassPerturbed;
+    int nMassPerturbed;
     //! Number of atoms for which the charge is perturbed
-    int                    nChargePerturbed;
+    int nChargePerturbed;
     //! Number of atoms for which the type is perturbed
-    int                    nTypePerturbed;
+    int nTypePerturbed;
     //! Do we have orientation restraints
-    gmx_bool               bOrires;
+    gmx_bool bOrires;
     //! Atomic mass in A state
-    real                  *massA;
+    realmassA;
     //! Atomic mass in B state
-    real                  *massB;
+    realmassB;
     //! Atomic mass in present state
-    real                  *massT;
+    realmassT;
     //! Inverse atomic mass per atom, 0 for vsites and shells
-    real                  *invmass;
+    realinvmass;
     //! Inverse atomic mass per atom and dimension, 0 for vsites, shells and frozen dimensions
-    rvec                  *invMassPerDim;
+    rvecinvMassPerDim;
     //! Atomic charge in A state
-    real                  *chargeA;
+    realchargeA;
     //! Atomic charge in B state
-    real                  *chargeB;
+    realchargeB;
     //! Dispersion constant C6 in A state
-    real                  *sqrt_c6A;
+    realsqrt_c6A;
     //! Dispersion constant C6 in A state
-    real                  *sqrt_c6B;
+    realsqrt_c6B;
     //! Van der Waals radius sigma in the A state
-    real                  *sigmaA;
+    realsigmaA;
     //! Van der Waals radius sigma in the B state
-    real                  *sigmaB;
+    realsigmaB;
     //! Van der Waals radius sigma^3 in the A state
-    real                  *sigma3A;
+    realsigma3A;
     //! Van der Waals radius sigma^3 in the B state
-    real                  *sigma3B;
+    realsigma3B;
     //! Is this atom perturbed
-    gmx_bool              *bPerturbed;
+    gmx_boolbPerturbed;
     //! Type of atom in the A state
-    int                   *typeA;
+    inttypeA;
     //! Type of atom in the B state
-    int                   *typeB;
+    inttypeB;
     //! Particle type
-    unsigned short        *ptype;
+    unsigned shortptype;
     //! Group index for temperature coupling
-    unsigned short        *cTC;
+    unsigned shortcTC;
     //! Group index for energy matrix
-    unsigned short        *cENER;
+    unsigned shortcENER;
     //! Group index for acceleration
-    unsigned short        *cACC;
+    unsigned shortcACC;
     //! Group index for freezing
-    unsigned short        *cFREEZE;
+    unsigned shortcFREEZE;
     //! Group index for center of mass motion removal
-    unsigned short        *cVCM;
+    unsigned shortcVCM;
     //! Group index for user 1
-    unsigned short        *cU1;
+    unsigned shortcU1;
     //! Group index for user 2
-    unsigned short        *cU2;
+    unsigned shortcU2;
     //! Group index for orientation restraints
-    unsigned short        *cORF;
+    unsigned shortcORF;
     //! QMMM atoms
-    gmx_bool              *bQM;
+    gmx_boolbQM;
     //! Number of atoms on this processor. TODO is this still used?
-    int                    homenr;
+    int homenr;
     //! The lambda value used to create the contents of the struct
-    real                   lambda;
+    real lambda;
 } t_mdatoms;
 
 #endif