1#ifndef RPC_SIMULATOR_TPP
2#define RPC_SIMULATOR_TPP
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>
21#include <util/misc/Timer.h>
22#include <util/random/Random.h>
26#include <gsl/gsl_eigen.h>
40 idealHamiltonian_(0.0),
41 fieldHamiltonian_(0.0),
42 perturbationHamiltonian_(0.0),
46 hasHamiltonian_(false),
51 compressorFactoryPtr_(0),
53 perturbationFactoryPtr_(0),
71 if (compressorFactoryPtr_) {
72 delete compressorFactoryPtr_;
74 if (compressorPtr_ ) {
75 delete compressorPtr_;
77 if (perturbationFactoryPtr_) {
78 delete perturbationFactoryPtr_;
80 if (perturbationPtr_) {
81 delete perturbationPtr_;
83 if (rampFactoryPtr_) {
84 delete rampFactoryPtr_;
99 const int nMonomer = system().mixture().nMonomer();
102 chiP_.allocate(nMonomer, nMonomer);
103 chiEvals_.allocate(nMonomer);
104 chiEvecs_.allocate(nMonomer, nMonomer);
105 sc_.allocate(nMonomer);
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);
117 dc_.allocate(nMonomer-1);
118 for (
int i = 0; i < nMonomer - 1; ++i) {
119 dc_[i].allocate(dimensions);
123 if (!state_.isAllocated) {
124 const IntVec<D> dimensions = system().domain().mesh().dimensions();
125 state_.allocate(nMonomer, dimensions);
144 readCompressor(in, isEnd);
147 readPerturbation(in, isEnd);
158 {
UTIL_THROW(
"Error: Unimplemented function Simulator<D>::simulate"); }
165 std::string classname,
166 std::string filename)
167 {
UTIL_THROW(
"Error: Unimplemented function Simulator<D>::analyze"); }
175 hasHamiltonian_ =
false;
191 hasHamiltonian_ =
false;
193 Mixture<D> const & mixture = system().mixture();
194 Domain<D> const & domain = system().domain();
196 const int nMonomer = mixture.
nMonomer();
197 const int meshSize = domain.
mesh().size();
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();
215 lnQ += phi*( -mu + 1.0 )/length;
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();
231 lnQ += phi*( -mu + 1.0 )/size;
238 for (
int i = 0; i < meshSize; ++i) {
239 lnQ += Wc[i]/double(meshSize);
247 double prefactor, w, s;
249 for (j = 0; j < nMonomer - 1; ++j) {
251 prefactor = -0.5*double(nMonomer)/chiEvals_[j];
253 for (i = 0; i < meshSize; ++i) {
260 HW /= double(meshSize);
263 HW += 0.5*sc_[nMonomer - 1];
266 const double vSystem = domain.
unitCell().volume();
267 const double vMonomer = mixture.
vMonomer();
268 const double nMonomerSystem = vSystem / vMonomer;
271 fieldHamiltonian_ = nMonomerSystem * HW;
272 idealHamiltonian_ = -1.0 * nMonomerSystem * lnQ;
273 hamiltonian_ = idealHamiltonian_ + fieldHamiltonian_;
275 if (hasPerturbation()) {
276 perturbationHamiltonian_ = perturbation().hamiltonian(hamiltonian_);
277 hamiltonian_ += perturbationHamiltonian_;
279 perturbationHamiltonian_ = 0.0;
282 hasHamiltonian_ =
true;
290 const int nMonomer = system().mixture().nMonomer();
292 double d = 1.0/double(nMonomer);
298 for (i = 0; i < nMonomer; ++i) {
299 for (j = 0; j < nMonomer; ++j) {
308 for (i = 0; i < nMonomer; ++i) {
309 for (j = 0; j < nMonomer; ++j) {
311 for (k = 0; k < nMonomer; ++k) {
312 T(i,j) += chi(i,k)*P(k,j);
320 for (i = 0; i < nMonomer; ++i) {
321 for (j = 0; j < nMonomer; ++j) {
323 for (k = 0; k < nMonomer; ++k) {
324 chiP(i,j) += P(i,k)*T(k,j);
333 gsl_matrix* A = gsl_matrix_alloc(nMonomer, nMonomer);
336 for (i = 0; i < nMonomer; ++i) {
337 for (j = 0; j < nMonomer; ++j) {
338 gsl_matrix_set(A, i, j, chiP(i, j));
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);
347 error = gsl_eigen_symmv(A, Avals, Avecs, work);
359 for (i = 0; i < nMonomer; ++i) {
360 val = gsl_vector_get(Avals, i);
361 if (std::abs(val) < 1.0E-8) {
368 for (j = 0; j < nMonomer; ++j) {
369 chiEvecs_(k, j) = gsl_matrix_get(Avecs, j, i);
371 if (chiEvecs_(k, 0) < 0.0) {
372 for (j = 0; j < nMonomer; ++j) {
373 chiEvecs_(k, j) = -chiEvecs_(k, j);
385 for (j = 0; j < nMonomer; ++j) {
386 chiEvecs_(i, j) = gsl_matrix_get(Avecs, j, iNull);
388 if (chiEvecs_(i, 0) < 0) {
389 for (j = 0; j < nMonomer; ++j) {
390 chiEvecs_(i, j) = -chiEvecs_(i, j);
395 double vec, norm, prefactor;
396 for (i = 0; i < nMonomer; ++i) {
398 for (j = 0; j < nMonomer; ++j) {
399 vec = chiEvecs_(i, j);
402 prefactor = sqrt(
double(nMonomer)/norm );
403 for (j = 0; j < nMonomer; ++j) {
404 chiEvecs_(i, j) *= prefactor;
409 for (j = 0; j < nMonomer; ++j) {
410 UTIL_CHECK(std::abs(chiEvecs_(nMonomer-1, j) - 1.0) < 1.0E-8);
416 for (i = 0; i < nMonomer; ++i) {
418 for (j = 0; j < nMonomer; ++j) {
421 s[i] = s[i]/double(nMonomer);
425 for (i = 0; i < nMonomer; ++i) {
427 for (j = 0; j < nMonomer; ++j) {
428 sc_[i] += chiEvecs_(i,j)*s[j];
430 sc_[i] = sc_[i]/double(nMonomer);
435 for (i = 0; i < nMonomer; ++i) {
436 Log::file() <<
"Eigenpair " << i <<
"\n";
437 Log::file() <<
"value = " << chiEvals_[i] <<
"\n";
439 for (j = 0; j < nMonomer; ++j) {
443 Log::file() <<
" sc[i] = " << sc_[i] << std::endl;
458 const int nMonomer = system().mixture().nMonomer();
459 const int meshSize = system().domain().mesh().size();
463 for (j = 0; j < nMonomer; ++j) {
467 for (i = 0; i < meshSize; ++i) {
472 for (k = 0; k < nMonomer; ++k) {
473 double vec = chiEvecs_(j, k)/double(nMonomer);
476 RField<D> const & Wr = system().w().rgrid(k);
477 for (i = 0; i < meshSize; ++i) {
499 const int nMonomer = system().mixture().nMonomer();
500 const int meshSize = system().domain().mesh().size();
504 for (i = 0; i < nMonomer; ++i) {
508 for (k = 0; k < meshSize; ++k) {
513 for (j = 0; j < nMonomer; ++j) {
514 RField<D> const & Cr = system().c().rgrid(j);
515 double vec = chiEvecs_(i, j);
518 for (k = 0; k < meshSize; ++k) {
536 if (!hasWc_) computeWc();
537 if (!hasCc_) computeCc();
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;
549 for (i = 0; i < nMonomer - 1; ++i) {
553 b = -1.0*double(nMonomer)/chiEvals_[i];
556 for (k = 0; k < meshSize; ++k) {
557 Dc[k] = a*( b*(Wc[k] - s) + Cc[k] );
562 if (hasPerturbation()) {
563 perturbation().incrementDc(dc_);
583 int nMonomer = system().mixture().nMonomer();
585 for (
int i = 0; i < nMonomer; ++i) {
586 state_.w[i] = system().w().rgrid(i);
587 state_.wc[i] = wc(i);
591 if (state_.needsCc) {
594 for (
int i = 0; i < nMonomer; ++i) {
595 state_.cc[i] = cc(i);
600 if (state_.needsDc) {
603 for (
int i = 0; i < nMonomer - 1; ++i) {
604 state_.dc[i] = dc(i);
609 if (state_.needsHamiltonian){
611 state_.hamiltonian = hamiltonian();
612 state_.idealHamiltonian = idealHamiltonian();
613 state_.fieldHamiltonian = fieldHamiltonian();
614 state_.perturbationHamiltonian = perturbationHamiltonian();
617 if (hasPerturbation()) {
618 perturbation().saveState();
621 state_.hasData =
true;
635 const int nMonomer = system().mixture().nMonomer();
638 system().setWRGrid(state_.w);
641 if (state_.needsHamiltonian){
642 hamiltonian_ = state_.hamiltonian;
643 idealHamiltonian_ = state_.idealHamiltonian;
644 fieldHamiltonian_ = state_.fieldHamiltonian;
645 perturbationHamiltonian_ = state_.perturbationHamiltonian;
646 hasHamiltonian_ =
true;
649 for (
int i = 0; i < nMonomer; ++i) {
650 wc_[i] = state_.wc[i];
654 if (state_.needsCc) {
655 for (
int i = 0; i < nMonomer; ++i) {
656 cc_[i] = state_.cc[i];
661 if (state_.needsDc) {
662 for (
int i = 0; i < nMonomer - 1; ++i) {
663 dc_[i] = state_.dc[i];
668 if (hasPerturbation()) {
669 perturbation().restoreState();
672 state_.hasData =
false;
682 { state_.hasData =
false; }
692 compressor().outputTimers(out);
702 out <<
"MDE counter "
703 << compressor().mdeCounter() << std::endl;
714 compressor().clearTimers();
727 readOptional(in,
"seed", seed_);
731 random().setSeed(seed_);
743 std::string className;
745 compressorFactory().readObjectOptional(in, *
this,
748 Log::file() << indent() <<
" Compressor{ [absent] }\n";
763 std::string className;
765 perturbationFactory().readObjectOptional(in, *
this,
768 Log::file() << indent() <<
" Perturbation{ [absent] }\n";
779 perturbationPtr_ = ptr;
793 std::string className;
795 rampFactory().readObjectOptional(in, *
this, className, isEnd);
797 Log::file() << indent() <<
" Ramp{ [absent] }\n";
An IntVec<D, T> is a D-component vector of elements of integer type T.
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).
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.
double size() const
Get the size (number of monomers) in this solvent.
double phi() const
Get the overall volume fraction for this species.
double mu() const
Get the chemical potential for this species (units kT=1).
Dynamically allocatable contiguous array template.
void allocate(int capacity)
Allocate the underlying C array.
Dynamically allocated Matrix.
void allocate(int capacity1, int capacity2)
Allocate memory for a matrix.
static std::ostream & file()
Get log ostream by reference.
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.
#define UTIL_THROW(msg)
Macro for throwing an Exception, reporting function, file and line number.
PSCF package top-level namespace.
Utility classes for scientific computation.