Annotate modular simulator headers with exposure level
authorPascal Merz <pascal.merz@me.com>
Tue, 7 Jul 2020 10:46:53 +0000 (10:46 +0000)
committerM. Eric Irrgang <mei2n@virginia.edu>
Tue, 7 Jul 2020 10:46:53 +0000 (10:46 +0000)
This change adds comments to the doxygen commen on top of each header file
to describe which files are exposed outside the modular simulator module.

19 files changed:
src/gromacs/modularsimulator/checkpointhelper.h
src/gromacs/modularsimulator/compositesimulatorelement.h
src/gromacs/modularsimulator/computeglobalselement.h
src/gromacs/modularsimulator/constraintelement.h
src/gromacs/modularsimulator/domdechelper.h
src/gromacs/modularsimulator/energyelement.h
src/gromacs/modularsimulator/forceelement.h
src/gromacs/modularsimulator/freeenergyperturbationelement.h
src/gromacs/modularsimulator/modularsimulator.h
src/gromacs/modularsimulator/modularsimulatorinterfaces.h
src/gromacs/modularsimulator/parrinellorahmanbarostat.h
src/gromacs/modularsimulator/pmeloadbalancehelper.h
src/gromacs/modularsimulator/propagator.h
src/gromacs/modularsimulator/signallers.h
src/gromacs/modularsimulator/simulatoralgorithm.h
src/gromacs/modularsimulator/statepropagatordata.h
src/gromacs/modularsimulator/topologyholder.h
src/gromacs/modularsimulator/trajectoryelement.h
src/gromacs/modularsimulator/vrescalethermostat.h

index 905e636af3f16aaa1fa1e152993a2ea22ec38f99..8f3b6eea7ec7a44e44abdba272a639112d553f52 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,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.
  * To help us fund GROMACS development, we humbly ask that you cite
  * the research papers on the package. Check out http://www.gromacs.org.
  */
-/*! \libinternal \file
+/*! \internal \file
  * \brief Declares the checkpoint helper for the modular simulator
  *
  * \author Pascal Merz <pascal.merz@me.com>
  * \ingroup module_modularsimulator
+ *
+ * This header is only used within the modular simulator module
  */
 
 #ifndef GMX_MODULARSIMULATOR_CHECKPOINTHELPER_H
@@ -56,7 +58,7 @@ namespace gmx
 class MDLogger;
 class TrajectoryElement;
 
-/*! \libinternal
+/*! \internal
  * \ingroup module_modularsimulator
  * \brief Checkpoint helper
  *
index 36a05af736a72b48a1ce9a383963d70a9ea77eeb..8f74b259f8a9792650c2053d5cb6bed798d53362 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,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.
  * To help us fund GROMACS development, we humbly ask that you cite
  * the research papers on the package. Check out http://www.gromacs.org.
  */
-/*! \libinternal \file
+/*! \internal \file
  * \brief Declares the composite element for the modular simulator
  *
  * \author Pascal Merz <pascal.merz@me.com>
  * \ingroup module_modularsimulator
+ *
+ * This header is only used within the modular simulator module
  */
 #ifndef GROMACS_MDTYPES_COMPOSITESIMULATORELEMENT_H
 #define GROMACS_MDTYPES_COMPOSITESIMULATORELEMENT_H
