PSCF v1.2
rpc/fts/simulator/Simulator.tpp
1#ifndef RPC_SIMULATOR_TPP
2#define RPC_SIMULATOR_TPP
3
4/*
5* PSCF - Polymer Self-Consistent Field Theory
6*
7* Copyright 2016 - 2022, The Regents of the University of Minnesota
8* Distributed under the terms of the GNU General Public License.
9*/
10
11#include "Simulator.h"
12
13#include <rpc/System.h>
14#include <rpc/fts/compressor/Compressor.h>
15#include <rpc/fts/compressor/CompressorFactory.h>
16#include <rpc/fts/perturbation/Perturbation.h>
17#include <rpc/fts/perturbation/PerturbationFactory.h>
18#include <rpc/fts/ramp/Ramp.h>
19#include <rpc/fts/ramp/RampFactory.h>
20
21#include <util/misc/Timer.h>
22#include <util/random/Random.h>
23#include <util/global.h>
24
25// Gnu scientifie library
26#include <gsl/gsl_eigen.h>
27
28namespace Pscf {
29namespace Rpc {
30
31 using namespace Util;
32
33 /*
34 * Constructor.
35 */
36 template <int D>
38 : random_(),
39 hamiltonian_(0.0),
40 idealHamiltonian_(0.0),
41 fieldHamiltonian_(0.0),
42 perturbationHamiltonian_(0.0),
43 iStep_(0),
44 iTotalStep_(0),
45 seed_(0),
46 hasHamiltonian_(false),
47 hasWc_(false),
48 hasCc_(false),
49 hasDc_(false),
50 systemPtr_(&system),
51 compressorFactoryPtr_(0),
52 compressorPtr_(0),
53 perturbationFactoryPtr_(0),
54 perturbationPtr_(0),
55 rampFactoryPtr_(0),
56 rampPtr_(0),
57 isAllocated_(false)
58 {
59 setClassName("Simulator");
60 compressorFactoryPtr_ = new CompressorFactory<D>(system);
61 perturbationFactoryPtr_ = new PerturbationFactory<D>(*this);
62 rampFactoryPtr_ = new RampFactory<D>(*this);
63 }
64
65 /*
66 * Destructor.
67 */
68 template <int D>
70 {
71 if (compressorFactoryPtr_) {
72 delete compressorFactoryPtr_;
73 }
74 if (compressorPtr_ ) {
75 delete compressorPtr_;
76 }
77 if (perturbationFactoryPtr_) {
78 delete perturbationFactoryPtr_;
79 }
80 if (perturbationPtr_) {
81 delete perturbationPtr_;
82 }
83 if (rampFactoryPtr_) {
84 delete rampFactoryPtr_;
85 }
86 if (rampPtr_) {
87 delete rampPtr_;
88 }
89 }
90
91 /*
92 * Allocate required memory.
93 */
94 template <int D>
96 {
97 UTIL_CHECK(!isAllocated_);
98
99 const int nMonomer = system().mixture().nMonomer();
100
101 // Allocate projected chi matrix chiP_ and associated arrays
102 chiP_.allocate(nMonomer, nMonomer);
103 chiEvals_.allocate(nMonomer);
104 chiEvecs_.allocate(nMonomer, nMonomer);
105 sc_.allocate(nMonomer);
106
107 // Allocate memory for eignevector components of w and c fields
108 wc_.allocate(nMonomer);
109 cc_.allocate(nMonomer);
110 const IntVec<D> dimensions = system().domain().mesh().dimensions();
111 for (int i = 0; i < nMonomer; ++i) {
112 wc_[i].allocate(dimensions);
113 cc_[i].allocate(dimensions);
114 }
115
116 // Allocate memory for components of d (functional derivative)
117 dc_.allocate(nMonomer-1);
118 for (int i = 0; i < nMonomer - 1; ++i) {
119 dc_[i].allocate(dimensions);
120 }
121
122 // Allocate state_, if necessary.
123 if (!state_.isAllocated) {
124 const IntVec<D> dimensions = system().domain().mesh().dimensions();
125 state_.allocate(nMonomer, dimensions);
126 }
127
128 isAllocated_ = true;
129 }
130
131 /*
132 * Default implementation - designed to be used by subclasses to read the
133 * initial common part of the parameter file block.
134 */
135 template <int D>
136 void Simulator<D>::readParameters(std::istream &in)
137 {
138 // Optionally read a random number generator seed
139 readRandomSeed(in);
140
141 bool isEnd = false;
142
143 // Read required Compressor block
144 readCompressor(in, isEnd);
145
146 // Optionally read a Perturbation
147 readPerturbation(in, isEnd);
148
149 // Optionally read a Ramp
150 readRamp(in, isEnd);
151 }
152
153 /*
154 * Perform a field theoretic simulation (unimplemented by base class).
155 */
156 template <int D>
158 { UTIL_THROW("Error: Unimplemented function Simulator<D>::simulate"); }
159
160 /*
161 * Open, read and analyze a trajectory file (unimplemented by base class).
162 */
163 template <int D>
164 void Simulator<D>::analyze(int min, int max,
165 std::string classname,
166 std::string filename)
167 { UTIL_THROW("Error: Unimplemented function Simulator<D>::analyze"); }
168
169 /*
170 * Clear all local state data (eigen-components of w and Hamiltonian)
171 */
172 template <int D>
174 {
175 hasHamiltonian_ = false;
176 hasWc_ = false;
177 hasCc_ = false;
178 hasDc_ = false;
179 }
180
181 /*
182 * Compute field theoretic Hamiltonian H[W].
183 */
184 template <int D>
186 {
187 UTIL_CHECK(isAllocated_);
188 UTIL_CHECK(system().w().hasData());
189 UTIL_CHECK(system().hasCFields());
190 UTIL_CHECK(hasWc_);
191 hasHamiltonian_ = false;
192
193 Mixture<D> const & mixture = system().mixture();
194 Domain<D> const & domain = system().domain();
195
196 const int nMonomer = mixture.nMonomer();
197 const int meshSize = domain.mesh().size();
198
199 const int np = mixture.nPolymer();
200 const int ns = mixture.nSolvent();
201 double phi, mu;
202
203 // Compute polymer ideal gas contributions to lnQ
204 double lnQ = 0.0;
205 if (np > 0) {
206 Polymer<D> const * polymerPtr;
207 double length;
208 for (int i = 0; i < np; ++i) {
209 polymerPtr = &mixture.polymer(i);
210 phi = polymerPtr->phi();
211 mu = polymerPtr->mu();
212 length = polymerPtr->length();
213 // Recall: mu = ln(phi/q)
214 if (phi > 1.0E-08) {
215 lnQ += phi*( -mu + 1.0 )/length;
216 }
217 }
218 }
219
220 // Compute solvent ideal gas contributions to lnQ
221 if (ns > 0) {
222 Solvent<D> const * solventPtr;
223 double size;
224 for (int i = 0; i < ns; ++i) {
225 solventPtr = &mixture.solvent(i);
226 phi = solventPtr->phi();
227 mu = solventPtr->mu();
228 size = solventPtr->size();
229 // Recall: mu = ln(phi/q)
230 if (phi > 1.0E-8) {
231 lnQ += phi*( -mu + 1.0 )/size;
232 }
233 }
234 }
235
236 // Subtract average of pressure field wc_[nMonomer-1]
237 RField<D> const & Wc = wc_[nMonomer-1];
238 for (int i = 0; i < meshSize; ++i) {
239 lnQ += Wc[i]/double(meshSize);
240 }
241 // lnQ now contains a value per monomer
242
243 // Initialize field contribution HW
244
245 // Compute quadratic field contribution to HW
246 double HW = 0.0;
247 double prefactor, w, s;
248 int i, j;
249 for (j = 0; j < nMonomer - 1; ++j) {
250 RField<D> const & Wc = wc_[j];
251 prefactor = -0.5*double(nMonomer)/chiEvals_[j];
252 s = sc_[j];
253 for (i = 0; i < meshSize; ++i) {
254 w = Wc[i] - s;
255 HW += prefactor*w*w;
256 }
257 }
258
259 // Normalize HW to equal a value per monomer
260 HW /= double(meshSize);
261
262 // Add constant term K/2 per monomer (K=s=e^{T}chi e/M^2)
263 HW += 0.5*sc_[nMonomer - 1];
264
265 // Compute number of monomers in the system (nMonomerSystem)
266 const double vSystem = domain.unitCell().volume();
267 const double vMonomer = mixture.vMonomer();
268 const double nMonomerSystem = vSystem / vMonomer;
269
270 // Compute final Hamiltonian components
271 fieldHamiltonian_ = nMonomerSystem * HW;
272 idealHamiltonian_ = -1.0 * nMonomerSystem * lnQ;
273 hamiltonian_ = idealHamiltonian_ + fieldHamiltonian_;
274
275 if (hasPerturbation()) {
276 perturbationHamiltonian_ = perturbation().hamiltonian(hamiltonian_);
277 hamiltonian_ += perturbationHamiltonian_;
278 } else {
279 perturbationHamiltonian_ = 0.0;
280 }
281
282 hasHamiltonian_ = true;
283 }
284
285 template <int D>
287 {
288 UTIL_CHECK(isAllocated_);
289
290 const int nMonomer = system().mixture().nMonomer();
291 DMatrix<double> const & chi = system().interaction().chi();
292 double d = 1.0/double(nMonomer);
293 int i, j, k;
294
295 // Compute orthogonal projection matrix P
297 P.allocate(nMonomer, nMonomer);
298 for (i = 0; i < nMonomer; ++i) {
299 for (j = 0; j < nMonomer; ++j) {
300 P(i,j) = -d;
301 }
302 P(i,i) += 1.0;
303 }
304
305 // Compute T = chi*P (temporary matrix)
307 T.allocate(nMonomer, nMonomer);
308 for (i = 0; i < nMonomer; ++i) {
309 for (j = 0; j < nMonomer; ++j) {
310 T(i, j) = 0.0;
311 for (k = 0; k < nMonomer; ++k) {
312 T(i,j) += chi(i,k)*P(k,j);
313 }
314 }
315 }
316
317 // Compute chiP = = P*chi*P = P*T
318 DMatrix<double> chiP;
319 chiP.allocate(nMonomer, nMonomer);
320 for (i = 0; i < nMonomer; ++i) {
321 for (j = 0; j < nMonomer; ++j) {
322 chiP(i, j) = 0.0;
323 for (k = 0; k < nMonomer; ++k) {
324 chiP(i,j) += P(i,k)*T(k,j);
325 }
326 }
327 }
328
329 // Eigenvalue calculations use data structures and
330 // functions from the Gnu Scientific Library (GSL)
331
332 // Allocate GSL matrix A that will hold a copy of chiP
333 gsl_matrix* A = gsl_matrix_alloc(nMonomer, nMonomer);
334
335 // Copy DMatrix<double> chiP to gsl_matrix A
336 for (i = 0; i < nMonomer; ++i) {
337 for (j = 0; j < nMonomer; ++j) {
338 gsl_matrix_set(A, i, j, chiP(i, j));
339 }
340 }
341
342 // Compute eigenvalues and eigenvectors of chiP (or A)
343 gsl_eigen_symmv_workspace* work = gsl_eigen_symmv_alloc(nMonomer);
344 gsl_vector* Avals = gsl_vector_alloc(nMonomer);
345 gsl_matrix* Avecs = gsl_matrix_alloc(nMonomer, nMonomer);
346 int error;
347 error = gsl_eigen_symmv(A, Avals, Avecs, work);
348 UTIL_CHECK(error == 0);
349
350 // Requirements:
351 // - A has exactly one zero eigenvalue, with eigenvector (1,...,1)
352 // - All other eigenvalues must be negative.
353
354 // Copy eigenpairs with non-null eigenvalues
355 int iNull = -1; // index for null eigenvalue
356 int nNull = 0; // number of null eigenvalue
357 k = 0; // re-ordered index for non-null eigenvalue
358 double val;
359 for (i = 0; i < nMonomer; ++i) {
360 val = gsl_vector_get(Avals, i);
361 if (std::abs(val) < 1.0E-8) {
362 ++nNull;
363 iNull = i;
364 UTIL_CHECK(nNull <= 1);
365 } else {
366 chiEvals_[k] = val;
367 UTIL_CHECK(val < 0.0);
368 for (j = 0; j < nMonomer; ++j) {
369 chiEvecs_(k, j) = gsl_matrix_get(Avecs, j, i);
370 }
371 if (chiEvecs_(k, 0) < 0.0) {
372 for (j = 0; j < nMonomer; ++j) {
373 chiEvecs_(k, j) = -chiEvecs_(k, j);
374 }
375 }
376 ++k;
377 }
378 }
379 UTIL_CHECK(nNull == 1);
380 UTIL_CHECK(iNull >= 0);
381
382 // Set eigenpair with zero eigenvalue
383 i = nMonomer - 1;
384 chiEvals_[i] = 0.0;
385 for (j = 0; j < nMonomer; ++j) {
386 chiEvecs_(i, j) = gsl_matrix_get(Avecs, j, iNull);
387 }
388 if (chiEvecs_(i, 0) < 0) {
389 for (j = 0; j < nMonomer; ++j) {
390 chiEvecs_(i, j) = -chiEvecs_(i, j);
391 }
392 }
393
394 // Normalize all eigenvectors so that the sum of squares = nMonomer
395 double vec, norm, prefactor;
396 for (i = 0; i < nMonomer; ++i) {
397 norm = 0.0;
398 for (j = 0; j < nMonomer; ++j) {
399 vec = chiEvecs_(i, j);
400 norm += vec*vec;
401 }
402 prefactor = sqrt( double(nMonomer)/norm );
403 for (j = 0; j < nMonomer; ++j) {
404 chiEvecs_(i, j) *= prefactor;
405 }
406 }
407
408 // Check final eigenvector is (1, ..., 1)
409 for (j = 0; j < nMonomer; ++j) {
410 UTIL_CHECK(std::abs(chiEvecs_(nMonomer-1, j) - 1.0) < 1.0E-8);
411 }
412
413 // Compute vector s in monomer basis
415 s.allocate(nMonomer);
416 for (i = 0; i < nMonomer; ++i) {
417 s[i] = 0.0;
418 for (j = 0; j < nMonomer; ++j) {
419 s[i] += chi(i,j);
420 }
421 s[i] = s[i]/double(nMonomer);
422 }
423
424 // Compute components of s in eigenvector basis -> sc_
425 for (i = 0; i < nMonomer; ++i) {
426 sc_[i] = 0.0;
427 for (j = 0; j < nMonomer; ++j) {
428 sc_[i] += chiEvecs_(i,j)*s[j];
429 }
430 sc_[i] = sc_[i]/double(nMonomer);
431 }
432
433 #if 0
434 // Debugging output
435 for (i = 0; i < nMonomer; ++i) {
436 Log::file() << "Eigenpair " << i << "\n";
437 Log::file() << "value = " << chiEvals_[i] << "\n";
438 Log::file() << "vector = [ ";
439 for (j = 0; j < nMonomer; ++j) {
440 Log::file() << chiEvecs_(i, j) << " ";
441 }
442 Log::file() << "]\n";
443 Log::file() << " sc[i] = " << sc_[i] << std::endl;
444 }
445 #endif
446
447 }
448
449 /*
450 * Compute the eigenvector components of the w fields, using the
451 * eigenvectors chiEvecs_ of the projected chi matrix as a basis.
452 */
453 template <int D>
455 {
456 UTIL_CHECK(isAllocated_);
457
458 const int nMonomer = system().mixture().nMonomer();
459 const int meshSize = system().domain().mesh().size();
460 int i, j, k;
461
462 // Loop over eigenvectors (j is an eigenvector index)
463 for (j = 0; j < nMonomer; ++j) {
464
465 // Loop over grid points to zero out field wc_[j]
466 RField<D>& Wc = wc_[j];
467 for (i = 0; i < meshSize; ++i) {
468 Wc[i] = 0.0;
469 }
470
471 // Loop over monomer types (k is a monomer index)
472 for (k = 0; k < nMonomer; ++k) {
473 double vec = chiEvecs_(j, k)/double(nMonomer);
474
475 // Loop over grid points
476 RField<D> const & Wr = system().w().rgrid(k);
477 for (i = 0; i < meshSize; ++i) {
478 Wc[i] += vec*Wr[i];
479 }
480
481 }
482 }
483
484 hasWc_ = true;
485 }
486
487 /*
488 * Compute the eigenvector components of the c-fields, using the
489 * eigenvectors chiEvecs_ of the projected chi matrix as a basis.
490 */
491 template <int D>
493 {
494 // Preconditions
495 UTIL_CHECK(isAllocated_);
496 UTIL_CHECK(system().w().hasData());
497 UTIL_CHECK(system().hasCFields());
498
499 const int nMonomer = system().mixture().nMonomer();
500 const int meshSize = system().domain().mesh().size();
501 int i, j, k;
502
503 // Loop over eigenvectors (i is an eigenvector index)
504 for (i = 0; i < nMonomer; ++i) {
505
506 // Set cc_[i] to zero
507 RField<D>& Cc = cc_[i];
508 for (k = 0; k < meshSize; ++k) {
509 Cc[k] = 0.0;
510 }
511
512 // Loop over monomer types
513 for (j = 0; j < nMonomer; ++j) {
514 RField<D> const & Cr = system().c().rgrid(j);
515 double vec = chiEvecs_(i, j);
516
517 // Loop over grid points
518 for (k = 0; k < meshSize; ++k) {
519 Cc[k] += vec*Cr[k];
520 }
521
522 }
523 }
524
525 hasCc_ = true;
526 }
527
528 /*
529 * Compute d fields, i.e., functional derivatives of H[W].
530 */
531 template <int D>
533 {
534 // Preconditions
535 UTIL_CHECK(isAllocated_);
536 if (!hasWc_) computeWc();
537 if (!hasCc_) computeCc();
538
539 // Local constants and variables
540 const int meshSize = system().domain().mesh().size();
541 const int nMonomer = system().mixture().nMonomer();
542 const double vMonomer = system().mixture().vMonomer();
543 const double a = 1.0/vMonomer;
544 double b, s;
545 int i, k;
546
547 // Compute derivatives for standard Hamiltonian
548 // Loop over composition eigenvectors (exclude the last)
549 for (i = 0; i < nMonomer - 1; ++i) {
550 RField<D>& Dc = dc_[i];
551 RField<D> const & Wc = wc_[i];
552 RField<D> const & Cc = cc_[i];
553 b = -1.0*double(nMonomer)/chiEvals_[i];
554 s = sc_[i];
555 // Loop over grid points
556 for (k = 0; k < meshSize; ++k) {
557 Dc[k] = a*( b*(Wc[k] - s) + Cc[k] );
558 }
559 }
560
561 // Add derivatives arising from a perturbation (if any).
562 if (hasPerturbation()) {
563 perturbation().incrementDc(dc_);
564 }
565
566 hasDc_ = true;
567 }
568
569 /*
570 * Save the current state prior to a next move.
571 *
572 * Invoked before each move.
573 */
574 template <int D>
576 {
577 UTIL_CHECK(system().w().hasData());
578 UTIL_CHECK(hasWc());
579 UTIL_CHECK(state_.isAllocated);
580 UTIL_CHECK(!state_.hasData);
581
582 // Set fields
583 int nMonomer = system().mixture().nMonomer();
584
585 for (int i = 0; i < nMonomer; ++i) {
586 state_.w[i] = system().w().rgrid(i);
587 state_.wc[i] = wc(i);
588 }
589
590 // Save cc based on ccSavePolicy
591 if (state_.needsCc) {
592 UTIL_CHECK(hasCc());
593 UTIL_CHECK(state_.cc.isAllocated());
594 for (int i = 0; i < nMonomer; ++i) {
595 state_.cc[i] = cc(i);
596 }
597 }
598
599 // Save dc based on dcSavePolicy
600 if (state_.needsDc) {
601 UTIL_CHECK(hasDc());
602 UTIL_CHECK(state_.dc.isAllocated());
603 for (int i = 0; i < nMonomer - 1; ++i) {
604 state_.dc[i] = dc(i);
605 }
606 }
607
608 // Save Hamiltonian based on hamiltonianSavePolicy
609 if (state_.needsHamiltonian){
610 UTIL_CHECK(hasHamiltonian());
611 state_.hamiltonian = hamiltonian();
612 state_.idealHamiltonian = idealHamiltonian();
613 state_.fieldHamiltonian = fieldHamiltonian();
614 state_.perturbationHamiltonian = perturbationHamiltonian();
615 }
616
617 if (hasPerturbation()) {
618 perturbation().saveState();
619 }
620
621 state_.hasData = true;
622 }
623
624 /*
625 * Restore a saved fts state.
626 *
627 * Invoked after an attempted Monte-Carlo move is rejected
628 * or an fts move fails to converge
629 */
630 template <int D>
632 {
633 UTIL_CHECK(state_.isAllocated);
634 UTIL_CHECK(state_.hasData);
635 const int nMonomer = system().mixture().nMonomer();
636
637 // Restore fields
638 system().setWRGrid(state_.w);
639
640 // Restore Hamiltonian and components
641 if (state_.needsHamiltonian){
642 hamiltonian_ = state_.hamiltonian;
643 idealHamiltonian_ = state_.idealHamiltonian;
644 fieldHamiltonian_ = state_.fieldHamiltonian;
645 perturbationHamiltonian_ = state_.perturbationHamiltonian;
646 hasHamiltonian_ = true;
647 }
648
649 for (int i = 0; i < nMonomer; ++i) {
650 wc_[i] = state_.wc[i];
651 }
652 hasWc_ = true;
653
654 if (state_.needsCc) {
655 for (int i = 0; i < nMonomer; ++i) {
656 cc_[i] = state_.cc[i];
657 }
658 hasCc_ = true;
659 }
660
661 if (state_.needsDc) {
662 for (int i = 0; i < nMonomer - 1; ++i) {
663 dc_[i] = state_.dc[i];
664 }
665 hasDc_ = true;
666 }
667
668 if (hasPerturbation()) {
669 perturbation().restoreState();
670 }
671
672 state_.hasData = false;
673 }
674
675 /*
676 * Clear the saved Monte-Carlo state.
677 *
678 * Invoked when an attempted Monte-Carlo move is accepted.
679 */
680 template <int D>
682 { state_.hasData = false; }
683
684
685 /*
686 * Output all timer results.
687 */
688 template<int D>
689 void Simulator<D>::outputTimers(std::ostream& out)
690 {
691 UTIL_CHECK(compressorPtr_);
692 compressor().outputTimers(out);
693 }
694
695 /*
696 * Output modified diffusion equation (MDE) counter.
697 */
698 template<int D>
699 void Simulator<D>::outputMdeCounter(std::ostream& out)
700 {
701 UTIL_CHECK(compressorPtr_);
702 out << "MDE counter "
703 << compressor().mdeCounter() << std::endl;
704 out << std::endl;
705 }
706
707 /*
708 * Clear all timers.
709 */
710 template<int D>
712 {
713 UTIL_CHECK(compressorPtr_);
714 compressor().clearTimers();
715 }
716
717 // Protected Functions
718
719 /*
720 * Optionally read a random number generator seed.
721 */
722 template<int D>
723 void Simulator<D>::readRandomSeed(std::istream& in)
724 {
725 // Optionally read a random number generator seed
726 seed_ = 0;
727 readOptional(in, "seed", seed_);
728
729 // Set random number generator seed
730 // Default value seed_ = 0 uses the clock time.
731 random().setSeed(seed_);
732 }
733
734 /*
735 * Optionally read the Compressor parameter file block.
736 */
737 template<int D>
738 void Simulator<D>::readCompressor(std::istream& in, bool& isEnd)
739 {
740 if (isEnd) return;
741 UTIL_CHECK(compressorFactoryPtr_);
742 UTIL_CHECK(!hasCompressor());
743 std::string className;
744 compressorPtr_ =
745 compressorFactory().readObjectOptional(in, *this,
746 className, isEnd);
747 if (!compressorPtr_ && ParamComponent::echo()) {
748 Log::file() << indent() << " Compressor{ [absent] }\n";
749 }
750 }
751
752 // Functions related to an associated Perturbation
753
754 /*
755 * Optionally read a Perturbation parameter file block.
756 */
757 template<int D>
758 void Simulator<D>::readPerturbation(std::istream& in, bool& isEnd)
759 {
760 if (isEnd) return;
761 UTIL_CHECK(perturbationFactoryPtr_);
762 UTIL_CHECK(!hasPerturbation());
763 std::string className;
764 perturbationPtr_ =
765 perturbationFactory().readObjectOptional(in, *this,
766 className, isEnd);
767 if (!perturbationPtr_ && ParamComponent::echo()) {
768 Log::file() << indent() << " Perturbation{ [absent] }\n";
769 }
770 }
771
772 /*
773 * Set the associated Perturbation<D> object.
774 */
775 template<int D>
777 {
778 UTIL_CHECK(ptr != 0);
779 perturbationPtr_ = ptr;
780 }
781
782 // Functions associated with associated Ramp
783
784 /*
785 * Optionally read a parameter file block for an associated Ramp.
786 */
787 template<int D>
788 void Simulator<D>::readRamp(std::istream& in, bool& isEnd)
789 {
790 if (isEnd) return;
791 UTIL_CHECK(!rampPtr_);
792
793 std::string className;
794 rampPtr_ =
795 rampFactory().readObjectOptional(in, *this, className, isEnd);
796 if (!rampPtr_ && ParamComponent::echo()) {
797 Log::file() << indent() << " Ramp{ [absent] }\n";
798 }
799 }
800
801 /*
802 * Set the associated Ramp<D> object.
803 */
804 template<int D>
806 {
807 UTIL_CHECK(ptr != 0);
808 rampPtr_ = ptr;
809 }
810
811}
812}
813#endif
An IntVec<D, T> is a D-component vector of elements of integer type T.
Definition IntVec.h:27
Polymer & polymer(int id)
Get a polymer object.
int nSolvent() const
Get number of solvent (point particle) species.
double vMonomer() const
Get monomer reference volume (set to 1.0 by default).
int nMonomer() const
Get number of monomer types.
Solvent & solvent(int id)
Set a solvent solver object.
int nPolymer() const
Get number of polymer species.
double length() const
Sum of the lengths of all blocks in the polymer.
Field of real double precision values on an FFT mesh.
Factory for subclasses of Compressor.
Spatial domain and spatial discretization for a periodic structure.
Mesh< D > & mesh()
Get spatial discretization mesh by reference.
UnitCell< D > & unitCell()
Get UnitCell (i.e., lattice type and parameters) by reference.
Solver for a mixture of polymers and solvents.
Factory for subclasses of Perturbation.
Base class for additive perturbations of standard FTS Hamiltonian.
Descriptor and solver for one polymer species.
Factory for subclasses of Ramp.
Class that varies parameters during a simulation (abstract).
Field theoretic simulator (base class).
Definition rpc/System.h:38
void readPerturbation(std::istream &in, bool &isEnd)
Optionally read an associated perturbation.
System< D > & system()
Get parent system by reference.
void computeDc()
Compute functional derivatives of the Hamiltonian.
virtual void analyze(int min, int max, std::string classname, std::string filename)
Read and analyze a trajectory file.
void clearState()
Clear the saved copy of the fts state.
void computeWc()
Compute eigenvector components of the current w fields.
void setPerturbation(Perturbation< D > *ptr)
Set the associated perturbation.
void clearData()
Clear field eigen-components and hamiltonian components.
void analyzeChi()
Perform eigenvalue analysis of projected chi matrix.
virtual void outputTimers(std::ostream &out)
Output timing results.
virtual void outputMdeCounter(std::ostream &out)
Output MDE counter.
virtual void readParameters(std::istream &in)
Read parameters for a simulation.
void allocate()
Allocate required memory.
virtual void simulate(int nStep)
Perform a field theoretic Monte-Carlo simulation.
void setRamp(Ramp< D > *ptr)
Set the associated ramp.
virtual void clearTimers()
Clear timers.
void restoreState()
Restore the saved copy of the fts move state.
void saveState()
Save a copy of the fts move state.
void readRandomSeed(std::istream &in)
Optionally read a random number generator seed.
void readCompressor(std::istream &in, bool &isEnd)
Read the compressor block of the parameter file.
void readRamp(std::istream &in, bool &isEnd)
Optionally read an associated ramp.
void computeHamiltonian()
Compute the Hamiltonian used in PS-FTS.
void computeCc()
Compute eigenvector components of the current c fields.
Solver and descriptor for a solvent species.
Main class for SCFT or PS-FTS simulation of one system.
Definition rpc/System.h:100
double size() const
Get the size (number of monomers) in this solvent.
double phi() const
Get the overall volume fraction for this species.
Definition Species.h:90
double mu() const
Get the chemical potential for this species (units kT=1).
Definition Species.h:96
Dynamically allocatable contiguous array template.
void allocate(int capacity)
Allocate the underlying C array.
Definition DArray.h:199
Dynamically allocated Matrix.
Definition DMatrix.h:25
void allocate(int capacity1, int capacity2)
Allocate memory for a matrix.
Definition DMatrix.h:170
static std::ostream & file()
Get log ostream by reference.
Definition Log.cpp:57
static bool echo()
Get echo parameter.
void setClassName(const char *className)
Set class name string.
File containing preprocessor macros for error handling.
#define UTIL_CHECK(condition)
Assertion macro suitable for serial or parallel production code.
Definition global.h:68
#define UTIL_THROW(msg)
Macro for throwing an Exception, reporting function, file and line number.
Definition global.h:51
PSCF package top-level namespace.
Definition param_pc.dox:1
Utility classes for scientific computation.