Line data Source code
1 : /* +++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++
2 : Copyright (c) 2017-2023 The plumed team
3 : (see the PEOPLE file at the root of the distribution for a list of names)
4 :
5 : See http://www.plumed.org for more information.
6 :
7 : This file is part of plumed, version 2.
8 :
9 : plumed is free software: you can redistribute it and/or modify
10 : it under the terms of the GNU Lesser General Public License as published by
11 : the Free Software Foundation, either version 3 of the License, or
12 : (at your option) any later version.
13 :
14 : plumed 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
17 : GNU Lesser General Public License for more details.
18 :
19 : You should have received a copy of the GNU Lesser General Public License
20 : along with plumed. If not, see <http://www.gnu.org/licenses/>.
21 : +++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++ */
22 : /*
23 :
24 : */
25 : #include "bias/Bias.h"
26 : #include "core/ActionRegister.h"
27 : #include "core/PlumedMain.h"
28 : #include "core/Value.h"
29 : #include "tools/File.h"
30 : #include "tools/Random.h"
31 : #include "tools/Communicator.h"
32 : #include <ctime>
33 :
34 : namespace PLMD {
35 : namespace isdb {
36 :
37 : //+PLUMEDOC ISDB_BIAS RESCALE
38 : /*
39 : Scales the value of an another action, being a Collective Variable or a Bias.
40 :
41 : The rescaling factor is determined by a parameter defined on a logarithmic grid of dimension NBIN in the range
42 : from 1 to MAX_RESCALE. The current value of the rescaling parameter is stored and shared across
43 : other actions using a \ref SELECTOR. A Monte Carlo procedure is used to update the value
44 : of the rescaling factor every MC_STRIDE steps of molecular dynamics. Well-tempered metadynamics, defined by the
45 : parameters W0 and BIASFACTOR, is used to enhance the sampling in the space of the rescaling factor.
46 : The well-tempered metadynamics bias potential is written to the file BFILE every BSTRIDE steps and read
47 : when restarting the simulation using the directive \ref RESTART.
48 :
49 : \note
50 : Additional arguments not to be scaled, one for each bin in the rescaling parameter ladder, can be
51 : provided at the end of the ARG list. The number of such arguments is specified by the option NOT_RESCALED.
52 : These arguments will be not be scaled, but they will be
53 : considered as bias potentials and used in the computation of the Metropolis
54 : acceptance probability when proposing a move in the rescaling parameter. See example below.
55 :
56 : \note
57 : If PLUMED is running in a multiple-replica framework (for example using the -multi option in GROMACS),
58 : the arguments will be summed across replicas, unless the NOT_SHARED option is used. Also, the value of the
59 : \ref SELECTOR will be shared and thus will be the same in all replicas.
60 :
61 : \par Examples
62 :
63 : In this example we use \ref RESCALE to implement a simulated-tempering like approach.
64 : The total potential energy of the system is scaled by a parameter defined on a logarithmic grid
65 : of 5 bins in the range from 1 to 1.5.
66 : A well-tempered metadynamics bias potential is used to ensure diffusion in the space of the rescaling
67 : parameter.
68 :
69 : \plumedfile
70 : ene: ENERGY
71 :
72 : SELECTOR NAME=GAMMA VALUE=0
73 :
74 : RESCALE ...
75 : LABEL=res ARG=ene TEMP=300
76 : SELECTOR=GAMMA MAX_RESCALE=1.5 NBIN=5
77 : W0=1000 BIASFACTOR=100.0 BSTRIDE=2000 BFILE=bias.dat
78 : ...
79 :
80 : PRINT FILE=COLVAR ARG=* STRIDE=100
81 : \endplumedfile
82 :
83 : In this second example, we add to the simulated-tempering approach introduced above
84 : one Parallel Bias metadynamics simulation (see \ref PBMETAD) for each value of the rescaling parameter.
85 : At each moment of the simulation, only one of the \ref PBMETAD
86 : actions is activated, based on the current value of the associated \ref SELECTOR.
87 : The \ref PBMETAD bias potentials are not scaled, but just used in the calculation of
88 : the Metropolis acceptance probability when proposing a move in the rescaling parameter.
89 :
90 : \plumedfile
91 : ene: ENERGY
92 : d: DISTANCE ATOMS=1,2
93 :
94 : SELECTOR NAME=GAMMA VALUE=0
95 :
96 : pbmetad0: PBMETAD ARG=d SELECTOR=GAMMA SELECTOR_ID=0 SIGMA=0.1 PACE=500 HEIGHT=1 BIASFACTOR=8 FILE=HILLS.0
97 : pbmetad1: PBMETAD ARG=d SELECTOR=GAMMA SELECTOR_ID=1 SIGMA=0.1 PACE=500 HEIGHT=1 BIASFACTOR=8 FILE=HILLS.1
98 : pbmetad2: PBMETAD ARG=d SELECTOR=GAMMA SELECTOR_ID=2 SIGMA=0.1 PACE=500 HEIGHT=1 BIASFACTOR=8 FILE=HILLS.2
99 : pbmetad3: PBMETAD ARG=d SELECTOR=GAMMA SELECTOR_ID=3 SIGMA=0.1 PACE=500 HEIGHT=1 BIASFACTOR=8 FILE=HILLS.3
100 : pbmetad4: PBMETAD ARG=d SELECTOR=GAMMA SELECTOR_ID=4 SIGMA=0.1 PACE=500 HEIGHT=1 BIASFACTOR=8 FILE=HILLS.4
101 :
102 : RESCALE ...
103 : LABEL=res TEMP=300
104 : ARG=ene,pbmetad0.bias,pbmetad1.bias,pbmetad2.bias,pbmetad3.bias,pbmetad4.bias
105 : SELECTOR=GAMMA MAX_RESCALE=1.5 NOT_RESCALED=5 NBIN=5
106 : W0=1000 BIASFACTOR=100.0 BSTRIDE=2000 BFILE=bias.dat
107 : ...
108 :
109 : PRINT FILE=COLVAR ARG=* STRIDE=100
110 : \endplumedfile
111 :
112 :
113 :
114 : */
115 : //+ENDPLUMEDOC
116 :
117 : class Rescale : public bias::Bias
118 : {
119 : // gamma parameter
120 : std::vector<double> gamma_;
121 : double w0_;
122 : double biasf_;
123 : std::vector<double> bias_;
124 : std::vector<double> expo_;
125 : std::vector<unsigned> shared_;
126 : unsigned nores_;
127 : // bias
128 : unsigned int Biasstride_;
129 : unsigned int Biaspace_;
130 : std::string Biasfilename_;
131 : bool first_bias_;
132 : OFile Biasfile_;
133 : // temperature in kbt
134 : double kbt_;
135 : // Monte Carlo stuff
136 : unsigned MCsteps_;
137 : unsigned MCstride_;
138 : long long int MCfirst_;
139 : long long unsigned MCaccgamma_;
140 : // replica stuff
141 : unsigned nrep_;
142 : unsigned replica_;
143 : // selector
144 : std::string selector_;
145 :
146 : // Monte Carlo
147 : void doMonteCarlo(unsigned igamma, double oldE, const std::vector<double> & args, const std::vector<double> & bargs);
148 : unsigned proposeMove(unsigned x, unsigned xmin, unsigned xmax);
149 : bool doAccept(double oldE, double newE);
150 : // read and print bias
151 : void read_bias();
152 : void print_bias(long long int step);
153 :
154 : public:
155 : explicit Rescale(const ActionOptions&);
156 : ~Rescale();
157 : void calculate();
158 : static void registerKeywords(Keywords& keys);
159 : };
160 :
161 :
162 : PLUMED_REGISTER_ACTION(Rescale,"RESCALE")
163 :
164 2 : void Rescale::registerKeywords(Keywords& keys) {
165 2 : Bias::registerKeywords(keys);
166 4 : keys.add("compulsory","TEMP","temperature");
167 4 : keys.add("compulsory","SELECTOR", "name of the SELECTOR used for rescaling");
168 4 : keys.add("compulsory","MAX_RESCALE","maximum values for rescaling");
169 4 : keys.add("compulsory","NBIN","number of bins for gamma grid");
170 4 : keys.add("compulsory","W0", "initial bias height");
171 4 : keys.add("compulsory","BIASFACTOR", "bias factor");
172 4 : keys.add("compulsory","BSTRIDE", "stride for writing bias");
173 4 : keys.add("compulsory","BFILE", "file name for bias");
174 4 : keys.add("optional","NOT_SHARED", "list of arguments (from 1 to N) not summed across replicas");
175 4 : keys.add("optional","NOT_RESCALED", "these last N arguments will not be scaled");
176 4 : keys.add("optional","MC_STEPS","number of MC steps");
177 4 : keys.add("optional","MC_STRIDE","MC stride");
178 4 : keys.add("optional","PACE", "Pace for adding bias, in MC stride unit");
179 4 : keys.addOutputComponent("igamma", "default","scalar","gamma parameter");
180 4 : keys.addOutputComponent("accgamma","default","scalar","MC acceptance for gamma");
181 4 : keys.addOutputComponent("wtbias", "default","scalar","well-tempered bias");
182 2 : }
183 :
184 0 : Rescale::Rescale(const ActionOptions&ao):
185 : PLUMED_BIAS_INIT(ao),
186 0 : nores_(0), Biaspace_(1), first_bias_(true),
187 0 : MCsteps_(1), MCstride_(1), MCfirst_(-1), MCaccgamma_(0)
188 : {
189 : // set up replica stuff
190 0 : if(comm.Get_rank()==0) {
191 0 : nrep_ = multi_sim_comm.Get_size();
192 0 : replica_ = multi_sim_comm.Get_rank();
193 : } else {
194 0 : nrep_ = 0;
195 0 : replica_ = 0;
196 : }
197 0 : comm.Sum(&nrep_,1);
198 0 : comm.Sum(&replica_,1);
199 :
200 : // wt-parameters
201 0 : parse("W0", w0_);
202 0 : parse("BIASFACTOR", biasf_);
203 :
204 : // selector name
205 0 : parse("SELECTOR", selector_);
206 :
207 : // number of bins for gamma ladder
208 : unsigned nbin;
209 0 : parse("NBIN", nbin);
210 :
211 : // number of bias
212 0 : parse("NOT_RESCALED", nores_);
213 0 : if(nores_>0 && nores_!=nbin) error("The number of non scaled arguments must be equal to either 0 or the number of bins");
214 :
215 : // maximum value of rescale
216 : std::vector<double> max_rescale;
217 0 : parseVector("MAX_RESCALE", max_rescale);
218 : // check dimension of max_rescale
219 0 : if(max_rescale.size()!=(getNumberOfArguments()-nores_))
220 0 : error("Size of MAX_RESCALE array must be equal to the number of arguments that will to be scaled");
221 :
222 : // calculate exponents
223 0 : double igamma_max = static_cast<double>(nbin);
224 0 : for(unsigned i=0; i<max_rescale.size(); ++i)
225 0 : expo_.push_back(std::log(max_rescale[i])/std::log(igamma_max));
226 :
227 : // allocate gamma grid and set bias to zero
228 0 : for(unsigned i=0; i<nbin; ++i) {
229 : // bias grid
230 0 : bias_.push_back(0.0);
231 : // gamma ladder
232 0 : double gamma = std::exp( static_cast<double>(i) / static_cast<double>(nbin-1) * std::log(igamma_max) );
233 0 : gamma_.push_back(gamma);
234 : }
235 : // print bias to file
236 0 : parse("BSTRIDE", Biasstride_);
237 0 : parse("BFILE", Biasfilename_);
238 :
239 : // create vectors of shared arguments
240 : // by default they are all shared
241 0 : for(unsigned i=0; i<getNumberOfArguments(); ++i) shared_.push_back(1);
242 : // share across replicas or not
243 : std::vector<unsigned> not_shared;
244 0 : parseVector("NOT_SHARED", not_shared);
245 : // and change the non-shared
246 0 : for(unsigned i=0; i<not_shared.size(); ++i) {
247 0 : if((not_shared[i]-1)>=(getNumberOfArguments()-nores_) && nrep_>1)
248 0 : error("NOT_RESCALED args must always be shared when using multiple replicas");
249 0 : if((not_shared[i]-1)>=getNumberOfArguments())
250 0 : error("NOT_SHARED args should be lower than total number of arguments");
251 0 : shared_[not_shared[i]-1] = 0;
252 : }
253 :
254 : // monte carlo stuff
255 0 : parse("MC_STEPS",MCsteps_);
256 0 : parse("MC_STRIDE",MCstride_);
257 : // adjust for multiple-time steps
258 0 : MCstride_ *= getStride();
259 : // read bias deposition pace
260 0 : parse("PACE", Biaspace_);
261 : // multiply by MCstride
262 0 : Biaspace_ *= MCstride_;
263 :
264 : // get temperature
265 0 : kbt_=getkBT();
266 :
267 0 : checkRead();
268 :
269 0 : log.printf(" temperature of the system in energy unit %f\n",kbt_);
270 0 : log.printf(" name of the SELECTOR use for this action %s\n",selector_.c_str());
271 0 : log.printf(" number of bins in grid %u\n",nbin);
272 0 : log.printf(" number of arguments that will not be scaled %u\n",nores_);
273 0 : if(nrep_>1) log<<" number of arguments that will not be summed across replicas "<<not_shared.size()<<"\n";
274 0 : log.printf(" biasfactor %f\n",biasf_);
275 0 : log.printf(" initial hills height %f\n",w0_);
276 0 : log.printf(" stride to write bias to file %u\n",Biasstride_);
277 0 : log.printf(" write bias to file : %s\n",Biasfilename_.c_str());
278 0 : log.printf(" number of replicas %u\n",nrep_);
279 0 : log.printf(" number of MC steps %d\n",MCsteps_);
280 0 : log.printf(" do MC every %d steps\n", MCstride_);
281 0 : log.printf("\n");
282 :
283 0 : log << " Bibliography" << plumed.cite("Bonomi, Camilloni, Bioinformatics, 33, 3999 (2017)") << "\n";
284 :
285 :
286 : // add components
287 0 : addComponent("igamma"); componentIsNotPeriodic("igamma");
288 0 : addComponent("accgamma"); componentIsNotPeriodic("accgamma");
289 0 : addComponent("wtbias"); componentIsNotPeriodic("wtbias");
290 :
291 : // initialize random seed
292 0 : srand (time(NULL));
293 :
294 : // read bias if restarting
295 0 : if(getRestart()) read_bias();
296 0 : }
297 :
298 0 : Rescale::~Rescale()
299 : {
300 0 : Biasfile_.close();
301 0 : }
302 :
303 0 : void Rescale::read_bias()
304 : {
305 : // open file
306 : auto ifile=Tools::make_unique<IFile>();
307 0 : ifile->link(*this);
308 0 : if(ifile->FileExist(Biasfilename_)) {
309 0 : ifile->open(Biasfilename_);
310 : // read all the lines, store last value of bias
311 : double MDtime;
312 0 : while(ifile->scanField("MD_time",MDtime)) {
313 0 : for(unsigned i=0; i<bias_.size(); ++i) {
314 : // convert i to string
315 0 : std::stringstream ss;
316 : ss << i;
317 : // label
318 0 : std::string label = "b" + ss.str();
319 : // read entry
320 0 : ifile->scanField(label, bias_[i]);
321 0 : }
322 : // new line
323 0 : ifile->scanField();
324 : }
325 0 : ifile->close();
326 : } else {
327 0 : error("Cannot find bias file "+Biasfilename_+"\n");
328 : }
329 0 : }
330 :
331 0 : unsigned Rescale::proposeMove(unsigned x, unsigned xmin, unsigned xmax)
332 : {
333 0 : int xmin_i = static_cast<int>(xmin);
334 0 : int xmax_i = static_cast<int>(xmax);
335 : int dx;
336 0 : int r = rand() % 2;
337 0 : if( r % 2 == 0 ) dx = +1;
338 : else dx = -1;
339 : // new index, integer
340 0 : int x_new = static_cast<int>(x) + dx;
341 : // check boundaries
342 0 : if(x_new >= xmax_i) x_new = xmax_i-1;
343 : if(x_new < xmin_i) x_new = xmin_i;
344 0 : return static_cast<unsigned>(x_new);
345 : }
346 :
347 0 : bool Rescale::doAccept(double oldE, double newE)
348 : {
349 : bool accept = false;
350 : // calculate delta energy
351 0 : double delta = ( newE - oldE ) / kbt_;
352 : // if delta is negative always accept move
353 0 : if( delta < 0.0 ) {
354 : accept = true;
355 : } else {
356 : // otherwise extract random number
357 0 : double s = static_cast<double>(rand()) / RAND_MAX;
358 0 : if( s < std::exp(-delta) ) { accept = true; }
359 : }
360 0 : return accept;
361 : }
362 :
363 0 : void Rescale::doMonteCarlo(unsigned igamma, double oldE,
364 : const std::vector<double> & args, const std::vector<double> & bargs)
365 : {
366 : double oldB, newB;
367 :
368 : // cycle on MC steps
369 0 : for(unsigned i=0; i<MCsteps_; ++i) {
370 : // propose move in igamma
371 0 : unsigned new_igamma = proposeMove(igamma, 0, gamma_.size());
372 : // calculate new energy
373 : double newE = 0.0;
374 0 : for(unsigned j=0; j<args.size(); ++j) {
375 : // calculate energy term
376 0 : double fact = 1.0/pow(gamma_[new_igamma], expo_[j]) - 1.0;
377 0 : newE += args[j] * fact;
378 : }
379 : // calculate contributions from non-rescaled terms
380 0 : if(bargs.size()>0) {
381 0 : oldB = bias_[igamma]+bargs[igamma];
382 0 : newB = bias_[new_igamma]+bargs[new_igamma];
383 : } else {
384 0 : oldB = bias_[igamma];
385 0 : newB = bias_[new_igamma];
386 : }
387 : // accept or reject
388 0 : bool accept = doAccept(oldE+oldB, newE+newB);
389 0 : if(accept) {
390 0 : igamma = new_igamma;
391 : oldE = newE;
392 0 : MCaccgamma_++;
393 : }
394 : }
395 : // send values of gamma to all replicas
396 0 : if(comm.Get_rank()==0) {
397 0 : if(multi_sim_comm.Get_rank()!=0) igamma = 0;
398 0 : multi_sim_comm.Sum(&igamma, 1);
399 : } else {
400 0 : igamma = 0;
401 : }
402 : // local communication
403 0 : comm.Sum(&igamma, 1);
404 :
405 : // set the value of gamma into passMap
406 0 : plumed.passMap[selector_]=static_cast<double>(igamma);
407 0 : }
408 :
409 0 : void Rescale::print_bias(long long int step)
410 : {
411 : // if first time open the file
412 0 : if(first_bias_) {
413 0 : first_bias_ = false;
414 0 : Biasfile_.link(*this);
415 0 : Biasfile_.open(Biasfilename_);
416 : Biasfile_.setHeavyFlush();
417 0 : Biasfile_.fmtField("%30.5f");
418 : }
419 :
420 : // write fields
421 0 : double MDtime = static_cast<double>(step)*getTimeStep();
422 0 : Biasfile_.printField("MD_time", MDtime);
423 0 : for(unsigned i=0; i<bias_.size(); ++i) {
424 : // convert i to string
425 0 : std::stringstream ss;
426 : ss << i;
427 : // label
428 0 : std::string label = "b" + ss.str();
429 : // print entry
430 0 : Biasfile_.printField(label, bias_[i]);
431 0 : }
432 0 : Biasfile_.printField();
433 0 : }
434 :
435 0 : void Rescale::calculate()
436 : {
437 : // get the current value of the selector
438 0 : unsigned igamma = static_cast<unsigned>(plumed.passMap[selector_]);
439 :
440 : // collect data from other replicas
441 0 : std::vector<double> all_args(getNumberOfArguments(), 0.0);
442 : // first calculate arguments
443 0 : for(unsigned i=0; i<all_args.size(); ++i) {
444 0 : double arg = getArgument(i);
445 : // sum shared arguments across replicas
446 0 : if(shared_[i]==1) {
447 0 : if(comm.Get_rank()==0) multi_sim_comm.Sum(arg);
448 0 : else arg = 0.0;
449 0 : if(comm.Get_size()>1) comm.Sum(arg);
450 : }
451 : // put into all_args
452 0 : all_args[i] = arg;
453 : }
454 :
455 : // now separate terms that should be rescaled
456 : std::vector<double> args;
457 0 : if(getNumberOfArguments()-nores_>0) args.resize(getNumberOfArguments()-nores_);
458 0 : for(unsigned i=0; i<args.size(); ++i) args[i] = all_args[i];
459 : // and terms that should not
460 : std::vector<double> bargs;
461 0 : if(nores_>0) bargs.resize(nores_);
462 0 : for(unsigned i=0; i<bargs.size(); ++i) bargs[i] = all_args[i+args.size()];
463 :
464 : // calculate energy and forces, only on rescaled terms
465 : double ene = 0.0;
466 0 : for(unsigned i=0; i<args.size(); ++i) {
467 : // calculate energy term
468 0 : double fact = 1.0/pow(gamma_[igamma], expo_[i]) - 1.0;
469 0 : ene += args[i] * fact;
470 : // add force
471 0 : setOutputForce(i, -fact);
472 : }
473 :
474 : // set to zero on the others
475 0 : for(unsigned i=0; i<bargs.size(); ++i) setOutputForce(i+args.size(), 0.0);
476 :
477 : // set value of the bias
478 0 : setBias(ene);
479 : // set value of the wt-bias
480 0 : getPntrToComponent("wtbias")->set(bias_[igamma]);
481 : // set values of gamma
482 0 : getPntrToComponent("igamma")->set(igamma);
483 : // get time step
484 0 : long long int step = getStep();
485 0 : if(MCfirst_==-1) MCfirst_=step;
486 : // calculate gamma acceptance
487 0 : double MCtrials = std::floor(static_cast<double>(step-MCfirst_) / static_cast<double>(MCstride_))+1.0;
488 0 : double accgamma = static_cast<double>(MCaccgamma_) / static_cast<double>(MCsteps_) / MCtrials;
489 0 : getPntrToComponent("accgamma")->set(accgamma);
490 :
491 : // do MC at the right time step
492 0 : if(step%MCstride_==0&&!getExchangeStep()) doMonteCarlo(igamma, ene, args, bargs);
493 :
494 : // add well-tempered like bias
495 0 : if(step%Biaspace_==0) {
496 : // get updated igamma
497 0 : unsigned igamma = static_cast<unsigned>(plumed.passMap[selector_]);
498 : // add "Gaussian"
499 0 : double kbDT = kbt_ * ( biasf_ - 1.0 );
500 0 : bias_[igamma] += w0_ * std::exp(-bias_[igamma] / kbDT);
501 : }
502 :
503 : // print bias
504 0 : if(step%Biasstride_==0) print_bias(step);
505 :
506 0 : }
507 :
508 :
509 : }
510 : }
511 :
|