Use more MDLogger in preprocessing
[alexxy/gromacs.git] / src / gromacs / gmxpreprocess / gen_maxwell_velocities.h
index e339cd797d2e92fec0debbf0194d45402c21aefb..5a31cb4fd4d3ed34052367a15460f6d75f1b07ed 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,2015,2019, by the GROMACS development team, led by
+ * Copyright (c) 2013,2014,2015,2019,2020, 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.
 
 struct gmx_mtop_t;
 
+namespace gmx
+{
+class MDLogger;
+}
+
 /*! \brief
  * Generate Maxwellian velocities.
  *
@@ -52,18 +57,19 @@ struct gmx_mtop_t;
  * \param[in] seed  Random number generator seed
  * \param[in] mtop  Molecular Topology
  * \param[out] v    Velocities
+ * \param[in] logger Handle to logging interface.
  */
-void maxwell_speed(real tempi, unsigned int seed, gmx_mtop_t* mtop, rvec v[]);
+void maxwell_speed(real tempi, unsigned int seed, gmx_mtop_t* mtop, rvec v[], const gmx::MDLogger& logger);
 
 /*! \brief
  * Remove the center of mass motion in a set of coordinates.
  *
- * \param[out] log  File for printing debug information
+ * \param[in]  logger Handle to logging interface.
  * \param[in]  natoms Number of atoms
  * \param[in]  mass   Atomic masses
  * \param[in]  x      Coordinates
  * \param[out] v      Velocities
  */
-void stop_cm(FILE* log, int natoms, real mass[], rvec x[], rvec v[]);
+void stop_cm(const gmx::MDLogger& logger, int natoms, real mass[], rvec x[], rvec v[]);
 
 #endif