Add AWH biasing module + tests
[gromacs.git] / src / gromacs / awh / awh.h
blobf074bbbc0d5d16c7e3b1feb3456cfc989e07fc4a
1 /*
2 * This file is part of the GROMACS molecular simulation package.
4 * Copyright (c) 2015,2016,2017, by the GROMACS development team, led by
5 * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
6 * and including many others, as listed in the AUTHORS file in the
7 * top-level source directory and at http://www.gromacs.org.
9 * GROMACS is free software; you can redistribute it and/or
10 * modify it under the terms of the GNU Lesser General Public License
11 * as published by the Free Software Foundation; either version 2.1
12 * of the License, or (at your option) any later version.
14 * GROMACS is distributed in the hope that it will be useful,
15 * but WITHOUT ANY WARRANTY; without even the implied warranty of
16 * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the GNU
17 * Lesser General Public License for more details.
19 * You should have received a copy of the GNU Lesser General Public
20 * License along with GROMACS; if not, see
21 * http://www.gnu.org/licenses, or write to the Free Software Foundation,
22 * Inc., 51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA.
24 * If you want to redistribute modifications to GROMACS, please
25 * consider that scientific software is very special. Version
26 * control is crucial - bugs must be traceable. We will be happy to
27 * consider code for inclusion in the official distribution, but
28 * derived work must not be called official GROMACS. Details are found
29 * in the README & COPYING files - if they are missing, get the
30 * official version at http://www.gromacs.org.
32 * To help us fund GROMACS development, we humbly ask that you cite
33 * the research papers on the package. Check out http://www.gromacs.org.
36 /*! \libinternal
37 * \defgroup module_awh Accelerated weight histogram (AWH) method
38 * \ingroup group_mdrun
39 * \brief
40 * Implements the "accelerated weight histogram" sampling method.
42 * This class provides the interface between the AWH module and
43 * other modules using it. Currently AWH can only act on COM pull
44 * reaction coordinates, but this can easily be extended to other
45 * types of reaction coordinates.
47 * \author Viveca Lindahl
48 * \author Berk Hess <hess@kth.se>
51 /*! \libinternal \file
53 * \brief
54 * Declares the Awh class.
56 * \author Viveca Lindahl
57 * \author Berk Hess <hess@kth.se>
58 * \inlibraryapi
59 * \ingroup module_awh
62 #ifndef GMX_AWH_H
63 #define GMX_AWH_H
65 #include <cstdio>
67 #include <memory>
68 #include <string>
69 #include <vector>
71 #include "gromacs/math/vectypes.h"
72 #include "gromacs/utility/basedefinitions.h"
74 struct gmx_multisim_t;
75 struct gmx_wallcycle;
76 struct pull_work_t;
77 struct pull_t;
78 class t_state;
79 struct t_commrec;
80 struct t_inputrec;
81 struct t_mdatoms;
83 namespace gmx
86 struct AwhHistory;
87 struct AwhParams;
88 class Bias;
89 struct BiasCoupledToSystem;
90 class ForceWithVirial;
92 /*! \libinternal
93 * \brief Coupling of the accelerated weight histogram method (AWH) with the system.
95 * AWH calculates the free energy along order parameters of the system.
96 * Free energy barriers are overcome by adaptively tuning a bias potential along
97 * the order parameter such that the biased distribution along the parameter
98 * converges toward a chosen target distribution.
100 * The Awh class takes care of the coupling between the system and the AWH
101 * bias(es). The Awh class contains one or more BiasCoupledToSystem objects.
102 * The BiasCoupledToSystem class takes care of the reaction coordinate input
103 * and force output for the single Bias object it containts.
105 * \todo Update parameter reading and checkpointing, when general C++ framework is ready.
107 class Awh
109 public:
110 /*! \brief Construct an AWH at the start of a simulation.
112 * AWH will here also register itself with the pull struct as the
113 * potential provider for the pull coordinates given as AWH coordinates
114 * in the user input. This allows AWH to later apply the bias force to
115 * these coordinate in \ref Awh::applyBiasForcesAndUpdateBias.
117 * \param[in,out] fplog General output file, normally md.log, can be nullptr.
118 * \param[in] inputRecord General input parameters (as set up by grompp).
119 * \param[in] commRecord Struct for communication, can be nullptr.
120 * \param[in] awhParams AWH input parameters, consistent with the relevant parts of \p inputRecord (as set up by grompp).
121 * \param[in] biasInitFilename Name of file to read PMF and target from.
122 * \param[in,out] pull_work Pointer to a pull struct which AWH will couple to, has to be initialized, is assumed not to change during the lifetime of the Awh object.
124 Awh(FILE *fplog,
125 const t_inputrec &inputRecord,
126 const t_commrec *commRecord,
127 const AwhParams &awhParams,
128 const std::string &biasInitFilename,
129 pull_t *pull_work);
131 /*! \brief Destructor. */
132 ~Awh();
134 /*! \brief Peform an AWH update, to be called every MD step.
136 * An update has two tasks: apply the bias force and improve
137 * the bias and the free energy estimate that AWH keeps internally.
139 * For the first task, AWH retrieves the pull coordinate values from the pull struct.
140 * With these, the bias potential and forces are calculated.
141 * The bias force together with the atom forces and virial
142 * are passed on to pull which applies the bias force to the atoms.
143 * This is done at every step.
145 * Secondly, coordinate values are regularly sampled and kept by AWH.
146 * Convergence of the bias and free energy estimate is achieved by
147 * updating the AWH bias state after a certain number of samples has been collected.
149 * \note Requires that pull_potential from pull.h has been called first
150 * since AWH needs the current coordinate values (the pull code checks
151 * for this).
153 * \param[in] mdatoms Atom properties.
154 * \param[in] ePBC Type of periodic boundary conditions.
155 * \param[in] box Box vectors.
156 * \param[in,out] forceWithVirial Force and virial buffers, should cover at least the local atoms.
157 * \param[in] t Time.
158 * \param[in] step Time step.
159 * \param[in,out] wallcycle Wallcycle counter, can be nullptr.
160 * \param[in,out] fplog General output file, normally md.log, can be nullptr.
161 * \returns the potential energy for the bias.
163 real applyBiasForcesAndUpdateBias(int ePBC,
164 const t_mdatoms &mdatoms,
165 const matrix box,
166 gmx::ForceWithVirial *forceWithVirial,
167 double t,
168 gmx_int64_t step,
169 gmx_wallcycle *wallcycle,
170 FILE *fplog);
172 /*! \brief
173 * Update the AWH history in preparation for writing to checkpoint file.
175 * Should be called at least on the master rank at checkpoint steps.
177 * Should be called with a valid \p awhHistory (is checked).
179 * \param[in,out] awhHistory AWH history to set.
181 void updateHistory(AwhHistory *awhHistory) const;
183 /*! \brief
184 * Allocate and initialize an AWH history with the given AWH state.
186 * This function should be called at the start of a new simulation
187 * at least on the master rank.
188 * Note that only constant data will be initialized here.
189 * History data is set by \ref Awh::updateHistory.
191 * \returns a shared pointer to the AWH history on the rank that does I/O, nullptr otherwise.
193 std::shared_ptr<AwhHistory> initHistoryFromState() const;
195 /*! \brief Restore the AWH state from the given history.
197 * Should be called on all ranks (for internal MPI broadcast).
198 * Should pass a point to an AwhHistory on the master rank that
199 * is compatible with the AWH setup in this simulation. Will throw
200 * an exception if it is not compatible.
202 * \param[in] awhHistory AWH history to restore from.
204 void restoreStateFromHistory(const AwhHistory *awhHistory);
206 /*! \brief Returns string "AWH" for registering AWH as an external potential provider with the pull module.
208 static const char *externalPotentialString();
210 /*! \brief Register the AWH biased coordinates with pull.
212 * This function is public because it needs to be called by grompp
213 * (and is otherwise only called by Awh()).
214 * Pull requires all external potentials to register themselves
215 * before the end of pre-processing and before the first MD step.
216 * If this has not happened, pull with throw an error.
218 * \param[in] awhParams The AWH parameters.
219 * \param[in,out] pull_work Pull struct which AWH will register the bias into.
221 static void registerAwhWithPull(const AwhParams &awhParams,
222 pull_t *pull_work);
224 private:
225 std::vector<BiasCoupledToSystem> biasCoupledToSystem_; /**< AWH biases and definitions of their coupling to the system. */
226 const gmx_int64_t seed_; /**< Random seed for MC jumping with umbrella type bias potential. */
227 const t_commrec *commRecord_; /**< Pointer to the communication record. */
228 pull_t *pull_; /**< Pointer to the pull working data. */
229 double potentialOffset_; /**< The offset of the bias potential which changes due to bias updates. */
232 } // namespace gmx
234 #endif /* GMX_AWH_H */