9#include <pscf/inter/Interaction.h>
10#include <pscf/math/LuSolver.h>
14namespace Homogeneous {
39 hasComposition_(false)
65 molecules_.allocate(nMolecule_);
68 for (
int i = 0; i < nMolecule_; ++i) {
79 molecules_.allocate(nMolecule_);
102 for (
int i = 0; i < nMolecule_ - 1; ++i) {
109 phi_[nMolecule_ -1] = 1.0 - sum;
112 hasComposition_ =
true;
115 void Mixture::computeC()
119 for (k = 0; k < nMonomer_; ++k) {
124 double concentration;
126 for (i = 0; i < nMolecule_; ++i) {
127 Molecule& mol = molecules_[i];
128 concentration = phi_[i]/mol.size();
129 for (j = 0; j < molecules_[i].nClump(); ++j) {
130 k = mol.clump(j).monomerId();
131 c_[k] += concentration*mol.clump(j).size();
137 for (k = 0; k < nMonomer_; ++k) {
144 for (k = 0; k < nMonomer_; ++k) {
166 for (m = 0; m < nMolecule_; ++m) {
193 dWdC_.
allocate(nMonomer_, nMonomer_);
194 dWdPhi_.
allocate(nMonomer_, nMolecule_);
195 jacobian_.
allocate(nMolecule_, nMolecule_);
208 double epsilon = 1.0E-10;
209 computeResidual(
mu, error);
212 std::cout <<
"mu[0] =" <<
mu[0] << std::endl;
213 std::cout <<
"mu[1] =" <<
mu[1] << std::endl;
214 std::cout <<
"mu_[0] =" << mu_[0] << std::endl;
215 std::cout <<
"mu_[1] =" << mu_[1] << std::endl;
216 std::cout <<
"residual[0] =" << residual_[0] << std::endl;
217 std::cout <<
"residual[1] =" << residual_[1] << std::endl;
218 std::cout <<
"error =" << error << std::endl;
221 if (error < epsilon)
return;
230 for (
int it = 0; it < 50; ++it) {
236 for (t1 = 0; t1 < nMonomer_; ++t1) {
237 for (m1 = 0; m1 < nMolecule_; ++m1) {
238 dWdPhi_(t1, m1) = 0.0;
241 for (m1 = 0; m1 < nMolecule_; ++m1) {
247 for (t2 = 0; t2 < nMonomer_; ++t2) {
248 dWdPhi_(t2, m1) += dWdC_(t2, t1)*f1;
254 for (m1 = 0; m1 < nMolecule_; ++m1) {
255 for (m2 = 0; m2 < nMolecule_; ++m2) {
256 jacobian_(m1, m2) = 0.0;
258 jacobian_(m1, m1) = 1.0/phi_[m1];
260 for (m1 = 0; m1 < nMolecule_; ++m1) {
265 for (m2 = 0; m2 < nMolecule_; ++m2) {
266 jacobian_(m1, m2) += s1*dWdPhi_(t1, m2);
272 int mLast = nMolecule_ - 1;
273 for (m1 = 0; m1 < nMolecule_; ++m1) {
274 for (m2 = 0; m2 < nMolecule_ - 1; ++m2) {
275 jacobian_(m1, m2) -= jacobian_(m1, mLast);
283 solverPtr_->
solve(residual_, dX_);
286 for (m1 = 0; m1 < nMolecule_; ++m1) {
287 phiOld_[m1] = phi_[m1];
291 bool inRange =
false;
292 for (
int j = 0; j < 5; ++j) {
296 for (m1 = 0; m1 < nMolecule_ - 1; ++m1) {
297 phi_[m1] = phiOld_[m1] - dX_[m1];
300 phi_[mLast] = 1.0 - sum;
304 for (m1 = 0; m1 < nMolecule_; ++m1) {
305 if (phi_[m1] < 0.0) inRange =
false;
306 if (phi_[m1] > 1.0) inRange =
false;
313 for (m1 = 0; m1 < nMolecule_; ++m1) {
320 xi = xi - dX_[mLast];
322 UTIL_THROW(
"Volume fractions remain out of range");
329 computeResidual(
mu, error);
332 std::cout <<
"mu[0] =" <<
mu[0] << std::endl;
333 std::cout <<
"mu[1] =" <<
mu[1] << std::endl;
334 std::cout <<
"mu_[0] =" << mu_[0] << std::endl;
335 std::cout <<
"mu_[1] =" << mu_[1] << std::endl;
336 std::cout <<
"residual[0] =" << residual_[0] << std::endl;
337 std::cout <<
"residual[1] =" << residual_[1] << std::endl;
338 std::cout <<
"error =" << error << std::endl;
341 if (error < epsilon)
return;
351 for (
int i=0; i < nMolecule_; ++i) {
352 dxi +=
mu[i] - mu_[i];
353 sum += molecules_[i].size();
356 for (
int i=0; i < nMolecule_; ++i) {
357 mu_[i] += dxi*molecules_[i].size();
362 void Mixture::computeResidual(
DArray<double> const & mu,
double& error)
365 for (
int i = 0; i < nMonomer_; ++i) {
366 residual_[i] = mu_[i] -
mu[i];
367 if (std::abs(residual_[i]) > error) {
368 error = std::abs(residual_[i]);
382 for (
int i = 0; i < nMolecule_; ++i) {
383 size = molecules_[i].size();
384 fHelmholtz_ += phi_[i]*( log(phi_[i]) - 1.0 )/size;
391 pressure_ = -fHelmholtz_;
392 for (
int i = 0; i < nMolecule_; ++i) {
393 size = molecules_[i].size();
394 pressure_ += phi_[i]*mu_[i]/size;
406 for (
int i = 0; i < nMolecule_; ++i) {
407 Molecule const & mol = molecules_[i];
409 for (
int j = 0; j < mol.
nClump(); ++j) {
int monomerId() const
Get the monomer type id.
double size() const
Get the size (number of monomers) in this block.
double c(int id) const
Return monomer volume fraction for one monomer type.
void validate() const
Validate all data structures.
Molecule & molecule(int id)
Get a molecule object (non-const reference).
virtual void readParameters(std::istream &in)
Read parameters from file and initialize.
double phi(int id) const
Return molecular volume fraction for one species.
int nMonomer() const
Get number of monomer types.
void setComposition(DArray< double > const &phi)
Set system composition.
void computePhi(Interaction const &interaction, DArray< double > const &mu, DArray< double > const &phi, double &xi)
Compute composition from chemical potentials.
void computeFreeEnergy(Interaction const &interaction)
Compute Helmholtz free energy and pressure.
int nMolecule() const
Get number of molecule species (polymer + solvent).
double mu(int id) const
Return chemical potential for one species.
void setNMonomer(int nMonomer)
Set the number of monomer types.
void computeMu(Interaction const &interaction, double xi=0.0)
Compute chemical potential from preset composition.
void setNMolecule(int nMolecule)
Set the number of molecular species and allocate memory.
Descriptor of a molecular species in a homogeneous mixture.
int nClump() const
Number of monomer clumps (monomer types).
Clump & clump(int id)
Get a specified Clump.
double size() const
Total molecule size = volume / reference volume.
Flory-Huggins excess free energy model.
virtual double fHelmholtz(Array< double > const &c) const
Compute excess Helmholtz free energy per monomer.
virtual void computeDwDc(Array< double > const &c, Matrix< double > &dWdC) const
Compute second derivatives of free energy.
virtual void computeW(Array< double > const &c, Array< double > &w) const
Compute chemical potential from concentration.
int nMonomer() const
Get number of monomer types.
Solve Ax=b by LU decomposition of A.
void allocate(int n)
Allocate memory.
void solve(Array< double > &b, Array< double > &x)
Solve Ax = b for known b to compute x.
void computeLU(const Matrix< double > &A)
Compute the LU decomposition for later use.
int capacity() const
Return allocated size.
Dynamically allocatable contiguous array template.
void allocate(int capacity)
Allocate the underlying C array.
void allocate(int capacity1, int capacity2)
Allocate memory for a matrix.
An object that can read multiple parameters from file.
ScalarParam< Type > & read(std::istream &in, const char *label, Type &value)
Add and read a new required ScalarParam < Type > object.
void setClassName(const char *className)
Set class name string.
void readParamComposite(std::istream &in, ParamComposite &child, bool next=true)
Add and read a required child ParamComposite.
#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.
#define UTIL_ASSERT(condition)
Assertion macro suitable for debugging serial or parallel code.
cudaReal sum(DeviceArray< cudaReal > const &in)
Compute sum of array elements (GPU kernel wrapper).
PSCF package top-level namespace.
Utility classes for scientific computation.