PSCF v1.2
pscf/homogeneous/Mixture.cpp
1/*
2* PSCF - Molecule Self-Consistent Field Theory
3*
4* Copyright 2016 - 2022, The Regents of the University of Minnesota
5* Distributed under the terms of the GNU General Public License.
6*/
7
8#include "Mixture.h"
9#include <pscf/inter/Interaction.h>
10#include <pscf/math/LuSolver.h>
11#include <cmath>
12
13namespace Pscf {
14namespace Homogeneous {
15
16 using namespace Util;
17
18 /*
19 * Constructor.
20 */
23 molecules_(),
24 mu_(),
25 phi_(),
26 c_(),
27 w_(),
28 residual_(),
29 dX_(),
30 dWdC_(),
31 dWdPhi_(),
32 jacobian_(),
33 phiOld_(),
34 fHelmholtz_(0.0),
35 pressure_(0.0),
36 solverPtr_(0),
37 nMolecule_(0),
38 nMonomer_(0),
39 hasComposition_(false)
40 { setClassName("Mixture"); }
41
42 /*
43 * Destructor.
44 */
46 {
47 if (solverPtr_) {
48 delete solverPtr_;
49 }
50 }
51
52 /*
53 * Read all parameters and initialize.
54 */
55 void Mixture::readParameters(std::istream& in)
56 {
57 // Precondition
58 UTIL_ASSERT(molecules_.capacity() == 0);
59
60 read<int>(in, "nMonomer", nMonomer_);
61 c_.allocate(nMonomer_);
62 w_.allocate(nMonomer_);
63
64 read<int>(in, "nMolecule", nMolecule_);
65 molecules_.allocate(nMolecule_);
66 mu_.allocate(nMolecule_);
67 phi_.allocate(nMolecule_);
68 for (int i = 0; i < nMolecule_; ++i) {
69 readParamComposite(in, molecules_[i]);
70 }
71
72 validate();
73 }
74
75 void Mixture::setNMolecule(int nMolecule)
76 {
77 UTIL_ASSERT(molecules_.capacity() == 0);
78 nMolecule_ = nMolecule;
79 molecules_.allocate(nMolecule_);
80 mu_.allocate(nMolecule_);
81 phi_.allocate(nMolecule_);
82 }
83
84 void Mixture::setNMonomer(int nMonomer)
85 {
86 UTIL_ASSERT(nMonomer_ == 0);
87 nMonomer_ = nMonomer;
88 c_.allocate(nMonomer_);
89 w_.allocate(nMonomer_);
90 }
91
92 /*
93 * Set molecular and monomer volume fractions.
94 */
96 {
97 validate();
98 UTIL_ASSERT(phi.capacity() == nMolecule_);
99
100 // Set molecular volume fractions
101 double sum = 0;
102 for (int i = 0; i < nMolecule_ - 1; ++i) {
103 UTIL_CHECK(phi[i] >= 0.0);
104 UTIL_CHECK(phi[i] <= 1.0);
105 phi_[i] = phi[i];
106 sum += phi[i];
107 }
108 UTIL_CHECK(sum <= 1.0);
109 phi_[nMolecule_ -1] = 1.0 - sum;
110
111 computeC();
112 hasComposition_ = true;
113 }
114
115 void Mixture::computeC()
116 {
117 // Initialize monomer fractions to zero
118 int k;
119 for (k = 0; k < nMonomer_; ++k) {
120 c_[k] = 0.0;
121 }
122
123 // Compute monomer volume fractions
124 double concentration;
125 int i, j;
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();
132 }
133 }
134
135 // Check and normalize monomer volume fractions
136 double sum = 0.0;
137 for (k = 0; k < nMonomer_; ++k) {
138 UTIL_CHECK(c_[k] >= 0.0);
139 UTIL_CHECK(c_[k] <= 1.0);
140 sum += c_[k];
141 }
142 UTIL_CHECK(sum > 0.9999);
143 UTIL_CHECK(sum < 1.0001);
144 for (k = 0; k < nMonomer_; ++k) {
145 c_[k] /= sum;
146 }
147
148 }
149
150 /*
151 * Compute thermodynamic properties.
152 */
153 void Mixture::computeMu(Interaction const & interaction,
154 double xi)
155 {
156 UTIL_CHECK(interaction.nMonomer() == nMonomer_);
157 UTIL_CHECK(hasComposition_);
158
159 // Compute monomer excess chemical potentials
160 interaction.computeW(c_, w_);
161
162 int m; // molecule index
163 int c; // clump index
164 int t; // monomer type index
165 double mu, size;
166 for (m = 0; m < nMolecule_; ++m) {
167 Molecule& mol = molecules_[m];
168 mu = log( phi_[m] );
169 mu += xi*mol.size();
170 for (c = 0; c < mol.nClump(); ++c) {
171 t = mol.clump(c).monomerId();
172 size = mol.clump(c).size();
173 mu += size*w_[t];
174 }
175 mu_[m] = mu;
176 }
177 }
178
179 /*
180 * Compute composition from chemical potentials.
181 */
182 void Mixture::computePhi(Interaction const & interaction,
183 DArray<double> const & mu,
184 DArray<double> const & phi,
185 double& xi)
186 {
187 UTIL_ASSERT(interaction.nMonomer() == nMonomer_);
188
189 // Allocate residual and jacobian on first use.
190 if (residual_.capacity() == 0) {
191 residual_.allocate(nMonomer_);
192 dX_.allocate(nMolecule_);
193 dWdC_.allocate(nMonomer_, nMonomer_);
194 dWdPhi_.allocate(nMonomer_, nMolecule_);
195 jacobian_.allocate(nMolecule_, nMolecule_);
196 phiOld_.allocate(nMolecule_);
197 solverPtr_ = new LuSolver();
198 solverPtr_->allocate(nMolecule_);
199 }
200
201 // Compute initial state
203 computeMu(interaction, xi);
204 adjustXi(mu, xi);
205
206 // Compute initial residual
207 double error;
208 double epsilon = 1.0E-10;
209 computeResidual(mu, error);
210
211 #if 0
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;
219 #endif
220
221 if (error < epsilon) return;
222
223 double s1; // clump size
224 double v1; // molecule size
225 double f1; // clump fraction
226 int m1, m2; // molecule type indices
227 int c1; // clump index
228 int t1, t2; // monomer type indices
229
230 for (int it = 0; it < 50; ++it) {
231
232 // Compute matrix of derivative dWdC (C = monomer fraction)
233 interaction.computeDwDc(c_, dWdC_);
234
235 // Compute matrix derivative dWdPhi (Phi = molecule fraction)
236 for (t1 = 0; t1 < nMonomer_; ++t1) {
237 for (m1 = 0; m1 < nMolecule_; ++m1) {
238 dWdPhi_(t1, m1) = 0.0;
239 }
240 }
241 for (m1 = 0; m1 < nMolecule_; ++m1) {
242 v1 = molecule(m1).size();
243 for (c1 = 0; c1 < molecule(m1).nClump(); ++c1) {
244 t1 = molecule(m1).clump(c1).monomerId();
245 s1 = molecule(m1).clump(c1).size();
246 f1 = s1/v1;
247 for (t2 = 0; t2 < nMonomer_; ++t2) {
248 dWdPhi_(t2, m1) += dWdC_(t2, t1)*f1;
249 }
250 }
251 }
252
253 // Compute matrix d(mu)/d(Phi), stored in jacobian_
254 for (m1 = 0; m1 < nMolecule_; ++m1) {
255 for (m2 = 0; m2 < nMolecule_; ++m2) {
256 jacobian_(m1, m2) = 0.0;
257 }
258 jacobian_(m1, m1) = 1.0/phi_[m1];
259 }
260 for (m1 = 0; m1 < nMolecule_; ++m1) {
261 v1 = molecule(m1).size();
262 for (c1 = 0; c1 < molecule(m1).nClump(); ++c1) {
263 t1 = molecule(m1).clump(c1).monomerId();
264 s1 = molecule(m1).clump(c1).size();
265 for (m2 = 0; m2 < nMolecule_; ++m2) {
266 jacobian_(m1, m2) += s1*dWdPhi_(t1, m2);
267 }
268 }
269 }
270
271 // Impose incompressibility
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);
276 }
277 // Derivative of mu_[m1] with respect to xi
278 jacobian_(m1, mLast) = molecule(m1).size();
279 }
280
281 // Newton Raphson update of phi and xi fields
282 solverPtr_->computeLU(jacobian_);
283 solverPtr_->solve(residual_, dX_);
284
285 // Store old value of phi
286 for (m1 = 0; m1 < nMolecule_; ++m1) {
287 phiOld_[m1] = phi_[m1];
288 }
289
290 // Apply update
291 bool inRange = false;
292 for (int j = 0; j < 5; ++j) {
293
294 // Update volume fractions
295 double sum = 0.0;
296 for (m1 = 0; m1 < nMolecule_ - 1; ++m1) {
297 phi_[m1] = phiOld_[m1] - dX_[m1];
298 sum += phi_[m1];
299 }
300 phi_[mLast] = 1.0 - sum;
301
302 // Check if all volume fractions are in [0,1]
303 inRange = true;
304 for (m1 = 0; m1 < nMolecule_; ++m1) {
305 if (phi_[m1] < 0.0) inRange = false;
306 if (phi_[m1] > 1.0) inRange = false;
307 }
308
309 // Exit loop or reduce increment
310 if (inRange) {
311 break;
312 } else {
313 for (m1 = 0; m1 < nMolecule_; ++m1) {
314 dX_[m1] *= 0.5;
315 }
316 }
317
318 }
319 if (inRange) {
320 xi = xi - dX_[mLast];
321 } else {
322 UTIL_THROW("Volume fractions remain out of range");
323 }
324
325 // Compute residual
326 computeC();
327 computeMu(interaction, xi);
328 adjustXi(mu, xi);
329 computeResidual(mu, error);
330
331 #if 0
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;
339 #endif
340
341 if (error < epsilon) return;
342 }
343
344 UTIL_THROW("Failed to converge");
345 }
346
347 void Mixture::adjustXi(DArray<double> const & mu, double& xi)
348 {
349 double dxi = 0.0;
350 double sum = 0.0;
351 for (int i=0; i < nMolecule_; ++i) {
352 dxi += mu[i] - mu_[i];
353 sum += molecules_[i].size();
354 }
355 dxi = dxi/sum;
356 for (int i=0; i < nMolecule_; ++i) {
357 mu_[i] += dxi*molecules_[i].size();
358 }
359 xi += dxi;
360 }
361
362 void Mixture::computeResidual(DArray<double> const & mu, double& error)
363 {
364 error = 0.0;
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]);
369 }
370 }
371 }
372
373 /*
374 * Compute Helmoltz free energy and pressure
375 */
376 void Mixture::computeFreeEnergy(Interaction const & interaction)
377 {
378 fHelmholtz_ = 0.0;
379
380 // Compute ideal gas contributions to fHelhmoltz_
381 double size;
382 for (int i = 0; i < nMolecule_; ++i) {
383 size = molecules_[i].size();
384 fHelmholtz_ += phi_[i]*( log(phi_[i]) - 1.0 )/size;
385 }
386
387 // Add average interaction free energy density per monomer
388 fHelmholtz_ += interaction.fHelmholtz(c_);
389
390 // Compute pressure
391 pressure_ = -fHelmholtz_;
392 for (int i = 0; i < nMolecule_; ++i) {
393 size = molecules_[i].size();
394 pressure_ += phi_[i]*mu_[i]/size;
395 }
396
397 }
398
399 /*
400 * Check validity after completing initialization.
401 */
402 void Mixture::validate() const
403 {
404 UTIL_ASSERT(nMolecule_ > 0);
405 UTIL_ASSERT(nMonomer_ > 0);
406 for (int i = 0; i < nMolecule_; ++i) {
407 Molecule const & mol = molecules_[i];
408 UTIL_ASSERT(mol.nClump() > 0);
409 for (int j = 0; j < mol.nClump(); ++j) {
410 UTIL_ASSERT(mol.clump(j).monomerId() < nMonomer_);
411 }
412 }
413 }
414
415} // namespace Homogeneous
416} // namespace Pscf
int monomerId() const
Get the monomer type id.
Definition Clump.h:127
double size() const
Get the size (number of monomers) in this block.
Definition Clump.h:133
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.
Definition Molecule.h:39
int nClump() const
Number of monomer clumps (monomer types).
Definition Molecule.h:126
Clump & clump(int id)
Get a specified Clump.
Definition Molecule.h:141
double size() const
Total molecule size = volume / reference volume.
Definition Molecule.h:132
Flory-Huggins excess free energy model.
Definition Interaction.h:26
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.
Definition LuSolver.h:31
void allocate(int n)
Allocate memory.
Definition LuSolver.cpp:46
void solve(Array< double > &b, Array< double > &x)
Solve Ax = b for known b to compute x.
Definition LuSolver.cpp:83
void computeLU(const Matrix< double > &A)
Compute the LU decomposition for later use.
Definition LuSolver.cpp:63
int capacity() const
Return allocated size.
Definition Array.h:159
Dynamically allocatable contiguous array template.
void allocate(int capacity)
Allocate the underlying C array.
Definition DArray.h:199
void allocate(int capacity1, int capacity2)
Allocate memory for a matrix.
Definition DMatrix.h:170
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.
Definition global.h:68
#define UTIL_THROW(msg)
Macro for throwing an Exception, reporting function, file and line number.
Definition global.h:51
#define UTIL_ASSERT(condition)
Assertion macro suitable for debugging serial or parallel code.
Definition global.h:75
cudaReal sum(DeviceArray< cudaReal > const &in)
Compute sum of array elements (GPU kernel wrapper).
Definition Reduce.cu:480
PSCF package top-level namespace.
Definition param_pc.dox:1
Utility classes for scientific computation.