Line data Source code
1 : /* +++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++
2 : Copyright (c) 2020 of Glen Hocky
3 :
4 : The FISST module is free software: you can redistribute it and/or modify
5 : it under the terms of the GNU Lesser General Public License as published by
6 : the Free Software Foundation, either version 3 of the License, or
7 : (at your option) any later version.
8 :
9 : The FISST module is distributed in the hope that it will be useful,
10 : but WITHOUT ANY WARRANTY; without even the implied warranty of
11 : MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the
12 : GNU Lesser General Public License for more details.
13 :
14 : You should have received a copy of the GNU Lesser General Public License
15 : along with plumed. If not, see <http://www.gnu.org/licenses/>.
16 : +++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++ */
17 : #include "bias/Bias.h"
18 : #include "core/ActionRegister.h"
19 : #include "tools/File.h"
20 : #include "tools/Matrix.h"
21 : #include "tools/Random.h"
22 : #include "legendre_rule_fast.h"
23 :
24 : #include <iostream>
25 :
26 :
27 : using namespace PLMD;
28 : using namespace bias;
29 :
30 : //namespace is lowercase to match
31 : //module names being all lowercase
32 :
33 : namespace PLMD {
34 : namespace fisst {
35 :
36 : //+PLUMEDOC FISSTMOD_BIAS FISST
37 : /*
38 : Compute and apply the optimal linear force on an observable to enhance sampling of conformational distributions over a range of applied forces.
39 :
40 : This method is described in \cite Hartmann-FISST-2019
41 :
42 : If the system's Hamiltonian is given by:
43 : \f[
44 : H(\vec{p},\vec{q}) = \sum_{j} \frac{p_j^2}{2m_j} + U(\vec{q}),
45 : \f]
46 :
47 : This bias modifies the Hamiltonian to be:
48 : \f[
49 : H'(\vec{p},\vec{q}) = H(\vec{p},\vec{q}) - \bar{F} Q
50 : \f]
51 :
52 : where for CV \f$Q\f$, a coupling constant \f${\bar{F}}\f$ is determined
53 : adaptively according to the FISST algorithm.
54 :
55 : Specifically,
56 : \f[
57 : \bar{F}(Q)=\frac{ \int_{F_{min}}^{F_{max}} e^{\beta F Q(\vec{q})} \omega(F) F dF}{\int_{F_{min}}^{F_{max}} e^{\beta F Q(\vec{q})} \omega(F) dF},
58 : \f]
59 :
60 : where \f$\vec{q}\f$ are the molecular coordinates of the system, and \f$w(F)\f$ is a weighting function that is learned on the fly for each force by the FISST algorithm (starting from an initial weight distribution, uniform by default).
61 :
62 : The target for \f$w(F)=1/Z_q(F)\f$, where
63 : \f[
64 : Z_q(F) \equiv \int d\vec{q} e^{-\beta U(\vec{q}) + \beta F Q(\vec{q})}.
65 : \f]
66 :
67 : FISST also computes and writes Observable Weights \f$W_F(\vec{q}_t)\f$ for a molecular configuration at time \f$t\f$, so that averages of other quantities \f$A(\vec{q})\f$ can be reconstructed later at different force values (over a trajectory with \f$T\f$ samples):
68 : \f[
69 : \langle A \rangle_F = \frac{1}{T} \sum_t W_F(\vec{q}_t) A(\vec{q}_t).
70 : \f]
71 :
72 :
73 : \par Examples
74 :
75 : In the following example, an adaptive restraint is learned to bias the distance between two atoms in a system, for a force range of 0-100 pN.
76 :
77 : \plumedfile
78 : UNITS LENGTH=A TIME=fs ENERGY=kcal/mol
79 :
80 : b1: GROUP ATOMS=1
81 : b2: GROUP ATOMS=12
82 :
83 : dend: DISTANCE ATOMS=b1,b2
84 :
85 : #The conversion factor is 69.4786 pN = 1 kcal/mol/Angstrom
86 :
87 : #0 pN to 100 pN
88 : f: FISST MIN_FORCE=0 MAX_FORCE=1.44 PERIOD=100 NINTERPOLATE=31 ARG=dend OUT_RESTART=pull.restart.txt OUT_OBSERVABLE=pull.observable.txt OBSERVABLE_FREQ=1000
89 :
90 : PRINT ARG=dend,f.dend_fbar,f.bias,f.force2 FILE=pull.colvar.txt STRIDE=1000
91 : \endplumedfile
92 :
93 :
94 : */
95 : //+ENDPLUMEDOC
96 :
97 :
98 : class FISST : public Bias {
99 :
100 :
101 : private:
102 : /*We will get this and store it once, since on-the-fly changing number of CVs will be fatal*/
103 : const unsigned int ncvs_;
104 : std::vector<double> center_;
105 : std::vector<double> current_avg_force_;
106 :
107 : std::vector<double> forces_;
108 : std::vector<double> force_weight_;
109 : std::vector<double> gauss_weight_;
110 : std::vector<double> partition_estimate_;
111 : std::vector<double> observable_weight_;
112 :
113 : std::string in_restart_name_;
114 : std::string out_restart_name_;
115 : std::string out_observable_name_;
116 : std::string fmt_;
117 : std::string initial_weight_dist_;
118 : OFile out_restart_;
119 : OFile out_observable_;
120 : IFile in_restart_;
121 : bool b_freeze_;
122 : bool b_adaptive_;
123 : bool b_restart_;
124 : bool b_write_restart_;
125 : bool b_write_observable_;
126 : bool b_first_restart_sample_;
127 : int period_;
128 : int reset_period_;
129 : int observable_freq_;
130 : int n_interpolation_;
131 : int n_samples_;
132 : double kbt_;
133 : double beta_;
134 : //change min_force and max_force to vectors if going to do more than one cv
135 : double max_force_;
136 : double min_force_;
137 : double initial_weight_rate_;
138 : double threshold_;
139 : Random rand_;
140 :
141 :
142 : Value* value_force2_;
143 : void readInRestart();
144 : void NormalizeForceWeights();
145 : /*setup output restart*/
146 : void setupOutRestart();
147 : void setupOutObservable();
148 : /*write output restart*/
149 : void writeOutRestart();
150 : void writeOutObservable();
151 : void update_statistics();
152 : void update_bias();
153 : void apply_bias();
154 : void compute_observable_weight();
155 :
156 : public:
157 : explicit FISST(const ActionOptions&);
158 : void calculate();
159 : void update();
160 : void turnOnDerivatives();
161 : static void registerKeywords(Keywords& keys);
162 : ~FISST();
163 : };
164 :
165 : PLUMED_REGISTER_ACTION(FISST,"FISST")
166 :
167 4 : void FISST::registerKeywords(Keywords& keys) {
168 4 : Bias::registerKeywords(keys);
169 8 : keys.add("compulsory","PERIOD","Steps corresponding to the learning rate");
170 8 : keys.add("optional","RESET_PERIOD","Reset the learning statistics every time this number of steps comes around.");
171 8 : keys.add("compulsory","NINTERPOLATE","Number of grid points on which to do interpolation.");
172 8 : keys.add("compulsory","MIN_FORCE","Minimum force (per CV) to use for sampling. Units: [Energy]/[CV] (can be negative).");
173 8 : keys.add("compulsory","MAX_FORCE","Maximum force (per CV) to use for sampling.");
174 8 : keys.add("compulsory","CENTER","0","The CV value at which the applied bias energy will be zero");
175 8 : keys.add("optional","KBT","The system temperature in units of KB*T. If not provided will be taken from MD code (if available)");
176 :
177 8 : keys.add("optional","INITIAL_WEIGHT_DIST","Starting distribution for the force weights (options: UNIFORM, EXP, GAUSS).");
178 8 : keys.add("optional","INITIAL_WEIGHT_RATE","Rate of decay for exponential and gaussian distributions. W(F)~exp(-r |F|^d).");
179 :
180 8 : keys.add("optional","RESTART_FMT","the format that should be used to output real numbers in FISST restarts.");
181 8 : keys.add("optional","OUT_RESTART","Output file for all information needed to continue FISST simulation."
182 : "If you have the RESTART directive set (global or for FISST), this file will be appended to."
183 : "Note that the header will be printed again if appending.");
184 8 : keys.add("optional","IN_RESTART","Read this file to continue an FISST simulation. "
185 : "If same as OUT_RESTART and you have not set the RESTART directive, the file will be backed-up and overwritten with new output."
186 : "If you do have the RESTART flag set and it is the same name as OUT_RESTART, this file will be appended.");
187 8 : keys.add("optional","OUT_OBSERVABLE","Output file putting weights needed to compute observables at different force values."
188 : "If you have the RESTART directive set (global or for FISST), this file will be appended to. "
189 : "Note that the header will be printed again if appending.");
190 8 : keys.add("optional","OBSERVABLE_FREQ","How often to write out observable weights (default=period).");
191 8 : keys.addFlag("FREEZE",false,"Fix bias weights at current level (only used for restarting).");
192 4 : keys.use("RESTART");
193 8 : keys.addOutputComponent("force2","default","scalar", "squared value of force from the bias.");
194 8 : keys.addOutputComponent("_fbar","default", "scalar", "For each named CV biased, there will be a corresponding output CV_fbar storing the current linear bias prefactor.");
195 4 : }
196 :
197 2 : FISST::FISST(const ActionOptions&ao):
198 : PLUMED_BIAS_INIT(ao),
199 2 : ncvs_(getNumberOfArguments()),
200 0 : current_avg_force_(ncvs_,0.0),
201 2 : center_(ncvs_,0.0),
202 : //change min_force and max_force to vectors if going to do more than one cv
203 2 : min_force_(0.0),
204 2 : max_force_(0.0),
205 2 : in_restart_name_(""),
206 2 : out_restart_name_(""),
207 2 : out_observable_name_(""),
208 2 : fmt_("%e"),
209 2 : b_freeze_(false),
210 2 : b_restart_(false),
211 2 : b_write_restart_(false),
212 2 : b_write_observable_(false),
213 2 : b_first_restart_sample_(true),
214 2 : n_interpolation_(0),
215 2 : n_samples_(0),
216 2 : initial_weight_rate_(0),
217 2 : initial_weight_dist_("UNIFORM"),
218 2 : period_(0),
219 2 : reset_period_(0),
220 2 : observable_freq_(0),
221 2 : kbt_(0.0),
222 6 : value_force2_(NULL)
223 : {
224 2 : if(ncvs_==0)
225 0 : error("Must specify at least one CV with ARG");
226 :
227 : //temporary
228 2 : if(ncvs_>1)
229 0 : error("FISST only supports using one CV right now");
230 :
231 4 : addComponent("force2");
232 2 : componentIsNotPeriodic("force2");
233 2 : value_force2_ = getPntrToComponent("force2");
234 :
235 4 : for(unsigned int i = 0; i<ncvs_; i++) {
236 2 : std::string comp = getPntrToArgument(i)->getName() + "_fbar";
237 2 : addComponent(comp);
238 2 : componentIsNotPeriodic(comp);
239 : }
240 :
241 2 : parseVector("CENTER",center_);
242 : //change min_force and max_force to vectors if going to do more than one cv
243 2 : parse("MIN_FORCE",min_force_);
244 2 : parse("MAX_FORCE",max_force_);
245 2 : parse("PERIOD",period_);
246 2 : parse("RESET_PERIOD",reset_period_);
247 2 : parse("INITIAL_WEIGHT_DIST",initial_weight_dist_);
248 2 : parse("INITIAL_WEIGHT_RATE",initial_weight_rate_);
249 2 : parse("OBSERVABLE_FREQ",observable_freq_);
250 2 : parse("NINTERPOLATE",n_interpolation_);
251 2 : parseFlag("FREEZE",b_freeze_);
252 2 : parse("KBT",kbt_);
253 2 : parse("RESTART_FMT", fmt_);
254 2 : fmt_ = " " + fmt_;//add space since parse strips them
255 2 : parse("OUT_RESTART",out_restart_name_);
256 2 : parse("OUT_OBSERVABLE",out_observable_name_);
257 2 : parse("IN_RESTART",in_restart_name_);
258 2 : checkRead();
259 :
260 2 : if(center_.size() != ncvs_)
261 0 : error("Must have same number of CENTER arguments as ARG arguments");
262 :
263 2 : if(in_restart_name_ != "") {
264 0 : b_restart_ = true;
265 0 : log.printf(" reading simulation information from file: %s\n",in_restart_name_.c_str());
266 0 : readInRestart();
267 : } else {
268 :
269 2 : if(! kbt_ > 0.0) kbt_=getkBT();
270 :
271 : //in driver, this results in kbt of 0
272 2 : if(kbt_ == 0) {
273 0 : error(" Unable to determine valid kBT. "
274 : "Could be because you are runnning from driver or MD didn't give temperature.\n"
275 : "Consider setting temperature manually with the KBT keyword.");
276 : }
277 :
278 2 : log.printf(" kBT = %f\n",kbt_);
279 2 : log.printf(" Updating with a time scale of %i steps\n",period_);
280 :
281 2 : log.printf(" Using centers for CVs of:");
282 4 : for(unsigned int i = 0; i< ncvs_; i++) {
283 2 : log.printf(" %f ",center_[i]);
284 : }
285 2 : log.printf("\n");
286 2 : observable_weight_.resize(n_interpolation_);
287 64 : for(unsigned int i = 0; i<n_interpolation_; i++) observable_weight_[i] = 1.0;
288 :
289 2 : forces_.resize(n_interpolation_);
290 2 : force_weight_.resize(n_interpolation_);
291 : //using code from the MIST project
292 2 : gauss_weight_.resize(n_interpolation_);
293 2 : legendre_compute_glr(n_interpolation_, &forces_[0], &gauss_weight_[0]);
294 2 : rescale(min_force_, max_force_, n_interpolation_, &forces_[0], &gauss_weight_[0]);
295 :
296 2 : log.printf("Using weight distribution %s with rate %f\n",initial_weight_dist_.c_str(),initial_weight_rate_);
297 2 : if(initial_weight_dist_ == "UNIFORM" ) {
298 32 : for(unsigned int i = 0; i<n_interpolation_; i++) force_weight_[i] = 1.0;
299 : }
300 1 : else if (initial_weight_dist_ == "EXP" ) {
301 32 : for(unsigned int i = 0; i<n_interpolation_; i++) force_weight_[i] = exp(-fabs(forces_[i])*initial_weight_rate_);
302 : }
303 0 : else if (initial_weight_dist_ == "GAUSS" ) {
304 0 : for(unsigned int i = 0; i<n_interpolation_; i++) force_weight_[i] = exp(-pow(forces_[i],2)*initial_weight_rate_);
305 : }
306 : else {
307 0 : error(" Specified weight distribution is not from the allowed list.");
308 :
309 : }
310 :
311 2 : partition_estimate_.resize(n_interpolation_);
312 2 : NormalizeForceWeights();
313 : double sum = 0.0;
314 64 : for(unsigned int i = 0; i<n_interpolation_; i++) {
315 : //setting partition estimate as 1/w_i
316 62 : partition_estimate_[i] = 1/force_weight_[i];
317 62 : log.printf("force/gauss weight/force_weight: %i %f %f %f\n",i,forces_[i],gauss_weight_[i],force_weight_[i]);
318 62 : sum+=gauss_weight_[i]*force_weight_[i];
319 : }
320 2 : log.printf("--Sum_i w_i g_i: %f\n",sum);
321 :
322 : }
323 :
324 : //set inverse temperature
325 2 : beta_ = 1/kbt_;
326 :
327 2 : if(b_freeze_ && b_restart_) {
328 0 : log.printf(" freezing weights read in from the restart file\n");
329 : }
330 :
331 2 : if(out_restart_name_.length()>0) {
332 2 : log.printf(" writing restart information every %i steps to file %s with format %s\n",abs(period_),out_restart_name_.c_str(), fmt_.c_str());
333 2 : b_write_restart_ = true;
334 2 : setupOutRestart();
335 : }
336 2 : if(out_observable_name_.length()>0) {
337 2 : if(observable_freq_==0) observable_freq_ = period_;
338 2 : log.printf(" writing observable information every %i steps to file %s with format %s\n",observable_freq_,out_observable_name_.c_str(), fmt_.c_str());
339 2 : b_write_observable_ = true;
340 2 : setupOutObservable();
341 : }
342 :
343 : //add citation later:
344 : //log<<" Bibliography "<<plumed.cite("")<<"\n";
345 2 : }
346 :
347 12 : void FISST::NormalizeForceWeights() {
348 : double denom = 0.0;
349 :
350 384 : for(unsigned i=0; i<n_interpolation_; i++)
351 372 : denom += gauss_weight_[i] * force_weight_[i];
352 :
353 384 : for(unsigned i=0; i<n_interpolation_; i++)
354 372 : force_weight_[i] /= denom;
355 12 : }
356 :
357 0 : void FISST::readInRestart() {
358 0 : in_restart_.open(in_restart_name_);
359 :
360 0 : if(in_restart_.FieldExist("kbt")) {
361 0 : in_restart_.scanField("kbt",kbt_);
362 0 : } else { error("No field 'kbt' in restart file"); }
363 0 : log.printf(" with kBT = %f\n",kbt_);
364 :
365 0 : if(in_restart_.FieldExist("period")) {
366 0 : in_restart_.scanField("period",period_);
367 0 : } else { error("No field 'period' in restart file"); }
368 0 : log.printf(" Updating every %i steps\n",period_);
369 :
370 : //this one can be optional
371 0 : if(in_restart_.FieldExist("reset_period")) {
372 0 : in_restart_.scanField("reset_period",reset_period_);
373 : }
374 0 : log.printf(" Resetting statistics every %i steps\n",reset_period_);
375 :
376 0 : if(in_restart_.FieldExist("n_interpolation")) {
377 0 : in_restart_.scanField("n_interpolation",n_interpolation_);
378 0 : } else { error("No field 'n_interpolation' in restart file"); }
379 :
380 0 : if(in_restart_.FieldExist("min_force")) {
381 0 : in_restart_.scanField("min_force",min_force_);
382 0 : } else { error("No field 'min_force' in restart file"); }
383 0 : if(in_restart_.FieldExist("max_force")) {
384 0 : in_restart_.scanField("max_force",max_force_);
385 0 : } else { error("No field 'max_force' in restart file"); }
386 0 : log.printf(" with forces from min_force=%e to max_force=%e over %i bins\n",min_force_,max_force_,n_interpolation_);
387 :
388 : unsigned int N = 0;
389 : std::string cv_name;
390 : double tmp, time;
391 :
392 0 : while(in_restart_.scanField("time",time)) {
393 0 : in_restart_.scanField("nsamples",n_samples_);
394 :
395 0 : observable_weight_.resize(n_interpolation_);
396 0 : partition_estimate_.resize(n_interpolation_);
397 0 : force_weight_.resize(n_interpolation_);
398 0 : gauss_weight_.resize(n_interpolation_);
399 0 : forces_.resize(n_interpolation_);
400 :
401 0 : for(unsigned int i = 0; i<ncvs_; ++i) {
402 : cv_name = getPntrToArgument(i)->getName();
403 0 : in_restart_.scanField(cv_name,tmp);
404 0 : for(unsigned int j =0; j<n_interpolation_; ++j) {
405 0 : in_restart_.scanField(cv_name + "_f"+std::to_string(j),forces_[j]);
406 0 : in_restart_.scanField(cv_name + "_g"+std::to_string(j),gauss_weight_[j]);
407 0 : in_restart_.scanField(cv_name + "_w"+std::to_string(j),force_weight_[j]);
408 0 : in_restart_.scanField(cv_name + "_z"+std::to_string(j),partition_estimate_[j]);
409 : }
410 : }
411 : N++;
412 :
413 0 : in_restart_.scanField();
414 : }
415 :
416 : double sum = 0.0;
417 0 : for(unsigned int j =0; j<n_interpolation_; ++j) {
418 : //clear observable weight, which will be set later
419 0 : observable_weight_[j] = 1.0;
420 :
421 : //setting partition estimate as 1/w_i
422 0 : log.printf("force/gauss weight/force_weight: %i %e %e %e\n",j,forces_[j],gauss_weight_[j],force_weight_[j]);
423 0 : sum+=gauss_weight_[j]*force_weight_[j];
424 : }
425 0 : log.printf("--Sum_i w_i g_i: %f\n",sum);
426 :
427 0 : in_restart_.close();
428 0 : }
429 :
430 2 : void FISST::setupOutObservable() {
431 2 : out_observable_.link(*this);
432 2 : out_observable_.fmtField(fmt_);
433 2 : out_observable_.open(out_observable_name_);
434 : out_observable_.setHeavyFlush();
435 :
436 4 : out_observable_.addConstantField("kbt").printField("kbt",kbt_);
437 4 : out_observable_.addConstantField("n_interpolation").printField("n_interpolation",n_interpolation_);
438 4 : out_observable_.addConstantField("period").printField("period",period_);
439 4 : out_observable_.addConstantField("min_force").printField("min_force",min_force_);
440 4 : out_observable_.addConstantField("max_force").printField("max_force",max_force_);
441 2 : }
442 :
443 2 : void FISST::setupOutRestart() {
444 2 : out_restart_.link(*this);
445 2 : out_restart_.fmtField(fmt_);
446 2 : out_restart_.open(out_restart_name_);
447 : out_restart_.setHeavyFlush();
448 :
449 4 : out_restart_.addConstantField("kbt").printField("kbt",kbt_);
450 4 : out_restart_.addConstantField("n_interpolation").printField("n_interpolation",n_interpolation_);
451 4 : out_restart_.addConstantField("period").printField("period",period_);
452 2 : if(reset_period_>0) out_restart_.addConstantField("reset_period").printField("reset_period",reset_period_);
453 4 : out_restart_.addConstantField("min_force").printField("min_force",min_force_);
454 4 : out_restart_.addConstantField("max_force").printField("max_force",max_force_);
455 2 : }
456 :
457 10 : void FISST::writeOutRestart() {
458 : std::string cv_name;
459 10 : out_restart_.printField("time",getTimeStep()*getStep());
460 10 : out_restart_.printField("nsamples",n_samples_);
461 :
462 20 : for(unsigned int i = 0; i<ncvs_; ++i) {
463 : cv_name = getPntrToArgument(i)->getName();
464 10 : double Q_i = difference(i, center_[i], getArgument(i));
465 10 : out_restart_.printField(cv_name,Q_i);
466 320 : for(int j = 0; j < n_interpolation_; j++ ) {
467 : //have to update this for multiple cvs
468 620 : out_restart_.printField(cv_name + "_f"+std::to_string(j),forces_[j]);
469 620 : out_restart_.printField(cv_name + "_g"+std::to_string(j),gauss_weight_[j]);
470 620 : out_restart_.printField(cv_name + "_w"+std::to_string(j),force_weight_[j]);
471 620 : out_restart_.printField(cv_name + "_z"+std::to_string(j),partition_estimate_[j]);
472 : }
473 : }
474 10 : out_restart_.printField();
475 10 : }
476 :
477 10 : void FISST::writeOutObservable() {
478 : std::string cv_name;
479 10 : out_observable_.printField("time",getTimeStep()*getStep());
480 10 : out_observable_.printField("nsamples",n_samples_);
481 :
482 20 : for(unsigned int i = 0; i<ncvs_; ++i) {
483 : cv_name = getPntrToArgument(i)->getName();
484 10 : double Q_i = difference(i, center_[i], getArgument(i));
485 10 : out_observable_.printField(cv_name,Q_i);
486 10 : out_observable_.printField(cv_name + "_fbar",current_avg_force_[i]);
487 320 : for(int j = 0; j < n_interpolation_; j++ ) {
488 : //have to update this for multiple cvs
489 620 : out_observable_.printField(cv_name + "_f"+std::to_string(j),forces_[j]);
490 620 : out_observable_.printField(cv_name + "_ow"+std::to_string(j),observable_weight_[j]);
491 : }
492 : }
493 10 : out_observable_.printField();
494 10 : }
495 :
496 :
497 10 : void FISST::calculate() {
498 10 : if(getStep() == 0 ) {
499 2 : if(b_write_restart_) writeOutRestart();
500 2 : if(b_write_observable_) writeOutObservable();
501 : }
502 :
503 10 : if(! b_freeze_) {
504 10 : if(b_restart_ && b_first_restart_sample_) {
505 : //dont' update statistics if restarting and first sample
506 0 : b_first_restart_sample_ = false;
507 : }
508 : else {
509 10 : update_statistics();
510 : }
511 : }
512 10 : update_bias();
513 10 : apply_bias();
514 :
515 : //check about writing restart file
516 10 : if(getStep()>0 && getStep()%period_==0) {
517 8 : if(b_write_restart_) writeOutRestart();
518 : }
519 10 : if(getStep()>0 && getStep()%observable_freq_==0) {
520 8 : if(b_write_observable_) {
521 8 : compute_observable_weight();
522 8 : writeOutObservable();
523 : }
524 : }
525 10 : }
526 :
527 :
528 10 : void FISST::apply_bias() {
529 : //Compute linear force as in "restraint"
530 : double ene = 0, totf2 = 0, cv, m, f;
531 :
532 20 : for(unsigned int i = 0; i < ncvs_; ++i) {
533 10 : cv = difference(i, center_[i], getArgument(i));
534 10 : double fbar = current_avg_force_[i];
535 10 : ene -= fbar*cv;
536 10 : setOutputForce(i,fbar);
537 10 : totf2 += fbar*fbar;
538 :
539 10 : std::string fbar_name_ = getPntrToArgument(i)->getName() + "_fbar";
540 10 : Value* fbar_ = getPntrToComponent(fbar_name_);
541 : fbar_->set(fbar);
542 : };
543 :
544 10 : setBias(ene);
545 10 : value_force2_->set(totf2);
546 : //log.flush();
547 10 : }
548 :
549 10 : void FISST::update_statistics() {
550 : //get stride is for multiple time stepping
551 10 : double dt=getTimeStep()*getStride();
552 10 : double h = dt/(period_*getTimeStep());
553 : double fbar_denum_integral = 0.0;
554 :
555 10 : int step = getStep();
556 10 : if(reset_period_>0 && step>0 && step%reset_period_==0) {
557 0 : n_samples_=1;
558 : }
559 : else {
560 10 : n_samples_++;
561 : }
562 10 : double d_n_samples = (double)n_samples_;
563 :
564 20 : for(unsigned int i = 0; i < ncvs_; ++i) {
565 10 : double Q_i = difference(i, center_[i], getArgument(i));
566 320 : for(unsigned int j=0; j<n_interpolation_; j++)
567 : {
568 : //if multiple cvs, these need to be updated to have 2 columns
569 310 : double f_j = forces_[j];
570 310 : double w_j = force_weight_[j];
571 310 : double g_j = gauss_weight_[j];
572 :
573 310 : fbar_denum_integral += g_j * w_j * exp(beta_*f_j * Q_i);
574 : }
575 :
576 320 : for(unsigned int j=0; j<n_interpolation_; j++)
577 : {
578 310 : double f_j = forces_[j];
579 310 : double sample_weight = exp(beta_*f_j * Q_i) / fbar_denum_integral;
580 :
581 310 : partition_estimate_[j] = sample_weight/d_n_samples + partition_estimate_[j]*(d_n_samples-1)/(d_n_samples);
582 :
583 310 : double w_jn = force_weight_[j];
584 310 : double z_jn = partition_estimate_[j];
585 :
586 310 : double w_jp1 = (1.0 - h) * w_jn + h / z_jn;
587 310 : force_weight_[j] = w_jp1;
588 : }
589 : }
590 :
591 : // make sure that the weights are normalised
592 10 : NormalizeForceWeights();
593 10 : }
594 :
595 :
596 10 : void FISST::update_bias()
597 : {
598 20 : for(unsigned int i = 0; i < ncvs_; ++i) {
599 10 : double Q_i = difference(i, center_[i], getArgument(i));
600 : double fbar_num_integral = 0.0;
601 : double fbar_denum_integral = 0.0;
602 :
603 320 : for(unsigned int j=0; j<n_interpolation_; j++ ) {
604 310 : double f_j = forces_[j];
605 310 : double w_j = force_weight_[j];
606 310 : double g_j = gauss_weight_[j];
607 :
608 310 : fbar_num_integral += g_j * f_j * w_j * exp(beta_*f_j*Q_i);
609 310 : fbar_denum_integral += g_j * w_j * exp(beta_*f_j*Q_i);
610 : }
611 :
612 10 : current_avg_force_[i] = fbar_num_integral/fbar_denum_integral;
613 : }
614 10 : }
615 :
616 8 : void FISST::compute_observable_weight() {
617 8 : double obs_num = (max_force_ - min_force_);
618 :
619 16 : for(unsigned int i = 0; i < ncvs_; ++i) {
620 8 : double Q_i = difference(i, center_[i], getArgument(i));
621 :
622 256 : for(unsigned int j=0; j<n_interpolation_; j++ ) {
623 248 : double z_j = partition_estimate_[j];
624 248 : double f_j = forces_[j];
625 : double denum_integral = 0.0;
626 :
627 7936 : for( unsigned int k=0; k<n_interpolation_; k++ ) {
628 7688 : double f_k = forces_[k];
629 7688 : double w_k = force_weight_[k];
630 7688 : double g_k = gauss_weight_[k];
631 :
632 7688 : denum_integral += g_k * w_k * exp(beta_*(f_k-f_j)*Q_i);
633 : }
634 248 : observable_weight_[j] = obs_num/(denum_integral*z_j);
635 : }
636 : }
637 8 : }
638 :
639 :
640 :
641 10 : void FISST::update() {
642 : //pass
643 10 : }
644 :
645 4 : FISST::~FISST() {
646 2 : out_restart_.close();
647 2 : out_observable_.close();
648 6 : }
649 :
650 0 : void FISST::turnOnDerivatives() {
651 : // do nothing
652 : // this is to avoid errors triggered when a bias is used as a CV
653 : // (This is done in ExtendedLagrangian.cpp)
654 0 : }
655 :
656 :
657 : }
658 : }//close the 2 namespaces
|