PSCF v1.2
rpg/fts/simulator/Simulator.tpp
1#ifndef RPG_SIMULATOR_TPP
2#define RPG_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#include <rpg/System.h>
13#include <rpg/fts/compressor/Compressor.h>
14#include <rpg/fts/compressor/CompressorFactory.h>
15#include <rpg/fts/perturbation/Perturbation.h>
16#include <rpg/fts/perturbation/PerturbationFactory.h>
17#include <rpg/fts/ramp/Ramp.h>
18#include <rpg/fts/ramp/RampFactory.h>
19#include <rpg/fts/VecOpFts.h>
20#include <prdc/cuda/resources.h>
21#include <pscf/math/IntVec.h>
22#include <util/misc/Timer.h>
23#include <util/random/Random.h>
24#include <util/global.h>
25#include <gsl/gsl_eigen.h>
26
27namespace Pscf {
28namespace Rpg {
29
30 using namespace Util;
31
32 /*
33 * Constructor.
34 */
35 template <int D>
37 : random_(),
38 cudaRandom_(),
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_(nullptr),
52 compressorPtr_(nullptr),
53 perturbationFactoryPtr_(nullptr),
54 perturbationPtr_(nullptr),
55 rampFactoryPtr_(nullptr),
56 rampPtr_(nullptr),
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 memory for single eigenvector components of w
123 // after constant shift
124 wcs_.allocate(dimensions);
125
126 // Allocate state_, if necessary.
127 if (!state_.isAllocated) {
128 state_.allocate(nMonomer, dimensions);
129 }
130
131 isAllocated_ = true;
132 }
133
134 /*
135 * Virtual function - this version is only used for testing.
136 */
137 template <int D>
138 void Simulator<D>::readParameters(std::istream &in)
139 {
140 readRandomSeed(in);
141
142 #if 0
143 // Optionally random seed
144 seed_ = 0;
145 readOptional(in, "seed", seed_);
146
147 // Set random number generator seed.
148 // Default value seed_ = 0 uses clock time.
149 random().setSeed(seed_);
150 cudaRandom().setSeed(seed_);
151 #endif
152
153 bool isEnd = false;
154
155 // Read required Compressor block
156 readCompressor(in, isEnd);
157
158 // Optionally read a Perturbation
159 readPerturbation(in, isEnd);
160
161 // Optionally read a Ramp
162 readRamp(in, isEnd);
163 }
164
165 /*
166 * Perform a field theoretic simulation of nStep steps.
167 */
168 template <int D>
170 { UTIL_THROW("Error: Unimplemented function Simulator<D>::simulate"); }
171
172 /*
173 * Open, read and analyze a trajectory file
174 */
175 template <int D>
176 void Simulator<D>::analyze(int min, int max,
177 std::string classname,
178 std::string filename)
179 { UTIL_THROW("Error: Unimplemented function Simulator<D>::analyze"); }
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 // Add average of pressure field wc_[nMonomer-1] to lnQ
237 double sum_xi = Reduce::sum(wc_[nMonomer-1]);
238 lnQ += sum_xi/double(meshSize);
239
240 // lnQ now contains a value per monomer
241
242 // Initialize field contribution HW
243
244 // Compute quadratic field contribution to HW
245 double HW = 0.0;
246 double prefactor, s;
247 int j;
248 for (j = 0; j < nMonomer - 1; ++j) {
249 prefactor = -0.5*double(nMonomer)/chiEvals_[j];
250 // Obtain constant shift
251 s = sc_[j];
252 // Subtract of constant shift s
253 VecOp::subVS(wcs_, wc_[j], s);
254 // Compute quadratic field contribution to HW
255 double wSqure = 0;
256 wSqure = Reduce::innerProduct(wcs_, wcs_);
257 HW += prefactor * wSqure;
258 }
259
260 // Normalize HW to equal a value per monomer
261 HW /= double(meshSize);
262
263 // Add constant term K/2 per monomer (K=s=e^{T}chi e/M^2)
264 HW += 0.5*sc_[nMonomer - 1];
265
266 // Compute number of monomers in the system (nMonomerSystem)
267 const double vSystem = domain.unitCell().volume();
268 const double vMonomer = mixture.vMonomer();
269 const double nMonomerSystem = vSystem / vMonomer;
270
271 // Compute final Hamiltonian components
272 fieldHamiltonian_ = nMonomerSystem * HW;
273 idealHamiltonian_ = -1.0 * nMonomerSystem * lnQ;
274 hamiltonian_ = idealHamiltonian_ + fieldHamiltonian_;
275
276 if (hasPerturbation()) {
277 perturbationHamiltonian_ = perturbation().hamiltonian(hamiltonian_);
278 hamiltonian_ += perturbationHamiltonian_;
279 } else {
280 perturbationHamiltonian_ = 0.0;
281 }
282
283 hasHamiltonian_ = true;
284 }
285
286 template <int D>
288 {
289 UTIL_CHECK(isAllocated_);
290
291 const int nMonomer = system().mixture().nMonomer();
292 DMatrix<double> const & chi = system().interaction().chi();
293 double d = 1.0/double(nMonomer);
294 int i, j, k;
295
296 // Compute orthogonal projection matrix P
298 P.allocate(nMonomer, nMonomer);
299 for (i = 0; i < nMonomer; ++i) {
300 for (j = 0; j < nMonomer; ++j) {
301 P(i,j) = -d;
302 }
303 P(i,i) += 1.0;
304 }
305
306 // Compute T = chi*P (temporary matrix)
308 T.allocate(nMonomer, nMonomer);
309 for (i = 0; i < nMonomer; ++i) {
310 for (j = 0; j < nMonomer; ++j) {
311 T(i, j) = 0.0;
312 for (k = 0; k < nMonomer; ++k) {
313 T(i,j) += chi(i,k)*P(k,j);
314 }
315 }
316 }
317
318 // Compute chiP = = P*chi*P = P*T
319 DMatrix<double> chiP;
320 chiP.allocate(nMonomer, nMonomer);
321 for (i = 0; i < nMonomer; ++i) {
322 for (j = 0; j < nMonomer; ++j) {
323 chiP(i, j) = 0.0;
324 for (k = 0; k < nMonomer; ++k) {
325 chiP(i,j) += P(i,k)*T(k,j);
326 }
327 }
328 }
329
330 // Eigenvalue calculations use data structures and
331 // functions from the Gnu Scientific Library (GSL)
332
333 // Allocate GSL matrix A that will hold a copy of chiP
334 gsl_matrix* A = gsl_matrix_alloc(nMonomer, nMonomer);
335
336 // Copy DMatrix<double> chiP to gsl_matrix A
337 for (i = 0; i < nMonomer; ++i) {
338 for (j = 0; j < nMonomer; ++j) {
339 gsl_matrix_set(A, i, j, chiP(i, j));
340 }
341 }
342
343 // Compute eigenvalues and eigenvectors of chiP (or A)
344 gsl_eigen_symmv_workspace* work = gsl_eigen_symmv_alloc(nMonomer);
345 gsl_vector* Avals = gsl_vector_alloc(nMonomer);
346 gsl_matrix* Avecs = gsl_matrix_alloc(nMonomer, nMonomer);
347 int error;
348 error = gsl_eigen_symmv(A, Avals, Avecs, work);
349 UTIL_CHECK(error == 0);
350
351 // Requirements:
352 // - A has exactly one zero eigenvalue, with eigenvector (1,...,1)
353 // - All other eigenvalues must be negative.
354
355 // Copy eigenpairs with non-null eigenvalues
356 int iNull = -1; // index for null eigenvalue
357 int nNull = 0; // number of null eigenvalue
358 k = 0; // re-ordered index for non-null eigenvalue
359 double val;
360 for (i = 0; i < nMonomer; ++i) {
361 val = gsl_vector_get(Avals, i);
362 if (std::abs(val) < 1.0E-8) {
363 ++nNull;
364 iNull = i;
365 UTIL_CHECK(nNull <= 1);
366 } else {
367 chiEvals_[k] = val;
368 UTIL_CHECK(val < 0.0);
369 for (j = 0; j < nMonomer; ++j) {
370 chiEvecs_(k, j) = gsl_matrix_get(Avecs, j, i);
371 }
372 if (chiEvecs_(k, 0) < 0.0) {
373 for (j = 0; j < nMonomer; ++j) {
374 chiEvecs_(k, j) = -chiEvecs_(k, j);
375 }
376 }
377 ++k;
378 }
379 }
380 UTIL_CHECK(nNull == 1);
381 UTIL_CHECK(iNull >= 0);
382
383 // Set eigenpair with zero eigenvalue
384 i = nMonomer - 1;
385 chiEvals_[i] = 0.0;
386 for (j = 0; j < nMonomer; ++j) {
387 chiEvecs_(i, j) = gsl_matrix_get(Avecs, j, iNull);
388 }
389 if (chiEvecs_(i, 0) < 0) {
390 for (j = 0; j < nMonomer; ++j) {
391 chiEvecs_(i, j) = -chiEvecs_(i, j);
392 }
393 }
394
395 // Normalize all eigenvectors so that the sum of squares = nMonomer
396 double vec, norm, prefactor;
397 for (i = 0; i < nMonomer; ++i) {
398 norm = 0.0;
399 for (j = 0; j < nMonomer; ++j) {
400 vec = chiEvecs_(i, j);
401 norm += vec*vec;
402 }
403 prefactor = sqrt( double(nMonomer)/norm );
404 for (j = 0; j < nMonomer; ++j) {
405 chiEvecs_(i, j) *= prefactor;
406 }
407 }
408
409 // Check final eigenvector is (1, ..., 1)
410 for (j = 0; j < nMonomer; ++j) {
411 UTIL_CHECK(std::abs(chiEvecs_(nMonomer-1, j) - 1.0) < 1.0E-8);
412 }
413
414 // Compute vector s in monomer basis
416 s.allocate(nMonomer);
417 for (i = 0; i < nMonomer; ++i) {
418 s[i] = 0.0;
419 for (j = 0; j < nMonomer; ++j) {
420 s[i] += chi(i,j);
421 }
422 s[i] = s[i]/double(nMonomer);
423 }
424
425 // Compute components of s in eigenvector basis -> sc_
426 for (i = 0; i < nMonomer; ++i) {
427 sc_[i] = 0.0;
428 for (j = 0; j < nMonomer; ++j) {
429 sc_[i] += chiEvecs_(i,j)*s[j];
430 }
431 sc_[i] = sc_[i]/double(nMonomer);
432 }
433
434 #if 0
435 // Debugging output
436 for (i = 0; i < nMonomer; ++i) {
437 Log::file() << "Eigenpair " << i << "\n";
438 Log::file() << "value = " << chiEvals_[i] << "\n";
439 Log::file() << "vector = [ ";
440 for (j = 0; j < nMonomer; ++j) {
441 Log::file() << chiEvecs_(i, j) << " ";
442 }
443 Log::file() << "]\n";
444 Log::file() << " sc[i] = " << sc_[i] << std::endl;
445 }
446 #endif
447
448 }
449
450 /*
451 * Compute the eigenvector components of the w fields, using the
452 * eigenvectors chiEvecs_ of the projected chi matrix as a basis.
453 */
454 template <int D>
456 {
457 UTIL_CHECK(isAllocated_);
458
459 const int nMonomer = system().mixture().nMonomer();
460 int i,j;
461
462 // Loop over eigenvectors (i is an eigenvector index)
463 for (i = 0; i < nMonomer; ++i) {
464
465 // Loop over grid points to zero out field wc_[i]
466 RField<D>& Wc = wc_[i];
467 VecOp::eqS(Wc, 0.0);
468
469 // Loop over monomer types (j is a monomer index)
470 for (j = 0; j < nMonomer; ++j) {
471 cudaReal vec;
472 vec = (cudaReal) chiEvecs_(i, j)/nMonomer;
473
474 // Loop over grid points
475 VecOp::addEqVc(Wc, system().w().rgrid(j), vec);
476 }
477 }
478
479 #if 0
480 // Debugging output
481 std::string filename = "wc";
482 system().fieldIo().writeFieldsRGrid(filename, wc_,
483 system().domain().unitCell());
484 #endif
485
486 hasWc_ = true;
487 }
488
489 /*
490 * Compute the eigenvector components of the c-fields, using the
491 * eigenvectors chiEvecs_ of the projected chi matrix as a basis.
492 */
493 template <int D>
495 {
496 // Preconditions
497 UTIL_CHECK(isAllocated_);
498 UTIL_CHECK(system().w().hasData());
499 UTIL_CHECK(system().hasCFields());
500
501 const int nMonomer = system().mixture().nMonomer();
502 int i, j;
503
504 // Loop over eigenvectors (i is an eigenvector index)
505 for (i = 0; i < nMonomer; ++i) {
506
507 // Set cc_[i] to zero
508 RField<D>& Cc = cc_[i];
509 VecOp::eqS(Cc, 0.0);
510
511 // Loop over monomer types
512 for (j = 0; j < nMonomer; ++j) {
513 cudaReal vec;
514 vec = (cudaReal)chiEvecs_(i, j);
515
516 // Loop over grid points
517 VecOp::addEqVc(Cc, system().c().rgrid(j), vec);
518 }
519 }
520
521 #if 0
522 // Debugging output
523 std::string filename = "cc";
524 system().fieldIo().writeFieldsRGrid(filename, cc_,
525 system().domain().unitCell());
526 #endif
527
528 hasCc_ = true;
529 }
530
531 /*
532 * Compute d fields, i.e., functional derivatives of H[W].
533 */
534 template <int D>
536 {
537 // Preconditions
538 UTIL_CHECK(isAllocated_);
539 if (!hasWc_) computeWc();
540 if (!hasCc_) computeCc();
541
542 // Local constants and variables
543 const int nMonomer = system().mixture().nMonomer();
544 const double vMonomer = system().mixture().vMonomer();
545 const double a = 1.0/vMonomer;
546 double b, s;
547 int i;
548
549 // Loop over composition eigenvectors (exclude the last)
550 for (i = 0; i < nMonomer - 1; ++i) {
551 RField<D>& Dc = dc_[i];
552 RField<D> const & Wc = wc_[i];
553 RField<D> const & Cc = cc_[i];
554 b = -1.0*double(nMonomer)/chiEvals_[i];
555 s = sc_[i];
556
557 // Loop over grid points
558 VecOpFts::computeDField(Dc, Wc, Cc, a, b, s);
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 // Set field components
586 for (int i = 0; i < nMonomer; ++i) {
587 VecOp::eqV(state_.w[i], system().w().rgrid(i));
588 VecOp::eqV(state_.wc[i], wc_[i]);
589 }
590
591 // Save cc based on ccSavePolicy
592 if (state_.needsCc) {
593 UTIL_CHECK(hasCc());
594 for (int i = 0; i < nMonomer; ++i) {
595 VecOp::eqV(state_.cc[i], cc_[i]);
596 }
597 }
598
599 // Save dc based on dcSavePolicy
600 if (state_.needsDc) {
601 UTIL_CHECK(hasDc());
602 for (int i = 0; i < nMonomer - 1; ++i) {
603 VecOp::eqV(state_.dc[i], dc_[i]);
604 }
605 }
606
607 // Save Hamiltonian based on hamiltonianSavePolicy
608 if (state_.needsHamiltonian){
609 UTIL_CHECK(hasHamiltonian());
610 state_.hamiltonian = hamiltonian();
611 state_.idealHamiltonian = idealHamiltonian();
612 state_.fieldHamiltonian = fieldHamiltonian();
613 state_.perturbationHamiltonian = perturbationHamiltonian();
614 }
615
616 if (hasPerturbation()) {
617 perturbation().saveState();
618 }
619
620 state_.hasData = true;
621 }
622
623 /*
624 * Restore a saved fts state.
625 *
626 * Invoked after an attempted Monte-Carlo move is rejected
627 * or an fts move fails to converge
628 */
629 template <int D>
631 {
632 UTIL_CHECK(state_.isAllocated);
633 UTIL_CHECK(state_.hasData);
634 int nMonomer = system().mixture().nMonomer();
635 int meshSize = system().domain().mesh().size();
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 VecOp::eqV(wc_[i], state_.wc[i]);
651 }
652 hasWc_ = true;
653
654 if (state_.needsCc) {
655 for (int i = 0; i < nMonomer; ++i) {
656 VecOp::eqV(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 VecOp::eqV(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 * Output all timer results.
686 */
687 template<int D>
688 void Simulator<D>::outputTimers(std::ostream& out)
689 {
690 outputMdeCounter(out);
691 compressor().outputTimers(out);
692 }
693
694 /*
695 * Output modified diffusion equation (MDE) counter.
696 */
697 template<int D>
698 void Simulator<D>::outputMdeCounter(std::ostream& out)
699 {
700 //out << std::endl;
701 out << "MDE counter "
702 << compressor().mdeCounter() << std::endl;
703 out << std::endl;
704 }
705
706 /*
707 * Clear all timers.
708 */
709 template<int D>
711 {
712 UTIL_CHECK(hasCompressor());
713 compressor().clearTimers();
714 }
715
716 // Protected Functions
717
718 /*
719 * Read random seed and initialize random number generators.
720 */
721 template <int D>
722 void Simulator<D>::readRandomSeed(std::istream &in)
723 {
724 // Optionally random seed
725 seed_ = 0;
726 readOptional(in, "seed", seed_);
727
728 // Set seed values for both random number generators
729 // Default value seed_ = 0 uses clock time.
730 random().setSeed(seed_);
731 cudaRandom().setSeed(seed_);
732 }
733
734 /*
735 * Read the required Compressor parameter file block.
736 */
737 template<int D>
738 void Simulator<D>::readCompressor(std::istream& in, bool& isEnd)
739 {
740 if (!isEnd) {
741 UTIL_CHECK(!hasCompressor());
742 UTIL_CHECK(compressorFactoryPtr_);
743 std::string className;
744 compressorPtr_ =
745 compressorFactory().readObjectOptional(in, *this,
746 className, isEnd);
747 }
748 if (!hasCompressor() && ParamComponent::echo()) {
749 Log::file() << indent() << " Compressor{ [absent] }\n";
750 }
751 }
752
753 // Functions related to an associated Perturbation
754
755 /*
756 * Optionally read a Perturbation parameter file block.
757 */
758 template<int D>
759 void Simulator<D>::readPerturbation(std::istream& in, bool& isEnd)
760 {
761 if (!isEnd) {
762 UTIL_CHECK(!hasPerturbation());
763 UTIL_CHECK(perturbationFactoryPtr_);
764 std::string className;
765 perturbationPtr_ =
766 perturbationFactory().readObjectOptional(in, *this,
767 className, isEnd);
768 }
769 if (!hasPerturbation() && ParamComponent::echo()) {
770 Log::file() << indent() << " Perturbation{ [absent] }\n";
771 }
772 }
773
774 /*
775 * Set the associated Perturbation<D> object.
776 */
777 template<int D>
779 {
780 UTIL_CHECK(ptr != 0);
781 perturbationPtr_ = ptr;
782 }
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) {
791 UTIL_CHECK(!hasRamp());
792 UTIL_CHECK(rampFactoryPtr_);
793 std::string className;
794 rampPtr_ =
795 rampFactory().readObjectOptional(in, *this,
796 className, isEnd);
797 }
798 if (!hasRamp() && ParamComponent::echo()) {
799 Log::file() << indent() << " Ramp{ [absent] }\n";
800 }
801 }
802
803 /*
804 * Set the associated Ramp<D> object.
805 */
806 template<int D>
808 {
809 UTIL_CHECK(ptr != 0);
810 rampPtr_ = ptr;
811 }
812
813}
814}
815#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.
UnitCell< D > & unitCell()
Get UnitCell by reference.
Mesh< D > & mesh()
Get the spatial Mesh 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 a branched polymer species.
Factory for subclasses of Ramp.
Class that varies parameters during a simulation (abstract).
void readRandomSeed(std::istream &in)
Read random seed and initialize random number generators.
virtual void outputTimers(std::ostream &out)
Output timing results.
System< D > & system()
Get parent system by reference.
void computeWc()
Compute eigenvector components of the current w fields.
void readRamp(std::istream &in, bool &isEnd)
Optionally read an associated ramp.
void computeCc()
Compute eigenvector components of the current c fields.
void setPerturbation(Perturbation< D > *ptr)
Set the associated perturbation.
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 allocate()
Allocate required memory.
void saveState()
Save a copy of the fts move state.
void restoreState()
Restore the saved copy of the fts move state.
void readPerturbation(std::istream &in, bool &isEnd)
Optionally read an associated perturbation.
void readCompressor(std::istream &in, bool &isEnd)
Read the compressor block of the parameter file.
virtual void simulate(int nStep)
Perform a field theoretic Monte-Carlo simulation.
virtual void readParameters(std::istream &in)
Read parameters for a simulation.
Simulator(System< D > &system)
Constructor.
void analyzeChi()
Perform eigenvalue analysis of projected chi matrix.
void setRamp(Ramp< D > *ptr)
Set the associated ramp.
void clearState()
Clear the saved copy of the fts state.
virtual void clearTimers()
Clear timers.
virtual void outputMdeCounter(std::ostream &out)
Output MDE counter.
void computeHamiltonian()
Compute the Hamiltonian used in field theoretic simulations.
Solver and descriptor for a solvent species.
Main class for calculations that represent one system.
Definition rpg/System.h:107
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
cudaReal innerProduct(DeviceArray< cudaReal > const &a, DeviceArray< cudaReal > const &b)
Compute inner product of two real arrays (GPU kernel wrapper).
Definition Reduce.cu:891
cudaReal sum(DeviceArray< cudaReal > const &in)
Compute sum of array elements (GPU kernel wrapper).
Definition Reduce.cu:480
void eqV(DeviceArray< cudaReal > &a, DeviceArray< cudaReal > const &b, const int beginIdA, const int beginIdB, const int n)
Vector assignment, a[i] = b[i], kernel wrapper (cudaReal).
Definition VecOp.cu:1020
void subVS(DeviceArray< cudaReal > &a, DeviceArray< cudaReal > const &b, cudaReal const c, const int beginIdA, const int beginIdB, const int n)
Vector subtraction, a[i] = b[i] - c, kernel wrapper (cudaReal).
Definition VecOp.cu:1304
void eqS(DeviceArray< cudaReal > &a, cudaReal const b, const int beginIdA, const int n)
Vector assignment, a[i] = b, kernel wrapper (cudaReal).
Definition VecOp.cu:1054
void addEqVc(DeviceArray< cudaReal > &a, DeviceArray< cudaReal > const &b, cudaReal const c)
Vector addition in-place w/ coefficient, a[i] += b[i] * c, kernel wrapper.
Definition VecOpMisc.cu:343
void computeDField(DeviceArray< cudaReal > &d, DeviceArray< cudaReal > const &Wc, DeviceArray< cudaReal > const &Cc, cudaReal const a, cudaReal const b, cudaReal const s)
Compute d field (functional derivative of H[w])
Definition VecOpFts.cu:112
PSCF package top-level namespace.
Definition param_pc.dox:1
Utility classes for scientific computation.