@@ -50,7 +52,7 @@
 namespace gmx
 {
 
-/*! \libinternal
+/*! \internal
  * \ingroup module_modularsimulator
  * \brief Composite simulator element
  *
index 74ad225e731510a05c76456f67bb6b1f7978e1ff..26beb24180f143cf4c23ef80982e6d0dbb045e8f 100644 (file)
  * To help us fund GROMACS development, we humbly ask that you cite
  * the research papers on the package. Check out http://www.gromacs.org.
  */
-/*! \libinternal \file
+/*! \internal \file
  * \brief Declares the global reduction element for the modular simulator
  *
  * \author Pascal Merz <pascal.merz@me.com>
  * \ingroup module_modularsimulator
+ *
+ * This header is only used within the modular simulator module
  */
 
 #ifndef GMX_MODULARSIMULATOR_COMPUTEGLOBALSELEMENT_H
@@ -75,7 +77,7 @@ typedef std::function<void()> CheckBondedInteractionsCallback;
 //! Pointer to the function type allowing to request a check of the number of bonded interactions
 typedef std::unique_ptr<CheckBondedInteractionsCallback> CheckBondedInteractionsCallbackPtr;
 
-/*! \libinternal
+/*! \internal
  * \brief Encapsulate the calls to `compute_globals`
  *
  * This element aims at offering an interface to the legacy
index 2b754d33c2edf9f7b31f20c4173f7ee6242df922..14c6b34fc47d15ce1ecd4522b2d121c3644ae22e 100644 (file)
  * To help us fund GROMACS development, we humbly ask that you cite
  * the research papers on the package. Check out http://www.gromacs.org.
  */
-/*! \libinternal \file
+/*! \internal \file
  * \brief Declares the constraint element for the modular simulator
  *
  * \author Pascal Merz <pascal.merz@me.com>
  * \ingroup module_modularsimulator
+ *
+ * This header is only used within the modular simulator module
  */
 
 #ifndef GMX_MODULARSIMULATOR_CONSTRAINTELEMENT_H
@@ -53,7 +55,7 @@ class EnergyElement;
 class FreeEnergyPerturbationElement;
 class StatePropagatorData;
 
-/*! \libinternal
+/*! \internal
  * \ingroup module_modularsimulator
  * \brief Constraints element
  *
index 5375c73e244c1004bc9ca3f27688fb6355f8659d..f0de5d90375411d2cd0f9920cb0f51fdc92407d8 100644 (file)
  * To help us fund GROMACS development, we humbly ask that you cite
  * the research papers on the package. Check out http://www.gromacs.org.
  */
-/*! \libinternal \file
+/*! \internal \file
  * \brief Declares the domain decomposition helper for the modular simulator
  *
  * \author Pascal Merz <pascal.merz@me.com>
  * \ingroup module_modularsimulator
+ *
+ * This header is only used within the modular simulator module
  */
 
 #ifndef GMX_MODULARSIMULATOR_DOMDECHELPER_H
@@ -70,7 +72,7 @@ typedef std::function<void()> CheckBondedInteractionsCallback;
 //! Pointer to the function type allowing to request a check of the number of bonded interactions
 typedef std::unique_ptr<CheckBondedInteractionsCallback> CheckBondedInteractionsCallbackPtr;
 
-/*! \libinternal
+/*! \internal
  * \brief Infrastructure element responsible for domain decomposition
  *
  * This encapsulates the function call to domain decomposition, which is
index a9440faae08ee8d3c27b72d8877ef0b91e67390f..b5a1b78a08c38d19e8f3e29187b25933a91350d8 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,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.
  * To help us fund GROMACS development, we humbly ask that you cite
  * the research papers on the package. Check out http://www.gromacs.org.
  */
-/*! \libinternal \file
+/*! \internal \file
  * \brief Declares the energy element for the modular simulator
  *
  * \author Pascal Merz <pascal.merz@me.com>
  * \ingroup module_modularsimulator
+ *
+ * This header is only used within the modular simulator module
  */
 
 #ifndef GMX_ENERGYELEMENT_MICROSTATE_H
@@ -67,7 +69,7 @@ class StatePropagatorData;
 class VRescaleThermostat;
 struct MdModulesNotifier;
 
-/*! \libinternal
+/*! \internal
  * \ingroup module_modularsimulator
  * \brief Element managing energies
  *
index 26e7661d030acde8c5b254573a4fe96aa25dbec5..d2e9387ff5fb1dcca91ab2a79fba5ee129f203ca 100644 (file)
@@ -32,7 +32,7 @@
  * To help us fund GROMACS development, we humbly ask that you cite
  * the research papers on the package. Check out http://www.gromacs.org.
  */
-/*! \libinternal \file
+/*! \internal \file
  * \brief Declares the force element for the modular simulator
  *
  * This element calculates the forces, with or without shells or
@@ -40,6 +40,8 @@
  *
  * \author Pascal Merz <pascal.merz@me.com>
  * \ingroup module_modularsimulator
+ *
+ * This header is only used within the modular simulator module
  */
 
 #ifndef GMX_MODULARSIMULATOR_FORCEELEMENT_H
@@ -71,7 +73,7 @@ class MdrunScheduleWorkload;
 class StatePropagatorData;
 class VirtualSitesHandler;
 
-/*! \libinternal
+/*! \internal
  * \ingroup module_modularsimulator
  * \brief Force element
  *
index f1566ffd764e30c1574f4dcd42a1932c10207768..5be5dd2d34616f418adf49bbea829ffeac8db419 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,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.
  * To help us fund GROMACS development, we humbly ask that you cite
  * the research papers on the package. Check out http://www.gromacs.org.
  */
-/*! \libinternal \file
+/*! \internal \file
  * \brief Declares the free energy perturbation element for the modular simulator
  *
  * \author Pascal Merz <pascal.merz@me.com>
  * \ingroup module_modularsimulator
+ *
+ * This header is only used within the modular simulator module
  */
 
 #ifndef GMX_MODULARSIMULATOR_FREEENERGYPERTURBATIONELEMENT_H
@@ -54,7 +56,7 @@ namespace gmx
 {
 class MDAtoms;
 
-/*! \libinternal
+/*! \internal
  * \ingroup module_modularsimulator
  * \brief The free energy perturbation element
  *
index 04b104db5d77c621c668d17817b0204da979cb31..c2922a07223b0d6584696475b6810f20ea01b62f 100644 (file)
  *
  * \author Pascal Merz <pascal.merz@me.com>
  * \ingroup module_modularsimulator
+ *
+ * This header is currently the only part of the modular simulator module which is exposed.
+ * Mdrunner creates an object of type ModularSimulator (via SimulatorBuilder), and calls its
+ * run() method. Mdrunner also calls checkUseModularSimulator(...), which in turns calls a
+ * static method of ModularSimulator. This could easily become a free function if this requires
+ * more exposure than otherwise necessary.
  */
 #ifndef GROMACS_MODULARSIMULATOR_MODULARSIMULATOR_H
 #define GROMACS_MODULARSIMULATOR_MODULARSIMULATOR_H
index 6f0e0cce49e362dc8b382b02b7af92734f7b9f73..85c37d94d1a53d83c66f438bf14690a15b3d2dca 100644 (file)
  *
  * \author Pascal Merz <pascal.merz@me.com>
  */
-/*! \libinternal \file
+/*! \internal \file
  * \brief
  * Declares the main interfaces used by the modular simulator
  *
  * \author Pascal Merz <pascal.merz@me.com>
  * \ingroup module_modularsimulator
+ *
+ * This header is only used within the modular simulator module
  */
 #ifndef GMX_MODULARSIMULATOR_MODULARSIMULATORINTERFACES_H
 #define GMX_MODULARSIMULATOR_MODULARSIMULATORINTERFACES_H
@@ -92,7 +94,7 @@ typedef std::function<void(SimulatorRunFunctionPtr)> RegisterRunFunction;
 //! Pointer to the function type that allows to register run functions
 typedef std::unique_ptr<RegisterRunFunction> RegisterRunFunctionPtr;
 
-/*! \libinternal
+/*! \internal
  * \brief The general interface for elements of the modular simulator
  *
  * Setup and teardown are run once at the beginning of the simulation
@@ -121,7 +123,7 @@ public:
     virtual ~ISimulatorElement() = default;
 };
 
-/*! \libinternal
+/*! \internal
  * \brief The general Signaller interface
  *
  * Signallers are run at the beginning of Simulator steps, informing
@@ -153,7 +155,7 @@ typedef std::function<void(Step, Time)> SignallerCallback;
 //! Pointer to the function type that can be registered to signallers for callback
 typedef std::unique_ptr<SignallerCallback> SignallerCallbackPtr;
 
-/*! \libinternal
+/*! \internal
  * \brief Interface for clients of the NeighborSearchSignaller
  *
  * Defining registerNSCallback allows clients to register an arbitrary callback
@@ -175,7 +177,7 @@ protected:
     virtual SignallerCallbackPtr registerNSCallback() = 0;
 };
 
-/*! \libinternal
+/*! \internal
  * \brief Interface for clients of the LastStepSignaller
  *
  * Defining registerLastStepCallback allows clients to register an arbitrary callback
@@ -197,7 +199,7 @@ protected:
     virtual SignallerCallbackPtr registerLastStepCallback() = 0;
 };
 
-/*! \libinternal
+/*! \internal
  * \brief Interface for clients of the LoggingSignaller
  *
  * Defining registerLoggingCallback allows clients to register an arbitrary callback
@@ -227,7 +229,7 @@ enum class EnergySignallerEvent
     FreeEnergyCalculationStep
 };
 
-/*! \libinternal
+/*! \internal
  * \brief Interface for clients of the EnergySignaller
  *
  * Defining registerEnergyCallback allows clients to register an arbitrary callback
@@ -256,7 +258,7 @@ enum class TrajectoryEvent
     EnergyWritingStep
 };
 
-/*! \libinternal
+/*! \internal
  * \brief Interface for signaller clients of the TrajectoryElement
  *
  * Defining registerTrajectorySignallerCallback allows clients to register an arbitrary
@@ -290,7 +292,7 @@ typedef std::function<void(gmx_mdoutf*, Step, Time, bool, bool)> ITrajectoryWrit
 //! Pointer to the function type for trajectory writing clients
 typedef std::unique_ptr<ITrajectoryWriterCallback> ITrajectoryWriterCallbackPtr;
 
-/*! \libinternal
+/*! \internal
  * \brief Interface for writer clients of the TrajectoryElement
  *
  * Defining registerTrajectoryWriterCallback allows clients to register an arbitrary
@@ -319,7 +321,7 @@ protected:
     virtual ITrajectoryWriterCallbackPtr registerTrajectoryWriterCallback(TrajectoryEvent) = 0;
 };
 
-/*! \libinternal
+/*! \internal
  * \brief Client requiring read access to the local topology
  *
  */
@@ -339,7 +341,7 @@ protected:
     virtual void setTopology(const gmx_localtop_t*) = 0;
 };
 
-/*! \libinternal
+/*! \internal
  * \brief Client that needs to store data during checkpointing
  *
  * The current checkpointing helper uses the legacy t_state object to collect
index 25b40d546bc0a801baf9f37a3c3f221441a0e72b..4423bf87a19ca7bf2a44868e5a5d10b48e5373e5 100644 (file)
  * To help us fund GROMACS development, we humbly ask that you cite
  * the research papers on the package. Check out http://www.gromacs.org.
  */
-/*! \libinternal \file
+/*! \internal \file
  * \brief Declares the Parrinello-Rahman barostat for the modular simulator
  *
  * \author Pascal Merz <pascal.merz@me.com>
  * \ingroup module_modularsimulator
+ *
+ * This header is only used within the modular simulator module
  */
 
 #ifndef GMX_MODULARSIMULATOR_PARRINELLORAHMANBAROSTAT_H
@@ -56,7 +58,7 @@ class EnergyElement;
 class MDAtoms;
 class StatePropagatorData;
 
-/*! \libinternal
+/*! \internal
  * \ingroup module_modularsimulator
  * \brief Element implementing the Parrinello-Rahman barostat
  *
index 39ffa1d03936a5288318da72358baef78c4ab8dd..cbb78424dfa4402270fdfaa89d44c98771b18274 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,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.
  * To help us fund GROMACS development, we humbly ask that you cite
  * the research papers on the package. Check out http://www.gromacs.org.
  */
-/*! \libinternal \file
+/*! \internal \file
  * \brief Declares the PME load balancing helper for the modular simulator
  *
  * \author Pascal Merz <pascal.merz@me.com>
  * \ingroup module_modularsimulator
+ *
+ * This header is only used within the modular simulator module
  */
 
 #ifndef GMX_MODULARSIMULATOR_PMELOADBALANCEHELPER_H
@@ -56,7 +58,7 @@ class MDLogger;
 struct MdrunOptions;
 class StatePropagatorData;
 
-/*! \libinternal
+/*! \internal
  * \ingroup module_modularsimulator
  * \brief Infrastructure element responsible for PME load balancing
  *
index 2cc3490cdb45beb6031af55121ea796a3c41d235..3528fbd322925910d8ebcd8ca55d4f3da52b04ae 100644 (file)
  * To help us fund GROMACS development, we humbly ask that you cite
  * the research papers on the package. Check out http://www.gromacs.org.
  */
-/*! \libinternal \file
+/*! \internal \file
  * \brief Declares the propagator element for the modular simulator
  *
  * \author Pascal Merz <pascal.merz@me.com>
  * \ingroup module_modularsimulator
+ *
+ * This header is only used within the modular simulator module
  */
 
 #ifndef GMX_MODULARSIMULATOR_PROPAGATOR_H
@@ -105,7 +107,7 @@ typedef std::function<void(Step)> PropagatorCallback;
 //! Pointer to generic callback to the propagator
 typedef std::unique_ptr<PropagatorCallback> PropagatorCallbackPtr;
 
-/*! \libinternal
+/*! \internal
  * \brief Propagator element
  *
  * The propagator element can, through templating, cover the different
index d3fe7db2f15a6722f0f88e2059e02281d8dcb4c4..a77e521ac0f35dc7e2d957df7cec3dd936dc63b9 100644 (file)
  * To help us fund GROMACS development, we humbly ask that you cite
  * the research papers on the package. Check out http://www.gromacs.org.
  */
-/*! \libinternal \file
+/*! \internal \file
  * \brief Declares the signallers for the modular simulator
  *
  * \author Pascal Merz <pascal.merz@me.com>
  * \ingroup module_modularsimulator
+ *
+ * This header is only used within the modular simulator module
  */
 
 #ifndef GMX_MODULARSIMULATOR_SIGNALLERS_H
@@ -53,7 +55,7 @@ namespace gmx
 class StopHandler;
 class TrajectoryElement;
 
-/*! \libinternal
+/*! \internal
  * \ingroup module_modularsimulator
  * \brief Builder for signallers
  *
@@ -90,7 +92,7 @@ private:
     SignallerCallbackPtr getSignallerCallback(typename Signaller::Client* client, Args&&... args);
 };
 
-/*! \libinternal
+/*! \internal
  * \ingroup module_modularsimulator
  * \brief Element signalling a neighbor search step
  *
@@ -138,7 +140,7 @@ private:
     const Time initTime_;
 };
 
-/*! \libinternal
+/*! \internal
  * \ingroup module_modularsimulator
  * \brief Element signalling the last step
  *
@@ -196,7 +198,7 @@ private:
     bool nsStepRegistrationDone_;
 };
 
-/*! \libinternal
+/*! \internal
  * \ingroup module_modularsimulator
  * \brief Element signalling a logging step
  *
@@ -251,7 +253,7 @@ private:
     bool lastStepRegistrationDone_;
 };
 
-/*! \libinternal
+/*! \internal
  * \ingroup module_modularsimulator
  * \brief Element signalling trajectory writing
  *
@@ -327,7 +329,7 @@ private:
     SignallerCallbackPtr registerLastStepCallback() override;
 };
 
-/*! \libinternal
+/*! \internal
  * \ingroup module_modularsimulator
  * \brief Element signalling energy related special steps
  *
index 27e44ce31d42d1c4dcaa7a696a64e40f171096ea..b33fe8ff1bd49ce4e60e9848acfaa445c387a22e 100644 (file)
  * To help us fund GROMACS development, we humbly ask that you cite
  * the research papers on the package. Check out http://www.gromacs.org.
  */
-/*! \libinternal \file
+/*! \internal \file
  * \brief Provides the modular simulator algorithm.
  *
  * Defines the ModularSimulatorAlgorithm class and its builder.
  *
  * \author Pascal Merz <pascal.merz@me.com>
  * \ingroup module_modularsimulator
+ *
+ * This header is only used within the modular simulator module.
+ * Moving forward, the ModularSimulatorAlgorithmBuilder could be exposed to allow users to
+ * create custom algorithm - currently algorithms are only created an used by the ModularSimulator,
+ * meaning that this file is not exposed outside of the modular simulator module.
  */
 #ifndef GROMACS_MODULARSIMULATOR_SIMULATORALGORITHM_H
 #define GROMACS_MODULARSIMULATOR_SIMULATORALGORITHM_H
@@ -65,7 +70,7 @@ class ResetHandler;
 class TopologyHolder;
 class TrajectoryElementBuilder;
 
-/*! \libinternal
+/*! \internal
  * \ingroup module_modularsimulator
  * \brief The modular simulator
  *
@@ -250,7 +255,7 @@ private:
     gmx_walltime_accounting* walltime_accounting;
 };
 
-/*!\libinternal
+/*!\internal
  * \brief Builder for ModularSimulatorAlgorithm objects
  *
  * TODO: The current builder automatically builds a simulator algorithm based on the
index 7b72d4dd8e9855c451b6cc0f1929bc2c60995d02..72848a2b93e57e6aa3e8224af77c2079a95ad8a3 100644 (file)
  * To help us fund GROMACS development, we humbly ask that you cite
  * the research papers on the package. Check out http://www.gromacs.org.
  */
-/*! \libinternal \file
+/*! \internal \file
  * \brief Declares the state for the modular simulator
  *
  * \author Pascal Merz <pascal.merz@me.com>
  * \ingroup module_modularsimulator
+ *
+ * This header is only used within the modular simulator module
  */
 
 #ifndef GMX_MODULARSIMULATOR_STATEPROPAGATORDATA_H
@@ -61,7 +63,7 @@ namespace gmx
 enum class ConstraintVariable;
 class FreeEnergyPerturbationElement;
 
-/*! \libinternal
+/*! \internal
  * \ingroup module_modularsimulator
  * \brief StatePropagatorData and associated data
  *
index 5e3f1171b7b1f946f27bd1d8276e95a2c3557e09..fb3d6044a1ef375766edd87a3563d5f6bafe2b16 100644 (file)
  * To help us fund GROMACS development, we humbly ask that you cite
  * the research papers on the package. Check out http://www.gromacs.org.
  */
-/*! \libinternal \file
+/*! \internal \file
  * \brief Declares the topology class for the modular simulator
  *
  * \author Pascal Merz <pascal.merz@me.com>
  * \ingroup module_modularsimulator
+ *
+ * This header is only used within the modular simulator module
  */
 
 
@@ -59,7 +61,7 @@ class Constraints;
 class MDAtoms;
 class VirtualSitesHandler;
 
-/*! \libinternal
+/*! \internal
  * \ingroup module_modularsimulator
  * \brief Object holding the topology
  *
index afbe2811c1dea5246cfa761f1f9c9551f4f42cb8..754ac888470d9f300effbf3e7f310a4808cc561c 100644 (file)
  * To help us fund GROMACS development, we humbly ask that you cite
  * the research papers on the package. Check out http://www.gromacs.org.
  */
-/*! \libinternal \file
+/*! \internal \file
  * \brief Declares the trajectory element for the modular simulator
  *
  * \author Pascal Merz <pascal.merz@me.com>
  * \ingroup module_modularsimulator
+ *
+ * This header is only used within the modular simulator module
  */
 
 #ifndef GMX_MODULARSIMULATOR_TRAJECTORYELEMENT_H
@@ -62,7 +64,7 @@ struct MdModulesNotifier;
 struct MdrunOptions;
 enum class StartingBehavior;
 
-/*! \libinternal
+/*! \internal
  * \ingroup module_modularsimulator
  * \brief Trajectory element signals and handles trajectory writing
  *
@@ -176,7 +178,7 @@ private:
     void write(Step step, Time time, bool writeState, bool writeEnergy, bool writeLog);
 };
 
-/*! \libinternal
+/*! \internal
  * \ingroup module_modularsimulator
  * \brief Build the `TrajectoryElement`
  *
index 7ae9be1e6493fc3546ad8fe4c99870f758ca860e..49f3c737bfcdb94d80d8da8c1f417c1c6efd1e1f 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,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.
  * To help us fund GROMACS development, we humbly ask that you cite
  * the research papers on the package. Check out http://www.gromacs.org.
  */
-/*! \libinternal \file
+/*! \internal \file
  * \brief Declares the v-rescale thermostat for the modular simulator
  *
  * \author Pascal Merz <pascal.merz@me.com>
  * \ingroup module_modularsimulator
+ *
+ * This header is only used within the modular simulator module
  */
 
 #ifndef GMX_MODULARSIMULATOR_VRESCALETHERMOSTAT_H
@@ -53,7 +55,7 @@ struct t_commrec;
 namespace gmx
 {
 
-/*! \libinternal
+/*! \internal
  * \ingroup module_modularsimulator
  * \brief Element implementing the v-rescale thermostat
  *