1#ifndef RPG_SIMULATOR_TPP
2#define RPG_SIMULATOR_TPP
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>
25#include <gsl/gsl_eigen.h>
40 idealHamiltonian_(0.0),
41 fieldHamiltonian_(0.0),
42 perturbationHamiltonian_(0.0),
46 hasHamiltonian_(false),
51 compressorFactoryPtr_(nullptr),
52 compressorPtr_(nullptr),
53 perturbationFactoryPtr_(nullptr),
54 perturbationPtr_(nullptr),
55 rampFactoryPtr_(nullptr),
71 if (compressorFactoryPtr_) {
72 delete compressorFactoryPtr_;
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);
124 wcs_.allocate(dimensions);
127 if (!state_.isAllocated) {
128 state_.allocate(nMonomer, dimensions);
145 readOptional(in,
"seed", seed_);
149 random().setSeed(seed_);
150 cudaRandom().setSeed(seed_);
156 readCompressor(in, isEnd);
159 readPerturbation(in, isEnd);
170 {
UTIL_THROW(
"Error: Unimplemented function Simulator<D>::simulate"); }
177 std::string classname,
178 std::string filename)
179 {
UTIL_THROW(
"Error: Unimplemented function Simulator<D>::analyze"); }
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 lnQ += sum_xi/double(meshSize);
248 for (j = 0; j < nMonomer - 1; ++j) {
249 prefactor = -0.5*double(nMonomer)/chiEvals_[j];
257 HW += prefactor * wSqure;
261 HW /= double(meshSize);
264 HW += 0.5*sc_[nMonomer - 1];
267 const double vSystem = domain.
unitCell().volume();
268 const double vMonomer = mixture.
vMonomer();
269 const double nMonomerSystem = vSystem / vMonomer;
272 fieldHamiltonian_ = nMonomerSystem * HW;
273 idealHamiltonian_ = -1.0 * nMonomerSystem * lnQ;
274 hamiltonian_ = idealHamiltonian_ + fieldHamiltonian_;
276 if (hasPerturbation()) {
277 perturbationHamiltonian_ = perturbation().hamiltonian(hamiltonian_);
278 hamiltonian_ += perturbationHamiltonian_;
280 perturbationHamiltonian_ = 0.0;
283 hasHamiltonian_ =
true;
291 const int nMonomer = system().mixture().nMonomer();
293 double d = 1.0/double(nMonomer);
299 for (i = 0; i < nMonomer; ++i) {
300 for (j = 0; j < nMonomer; ++j) {
309 for (i = 0; i < nMonomer; ++i) {
310 for (j = 0; j < nMonomer; ++j) {
312 for (k = 0; k < nMonomer; ++k) {
313 T(i,j) += chi(i,k)*P(k,j);
321 for (i = 0; i < nMonomer; ++i) {
322 for (j = 0; j < nMonomer; ++j) {
324 for (k = 0; k < nMonomer; ++k) {
325 chiP(i,j) += P(i,k)*T(k,j);
334 gsl_matrix* A = gsl_matrix_alloc(nMonomer, nMonomer);
337 for (i = 0; i < nMonomer; ++i) {
338 for (j = 0; j < nMonomer; ++j) {
339 gsl_matrix_set(A, i, j, chiP(i, j));
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);
348 error = gsl_eigen_symmv(A, Avals, Avecs, work);
360 for (i = 0; i < nMonomer; ++i) {
361 val = gsl_vector_get(Avals, i);
362 if (std::abs(val) < 1.0E-8) {
369 for (j = 0; j < nMonomer; ++j) {
370 chiEvecs_(k, j) = gsl_matrix_get(Avecs, j, i);
372 if (chiEvecs_(k, 0) < 0.0) {
373 for (j = 0; j < nMonomer; ++j) {
374 chiEvecs_(k, j) = -chiEvecs_(k, j);
386 for (j = 0; j < nMonomer; ++j) {
387 chiEvecs_(i, j) = gsl_matrix_get(Avecs, j, iNull);
389 if (chiEvecs_(i, 0) < 0) {
390 for (j = 0; j < nMonomer; ++j) {
391 chiEvecs_(i, j) = -chiEvecs_(i, j);
396 double vec, norm, prefactor;
397 for (i = 0; i < nMonomer; ++i) {
399 for (j = 0; j < nMonomer; ++j) {
400 vec = chiEvecs_(i, j);
403 prefactor = sqrt(
double(nMonomer)/norm );
404 for (j = 0; j < nMonomer; ++j) {
405 chiEvecs_(i, j) *= prefactor;
410 for (j = 0; j < nMonomer; ++j) {
411 UTIL_CHECK(std::abs(chiEvecs_(nMonomer-1, j) - 1.0) < 1.0E-8);
417 for (i = 0; i < nMonomer; ++i) {
419 for (j = 0; j < nMonomer; ++j) {
422 s[i] = s[i]/double(nMonomer);
426 for (i = 0; i < nMonomer; ++i) {
428 for (j = 0; j < nMonomer; ++j) {
429 sc_[i] += chiEvecs_(i,j)*s[j];
431 sc_[i] = sc_[i]/double(nMonomer);
436 for (i = 0; i < nMonomer; ++i) {
437 Log::file() <<
"Eigenpair " << i <<
"\n";
438 Log::file() <<
"value = " << chiEvals_[i] <<
"\n";
440 for (j = 0; j < nMonomer; ++j) {
444 Log::file() <<
" sc[i] = " << sc_[i] << std::endl;
459 const int nMonomer = system().mixture().nMonomer();
463 for (i = 0; i < nMonomer; ++i) {
470 for (j = 0; j < nMonomer; ++j) {
472 vec = (cudaReal) chiEvecs_(i, j)/nMonomer;
481 std::string filename =
"wc";
482 system().fieldIo().writeFieldsRGrid(filename, wc_,
483 system().domain().unitCell());
501 const int nMonomer = system().mixture().nMonomer();
505 for (i = 0; i < nMonomer; ++i) {
512 for (j = 0; j < nMonomer; ++j) {
514 vec = (cudaReal)chiEvecs_(i, j);
523 std::string filename =
"cc";
524 system().fieldIo().writeFieldsRGrid(filename, cc_,
525 system().domain().unitCell());
539 if (!hasWc_) computeWc();
540 if (!hasCc_) computeCc();
543 const int nMonomer = system().mixture().nMonomer();
544 const double vMonomer = system().mixture().vMonomer();
545 const double a = 1.0/vMonomer;
550 for (i = 0; i < nMonomer - 1; ++i) {
554 b = -1.0*double(nMonomer)/chiEvals_[i];
562 if (hasPerturbation()) {
563 perturbation().incrementDc(dc_);
583 int nMonomer = system().mixture().nMonomer();
586 for (
int i = 0; i < nMonomer; ++i) {
587 VecOp::eqV(state_.w[i], system().w().rgrid(i));
592 if (state_.needsCc) {
594 for (
int i = 0; i < nMonomer; ++i) {
600 if (state_.needsDc) {
602 for (
int i = 0; i < nMonomer - 1; ++i) {
608 if (state_.needsHamiltonian){
610 state_.hamiltonian = hamiltonian();
611 state_.idealHamiltonian = idealHamiltonian();
612 state_.fieldHamiltonian = fieldHamiltonian();
613 state_.perturbationHamiltonian = perturbationHamiltonian();
616 if (hasPerturbation()) {
617 perturbation().saveState();
620 state_.hasData =
true;
634 int nMonomer = system().mixture().nMonomer();
635 int meshSize = system().domain().mesh().size();
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) {
654 if (state_.needsCc) {
655 for (
int i = 0; i < nMonomer; ++i) {
661 if (state_.needsDc) {
662 for (
int i = 0; i < nMonomer - 1; ++i) {
668 if (hasPerturbation()) {
669 perturbation().restoreState();
672 state_.hasData =
false;
682 { state_.hasData =
false; }
690 outputMdeCounter(out);
691 compressor().outputTimers(out);
701 out <<
"MDE counter "
702 << compressor().mdeCounter() << std::endl;
713 compressor().clearTimers();
726 readOptional(in,
"seed", seed_);
730 random().setSeed(seed_);
731 cudaRandom().setSeed(seed_);
743 std::string className;
745 compressorFactory().readObjectOptional(in, *
this,
749 Log::file() << indent() <<
" Compressor{ [absent] }\n";
764 std::string className;
766 perturbationFactory().readObjectOptional(in, *
this,
770 Log::file() << indent() <<
" Perturbation{ [absent] }\n";
781 perturbationPtr_ = ptr;
793 std::string className;
795 rampFactory().readObjectOptional(in, *
this,
799 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.
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.
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.
cudaReal innerProduct(DeviceArray< cudaReal > const &a, DeviceArray< cudaReal > const &b)
Compute inner product of two real arrays (GPU kernel wrapper).
cudaReal sum(DeviceArray< cudaReal > const &in)
Compute sum of array elements (GPU kernel wrapper).
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).
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).
void eqS(DeviceArray< cudaReal > &a, cudaReal const b, const int beginIdA, const int n)
Vector assignment, a[i] = b, kernel wrapper (cudaReal).
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.
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])
PSCF package top-level namespace.
Utility classes for scientific computation.