PSCF v1.2
fieldIoUtil.tpp
1#ifndef PRDC_FIELD_IO_UTIL_TPP
2#define PRDC_FIELD_IO_UTIL_TPP
3
4/*
5* PSCF - Polymer Self-Consistent Field Theory
6*
7* Copyright 2016 - 2024, The Regents of the University of Minnesota
8* Distributed under the terms of the GNU General Public License.
9*/
10
11#include <prdc/crystal/Basis.h>
12#include <prdc/crystal/UnitCell.h>
13#include <prdc/crystal/shiftToMinimum.h>
14#include <prdc/crystal/fieldHeader.h>
15
16#include <pscf/mesh/Mesh.h>
17#include <pscf/mesh/MeshIterator.h>
18#include <pscf/mesh/MeshIteratorFortran.h>
19#include <pscf/math/IntVec.h>
20#include <pscf/math/complex.h>
21
22#include <util/containers/DArray.h>
23#include <util/misc/FileMaster.h>
24#include <util/misc/Log.h>
25#include <util/format/Int.h>
26#include <util/format/Dbl.h>
27
28#include <string>
29
30namespace Pscf {
31namespace Prdc {
32
33 /*
34 * Check allocation of a single field of type FT, allocate if needed.
35 */
36 template <int D, class FT>
37 void checkAllocateField(FT& field,
38 IntVec<D> const& dimensions)
39 {
40 if (field.isAllocated()) {
41 UTIL_CHECK(field.meshDimensions() == dimensions);
42 } else {
43 field.allocate(dimensions);
44 }
45 }
46
47 /*
48 * Check allocation of an array of fields of type FT, allocate if needed.
49 */
50 template <int D, class FT>
52 int nMonomer,
53 IntVec<D> const& dimensions)
54 {
55 if (fields.isAllocated()) {
56 int nMonomerFields = fields.capacity();
57 UTIL_CHECK(nMonomerFields > 0)
58 UTIL_CHECK(nMonomerFields == nMonomer)
59 for (int i = 0; i < nMonomer; ++i) {
60 UTIL_CHECK(fields[i].meshDimensions() == dimensions);
61 }
62 } else {
63 fields.allocate(nMonomer);
64 for (int i = 0; i < nMonomer; ++i) {
65 fields[i].allocate(dimensions);
66 }
67 }
68 }
69
70 /*
71 * Inspect dimensions of a DArray of fields, each of type FT.
72 */
73 template <int D, class FT>
74 void inspectFields(DArray<FT> const& fields,
75 int & nMonomer,
76 IntVec<D> & dimensions)
77 {
78 UTIL_CHECK(fields.isAllocated());
79 nMonomer = fields.capacity();
80 UTIL_CHECK(nMonomer > 0);
81
82 dimensions = fields[0].meshDimensions();
83 for (int i = 0; i < nMonomer; ++i) {
84 UTIL_CHECK(fields[i].meshDimensions() == dimensions);
85 }
86 }
87
88 /*
89 * Check allocation of an array of arrays of type AT, allocate if needed.
90 */
91 template <class AT>
93 int nMonomer,
94 int capacity)
95 {
96 if (arrays.isAllocated()) {
97 int nMonomerArrays = arrays.capacity();
98 UTIL_CHECK(nMonomerArrays > 0)
99 UTIL_CHECK(nMonomerArrays == nMonomer)
100 for (int i = 0; i < nMonomer; ++i) {
101 UTIL_CHECK(arrays[i].capacity() == capacity);
102 }
103 } else {
104 arrays.allocate(nMonomer);
105 for (int i = 0; i < nMonomer; ++i) {
106 arrays[i].allocate(capacity);
107 }
108 }
109 }
110
111 /*
112 * Inspect dimensions of an array of arrays of type AT.
113 */
114 template <class AT>
115 void inspectArrays(DArray<AT> const& arrays,
116 int & nMonomer,
117 int & capacity)
118 {
119 UTIL_CHECK(arrays.isAllocated());
120 nMonomer = arrays.capacity();
121 UTIL_CHECK(nMonomer > 0);
122
123 capacity = arrays[0].capacity();
124 UTIL_CHECK(capacity > 0);
125 for (int i = 0; i < nMonomer; ++i) {
126 UTIL_CHECK(arrays[i].capacity() == capacity);
127 }
128 }
129
130 // RGrid File Io Templates
131
132 template <int D>
133 void readMeshDimensions(std::istream& in,
134 IntVec<D> const& meshDimensions)
135 {
136 // Read and check input stream mesh dimensions
137 std::string label;
138 in >> label;
139 if (label != "mesh" && label != "ngrid") {
140 std::string msg = "\n";
141 msg += "Error reading field file:\n";
142 msg += "Expected mesh or ngrid, but found [";
143 msg += label;
144 msg += "]";
145 UTIL_THROW(msg.c_str());
146 }
147 IntVec<D> meshDimensionsIn;
148 in >> meshDimensionsIn;
149 if (meshDimensionsIn != meshDimensions) {
150 Log::file()
151 << "Inconsistent mesh dimensions:\n"
152 << "meshDimensions (expected) = " << meshDimensions << "\n"
153 << "meshDimensions (from file) = " << meshDimensionsIn << "\n";
154 UTIL_THROW("Unexpected mesh dimensions in field file header");
155 }
156 }
157
158 template <int D>
159 void writeMeshDimensions(std::ostream &out,
160 IntVec<D> const& meshDimensions)
161 {
162 out << "mesh " << std::endl
163 << " " << meshDimensions << std::endl;
164 }
165
166 template <int D, class ART>
167 void readRGridData(std::istream& in,
168 DArray<ART>& fields,
169 int nMonomer,
170 IntVec<D> const& dimensions)
171 {
172 UTIL_CHECK(nMonomer > 0);
173 UTIL_CHECK(fields.capacity() == nMonomer);
174
175 MeshIteratorFortran<D> iter(dimensions);
176 int rank;
177 for (iter.begin(); !iter.atEnd(); ++iter) {
178 rank = iter.rank();
179 for (int k = 0; k < nMonomer; ++k) {
180 in >> fields[k][rank];
181 }
182 }
183 }
184
185 template <int D, class ART>
186 void readRGridData(std::istream& in,
187 ART& field,
188 IntVec<D> const& dimensions)
189 {
190 MeshIteratorFortran<D> iter(dimensions);
191 int rank;
192 for (iter.begin(); !iter.atEnd(); ++iter) {
193 rank = iter.rank();
194 in >> field[rank];
195 }
196 }
197
198 template <int D, class ART>
199 void writeRGridData(std::ostream& out,
200 DArray<ART> const& fields,
201 int nMonomer,
202 IntVec<D> const& dimensions)
203 {
204 UTIL_CHECK(nMonomer > 0);
205 UTIL_CHECK(nMonomer == fields.capacity());
206
207 MeshIteratorFortran<D> iter(dimensions);
208 int rank, j;
209 for (iter.begin(); !iter.atEnd(); ++iter) {
210 rank = iter.rank();
211 for (j = 0; j < nMonomer; ++j) {
212 out << " " << Dbl(fields[j][rank], 21, 13);
213 }
214 out << std::endl;
215 }
216
217 }
218
219 template <int D, class ART>
220 void writeRGridData(std::ostream& out,
221 ART const& field,
222 IntVec<D> const& dimensions)
223 {
224 MeshIteratorFortran<D> iter(dimensions);
225 int rank;
226 for (iter.begin(); !iter.atEnd(); ++iter) {
227 rank = iter.rank();
228 out << " " << Dbl(field[rank], 21, 13);
229 out << std::endl;
230 }
231 }
232
233 // KGrid file IO templates
234
235 template <int D, class ACT>
236 void readKGridData(std::istream& in,
237 DArray<ACT> & fields,
238 int nMonomer,
239 IntVec<D> const& dftDimensions)
240 {
241 typedef typename ACT::Complex CT;
242 typedef typename ACT::Real RT;
243
244 RT x, y;
245 MeshIterator<D> iter(dftDimensions);
246 int rank, i, j, idum;
247 i = 0;
248 for (iter.begin(); !iter.atEnd(); ++iter) {
249 rank = iter.rank();
250 in >> idum;
251 UTIL_CHECK(i == idum);
252 UTIL_CHECK(i == rank);
253 for (j = 0; j < nMonomer; ++j) {
254 in >> x;
255 in >> y;
256 assign<CT, RT>(fields[j][rank], x, y);
257 }
258 ++i;
259 }
260 }
261
262 template <int D, class ACT>
263 void readKGridData(std::istream& in,
264 ACT& field,
265 IntVec<D> const& dftDimensions)
266 {
267 typedef typename ACT::Complex CT;
268 typedef typename ACT::Real RT;
269
270 RT x, y;
271 MeshIterator<D> iter(dftDimensions);
272 int rank, idum;
273 int i = 0;
274 for (iter.begin(); !iter.atEnd(); ++iter) {
275 rank = iter.rank();
276 in >> idum;
277 UTIL_CHECK(i == idum);
278 UTIL_CHECK(i == rank);
279 //in >> field[rank][0];
280 //in >> field[rank][1];
281 in >> x;
282 in >> y;
283 assign<CT, RT>(field[rank], x, y);
284 ++i;
285 }
286 }
287
288 template <int D, class ACT>
289 void writeKGridData(std::ostream& out,
290 DArray<ACT> const& fields,
291 int nMonomer,
292 IntVec<D> const& dftDimensions)
293 {
294 UTIL_CHECK(nMonomer > 0);
295 UTIL_CHECK(nMonomer == fields.capacity());
296
297 typedef typename ACT::Complex CT;
298 typedef typename ACT::Real RT;
299
300 RT x, y;
301 MeshIterator<D> iter(dftDimensions);
302 int rank;
303 int i = 0;
304 for (iter.begin(); !iter.atEnd(); ++iter) {
305 rank = iter.rank();
306 UTIL_CHECK(i == rank);
307 out << Int(rank, 5);
308 for (int j = 0; j < nMonomer; ++j) {
309 x = real<CT, RT>(fields[j][rank]);
310 y = imag<CT, RT>(fields[j][rank]);
311 out << " "
312 << Dbl(x, 21, 13)
313 << Dbl(y, 21, 13);
314 }
315 out << std::endl;
316 ++i;
317 }
318
319 }
320
321 template <int D, class ACT>
322 void writeKGridData(std::ostream& out,
323 ACT const& field,
324 IntVec<D> const& dftDimensions)
325 {
326 typedef typename ACT::Complex CT;
327 typedef typename ACT::Real RT;
328
329 RT x, y;
330 MeshIterator<D> iter(dftDimensions);
331 int rank, i;
332 i = 0;
333 for (iter.begin(); !iter.atEnd(); ++iter) {
334 rank = iter.rank();
335 UTIL_CHECK(i == rank);
336 x = real<CT, RT>(field[rank]);
337 y = imag<CT, RT>(field[rank]);
338 out << Int(rank, 5);
339 out << " "
340 << Dbl(x, 21, 13)
341 << Dbl(y, 21, 13);
342 out << std::endl;
343 ++i;
344 }
345 }
346
347 // Functions for files in symmetry-adapted basis format
348
349 /*
350 * Read the number of basis functions from a field file header.
351 */
352 int readNBasis(std::istream& in)
353 {
354
355 // Read the label, which can be N_star or N_basis
356 std::string label;
357 in >> label;
358 if (label != "N_star" && label != "N_basis") {
359 std::string msg = "\n";
360 msg += "Error reading field file:\n";
361 msg += "Expected N_basis or N_star, but found [";
362 msg += label;
363 msg += "]";
364 UTIL_THROW(msg.c_str());
365 }
366
367 // Read the value of nBasis
368 int nBasis;
369 in >> nBasis;
370 UTIL_CHECK(nBasis > 0);
371
372 return nBasis;
373 }
374
375 /*
376 * Write the number of basis functions to a field file header.
377 */
378 void writeNBasis(std::ostream& out, int nBasis)
379 {
380 out << "N_basis " << std::endl
381 << " " << nBasis << std::endl;
382 }
383
384 /*
385 * Read the data section for an array of fields in basis format.
386 */
387 template <int D>
388 void readBasisData(std::istream& in,
389 DArray< DArray<double> >& fields,
390 UnitCell<D> const& unitCell,
391 Mesh<D> const& mesh,
392 Basis<D> const& basis,
393 int nBasisIn)
394 {
395 UTIL_CHECK(basis.isInitialized());
396 UTIL_CHECK(fields.isAllocated());
397
398 int nMonomer = fields.capacity();
399 UTIL_CHECK(nMonomer > 0);
400
401 // Initialize all field array elements to zero
402 int fieldCapacity = fields[0].capacity();
403 UTIL_CHECK(fieldCapacity > 0);
404 for (int i = 0; i < nMonomer; ++i) {
405 UTIL_CHECK(fields[i].capacity() == fieldCapacity);
406 for (int j = 0; j < fieldCapacity; ++j) {
407 fields[i][j] = 0.0;
408 }
409 }
410
411 // Reset nBasis = min(nBasisIn, fieldCapacity)
412 int nBasis = nBasisIn;
413 if (fieldCapacity < nBasisIn) {
414 nBasis = fieldCapacity;
415 }
416
417 // Allocate temp arrays used to read in components
418 DArray<double> temp, temp2;
419 temp.allocate(nMonomer);
420 temp2.allocate(nMonomer);
421
422 typename Basis<D>::Star const * starPtr;
423 typename Basis<D>::Star const * starPtr2;
424 IntVec<D> waveIn, waveIn2;
425 int sizeIn, sizeIn2;
426 int starId, starId2;
427 int basisId, basisId2;
428 int waveId, waveId2;
429
430 std::complex<double> coeff, phasor;
431 IntVec<D> waveBz, waveDft;
432 int nReversedPair = 0;
433 bool waveExists, sizeMatches;
434
435 // Loop over stars in input file to read field components
436 int i = 0;
437 while (i < nBasis) {
438
439 // Read next line of data
440 for (int j = 0; j < nMonomer; ++j) {
441 in >> temp[j]; // field components
442 }
443 in >> waveIn; // wave of star
444 in >> sizeIn; // # of waves in star
445 ++i;
446
447 sizeMatches = false;
448 waveExists = false;
449
450 // Check if waveIn is in first Brillouin zone (FBZ) for the mesh.
451 waveBz = shiftToMinimum(waveIn, mesh.dimensions(), unitCell);
452 waveExists = (waveIn == waveBz);
453
454 if (waveExists) {
455
456 // Find the star containing waveIn
457 waveDft = waveIn;
458 mesh.shift(waveDft);
459 waveId = basis.waveId(waveDft);
460 starId = basis.wave(waveId).starId;
461 starPtr = &basis.star(starId);
462 UTIL_CHECK(!(starPtr->cancel));
463 basisId = starPtr->basisId;
464
465 if (starPtr->size == sizeIn) {
466 sizeMatches = true;
467 } else {
468 Log::file()
469 << "Warning: Inconsistent star size (line ignored)\n"
470 << "wave from file = " << waveIn << "\n"
471 << "size from file = " << sizeIn << "\n"
472 << "size of star = " << starPtr->size
473 << "\n";
474 sizeMatches = false;
475 }
476
477 }
478
479 if (waveExists && sizeMatches) { // Attempt to process wave
480
481 if (starPtr->invertFlag == 0) {
482
483 if (starPtr->waveBz == waveIn) {
484
485 // Copy components of closed star to fields array
486 for (int j = 0; j < nMonomer; ++j) {
487 fields[j][basisId] = temp[j];
488 }
489
490 } else {
491
492 Log::file()
493 << "Inconsistent wave of closed star on input\n"
494 << "wave from file = " << waveIn << "\n"
495 << "starId of wave = " << starId << "\n"
496 << "waveBz of star = " << starPtr->waveBz
497 << "\n";
498
499 }
500
501 } else {
502
503 // Read the next line
504 for (int j = 0; j < nMonomer; ++j) {
505 in >> temp2[j]; // components of field
506 }
507 in >> waveIn2; // wave of star
508 in >> sizeIn2; // # of wavevectors in star
509 ++i;
510
511 // Check that waveIn2 is also in the 1st BZ
512 waveBz =
513 shiftToMinimum(waveIn2, mesh.dimensions(), unitCell);
514 UTIL_CHECK(waveIn2 == waveBz);
515
516 // Identify the star containing waveIn2
517 waveDft = waveIn2;
518 mesh.shift(waveDft);
519 waveId2 = basis.waveId(waveDft);
520 starId2 = basis.wave(waveId2).starId;
521 starPtr2 = &basis.star(starId2);
522 UTIL_CHECK(!(starPtr2->cancel));
523 basisId2 = starPtr2->basisId;
524 UTIL_CHECK(starPtr2->size == sizeIn2);
525 UTIL_CHECK(sizeIn == sizeIn2);
526
527 if (starPtr->invertFlag == 1) {
528
529 // This is a pair of open stars written in the same
530 // order as in this basis. Check preconditions:
531 UTIL_CHECK(starPtr2->invertFlag == -1);
532 UTIL_CHECK(starId2 = starId + 1);
533 UTIL_CHECK(basisId2 = basisId + 1);
534 UTIL_CHECK(starPtr->waveBz == waveIn);
535 UTIL_CHECK(starPtr2->waveBz == waveIn2);
536
537 // Copy components for both stars into fields array
538 for (int j = 0; j < nMonomer; ++j) {
539 fields[j][basisId] = temp[j];
540 fields[j][basisId2] = temp2[j];
541 }
542
543 } else
544 if (starPtr->invertFlag == -1) {
545
546 // This is a pair of open stars written in opposite
547 // order from in this basis. Check preconditions:
548 UTIL_CHECK(starPtr2->invertFlag == 1);
549 UTIL_CHECK(starId == starId2 + 1);
550 UTIL_CHECK(basisId == basisId2 + 1);
551 UTIL_CHECK(waveId == starPtr->beginId);
552
553 // Check that waveIn2 is negation of waveIn
554 IntVec<D> nVec;
555 nVec.negate(waveIn);
556 nVec =
557 shiftToMinimum(nVec, mesh.dimensions(), unitCell);
558 UTIL_CHECK(waveIn2 == nVec);
559
560 /*
561 * Consider two related stars, C and D, that are listed
562 * in the order (C,D) in the basis used in this code (the
563 * reading program), but that were listed in the opposite
564 * order (D,C) in the program that wrote the file (the
565 * writing program). In the basis of the reading program,
566 * star C has star index starId2, while star D has index
567 * starId = starid2 + 1.
568 *
569 * Let f(r) and f^{*}(r) denote the basis functions used
570 * by the reading program for stars C and D, respectively.
571 * Let u(r) and u^{*}(r) denote the corresponding basis
572 * functions used by the writing program for stars C
573 * and D. Let exp(i phi) denote the unit magnitude
574 * coefficient (i.e., phasor) within f(r) of the wave
575 * with wave index waveId2, which was the characteristic
576 * wave for star C in the writing program. The
577 * coefficient of this wave within the basis function
578 * u(r) used by the writing program must instead be real
579 * and positive. This implies that
580 * u(r) = exp(-i phi) f(r).
581 *
582 * Focus on the contribution to the field for a specific
583 * monomer type j. Let a and b denote the desired
584 * coefficients of stars C and D in the reading program,
585 * for which the total contribution of both stars to the
586 * field is:
587 *
588 * (a - ib) f(r) + (a + ib) f^{*}(r)
589 *
590 * Let A = temp[j] and B = temp2[j] denote the
591 * coefficients read from file in order (A,B). Noting
592 * that the stars were listed in the order (D,C) in the
593 * basis used by the writing program, the contribution
594 * of both stars must be (A-iB)u^{*}(r)+(A+iB)u(r), or:
595 *
596 * (A+iB) exp(-i phi)f(r) + (A-iB) exp(i phi) f^{*}(r)
597 *
598 * Comparing coefficients of f^{*}(r), we find that
599 *
600 * (a + ib) = (A - iB) exp(i phi)
601 *
602 * This equality is implemented below, where the
603 * variable "phasor" is set equal to exp(i phi).
604 */
605 phasor = basis.wave(waveId2).coeff;
606 phasor = phasor/std::abs(phasor);
607 for (int j = 0; j < nMonomer; ++j) {
608 coeff = std::complex<double>(temp[j],-temp2[j]);
609 coeff *= phasor;
610 fields[j][basisId2] = real(coeff);
611 fields[j][basisId ] = imag(coeff);
612 }
613
614 // Increment count of number of reversed open pairs
615 ++nReversedPair;
616
617 } else {
618 UTIL_THROW("Invalid starInvert value");
619 }
620
621 } // if (wavePtr->invertFlag == 0) ... else ...
622
623 } // if (waveExists && sizeMatches)
624
625 } // end while (i < nBasis)
626
627 if (nReversedPair > 0) {
628 Log::file() << "\n";
629 Log::file() << nReversedPair << " reversed pairs of open stars"
630 << " detected in readFieldsBasis\n";
631 }
632
633 }
634
635 /*
636 * Write an array of fields in basis format to an output stream.
637 */
638 template <int D>
639 void writeBasisData(std::ostream &out,
640 DArray< DArray<double> > const & fields,
641 Basis<D> const & basis)
642 {
643 // Preconditions, set nMonomer and fieldCapacity
644 int nMonomer = fields.capacity();
645 UTIL_CHECK(nMonomer > 0);
646 int fieldCapacity = fields[0].capacity();
647 for (int j = 0; j < nMonomer; ++j) {
648 UTIL_CHECK(fieldCapacity == fields[j].capacity());
649 }
650 UTIL_CHECK(basis.isInitialized());
651
652 // Write fields
653 int ib = 0;
654 int nStar = basis.nStar();
655 for (int i = 0; i < nStar; ++i) {
656 if (ib >= fieldCapacity) break;
657 if (!basis.star(i).cancel) {
658 for (int j = 0; j < nMonomer; ++j) {
659 out << Dbl(fields[j][ib], 20, 10);
660 }
661 out << " ";
662 for (int j = 0; j < D; ++j) {
663 out << Int(basis.star(i).waveBz[j], 5);
664 }
665 out << Int(basis.star(i).size, 5) << std::endl;
666 ++ib;
667 }
668 }
669
670 }
671
672 template <int D, class ACT>
673 void convertBasisToKGrid(DArray<double> const & in,
674 ACT& out,
675 Basis<D> const& basis,
676 IntVec<D> const& dftDimensions)
677 {
678 UTIL_CHECK(basis.isInitialized());
679
680 typedef typename ACT::Complex CT;
681 typedef typename ACT::Real RT;
682
683 // Create Mesh<D> with dimensions of DFT Fourier grid.
684 Mesh<D> dftMesh(dftDimensions);
685
686 typename Basis<D>::Star const* starPtr; // pointer to current star
687 typename Basis<D>::Wave const* wavePtr; // pointer to current wave
688 std::complex<double> component; // coefficient for star
689 std::complex<double> coeff; // coefficient for wave
690 IntVec<D> indices; // dft grid indices of wave
691 int rank; // dft grid rank of wave
692 int is; // star index
693 int ib; // basis index
694 int iw; // wave index
695
696 // Initialize all dft coponents to zero
697 for (rank = 0; rank < dftMesh.size(); ++rank) {
698 //out[rank][0] = 0.0;
699 //out[rank][1] = 0.0;
700 assign<CT, RT>(out[rank], 0.0, 0.0);
701 }
702
703 // Loop over stars, skipping cancelled stars
704 is = 0;
705 while (is < basis.nStar()) {
706 starPtr = &(basis.star(is));
707
708 if (starPtr->cancel) {
709 ++is;
710 continue;
711 }
712
713 // Set basisId for uncancelled star
714 ib = starPtr->basisId;
715
716 if (starPtr->invertFlag == 0) {
717
718 // Make complex coefficient for star basis function
719 component = std::complex<double>(in[ib], 0.0);
720
721 // Loop over waves in closed star
722 for (iw = starPtr->beginId; iw < starPtr->endId; ++iw) {
723 wavePtr = &basis.wave(iw);
724 if (!wavePtr->implicit) {
725 coeff = component*(wavePtr->coeff);
726 indices = wavePtr->indicesDft;
727 rank = dftMesh.rank(indices);
728 //out[rank][0] = coeff.real();
729 //out[rank][1] = coeff.imag();
730 assign<CT, RT>(out[rank], coeff);
731 }
732 }
733 ++is;
734
735 } else
736 if (starPtr->invertFlag == 1) {
737
738 // Loop over waves in first star
739 component = std::complex<double>(in[ib], -in[ib+1]);
740 component /= sqrt(2.0);
741 starPtr = &(basis.star(is));
742 for (iw = starPtr->beginId; iw < starPtr->endId; ++iw) {
743 wavePtr = &basis.wave(iw);
744 if (!(wavePtr->implicit)) {
745 coeff = component*(wavePtr->coeff);
746 indices = wavePtr->indicesDft;
747 rank = dftMesh.rank(indices);
748 //out[rank][0] = coeff.real();
749 //out[rank][1] = coeff.imag();
750 assign<CT, RT>(out[rank], coeff);
751 }
752 }
753
754 // Loop over waves in second star
755 starPtr = &(basis.star(is+1));
756 UTIL_CHECK(starPtr->invertFlag == -1);
757 component = std::complex<double>(in[ib], +in[ib+1]);
758 component /= sqrt(2.0);
759 for (iw = starPtr->beginId; iw < starPtr->endId; ++iw) {
760 wavePtr = &basis.wave(iw);
761 if (!(wavePtr->implicit)) {
762 coeff = component*(wavePtr->coeff);
763 indices = wavePtr->indicesDft;
764 rank = dftMesh.rank(indices);
765 //out[rank][0] = coeff.real();
766 //out[rank][1] = coeff.imag();
767 assign<CT, RT>(out[rank], coeff);
768 }
769 }
770
771 // Increment is by 2 (two stars were processed)
772 is += 2;
773
774 } else {
775
776 UTIL_THROW("Invalid invertFlag value");
777
778 }
779
780 }
781
782 }
783
784 template <int D, class ACT>
785 void convertKGridToBasis(ACT const& in,
786 DArray<double>& out,
787 Basis<D> const& basis,
788 IntVec<D> const& dftDimensions,
789 bool checkSymmetry,
790 double epsilon)
791 {
792 UTIL_CHECK(basis.isInitialized());
793
794 typedef typename ACT::Complex CT;
795 typedef typename ACT::Real RT;
796
797 // Check if input field in k-grid format has specified symmetry
798 if (checkSymmetry) {
799 bool symmetric;
800 symmetric = hasSymmetry(in, basis, dftDimensions, epsilon, true);
801 if (!symmetric) {
802 Log::file() << std::endl
803 << "WARNING: Conversion of asymmetric field to"
804 << "symmetry-adapted basis in Prdc::convertKgridToBasis."
805 << std::endl << std::endl;
806 }
807 }
808
809 // Create Mesh<D> with dimensions of DFT Fourier grid.
810 Mesh<D> dftMesh(dftDimensions);
811
812 typename Basis<D>::Star const* starPtr; // pointer to current star
813 typename Basis<D>::Wave const* wavePtr; // pointer to current wave
814 std::complex<double> component; // coefficient for star
815 int rank; // dft grid rank of wave
816 int is; // star index
817 int ib; // basis index
818 int iw; // wave index
819
820 // Initialize all components to zero
821 for (is = 0; is < basis.nBasis(); ++is) {
822 out[is] = 0.0;
823 }
824
825 // Loop over stars
826 is = 0;
827 while (is < basis.nStar()) {
828 starPtr = &(basis.star(is));
829
830 if (starPtr->cancel) {
831 ++is;
832 continue;
833 }
834
835 // Set basis id for uncancelled star
836 ib = starPtr->basisId;
837
838 if (starPtr->invertFlag == 0) {
839
840 // Choose a wave in the star that is not implicit
841 int beginId = starPtr->beginId;
842 int endId = starPtr->endId;
843 iw = 0;
844 bool isImplicit = true;
845 while (isImplicit) {
846 wavePtr = &basis.wave(beginId + iw);
847 if (!wavePtr->implicit) {
848 isImplicit = false;
849 } else {
850 UTIL_CHECK(beginId + iw < endId - 1 - iw);
851 wavePtr = &basis.wave(endId - 1 - iw);
852 if (!wavePtr->implicit) {
853 isImplicit = false;
854 }
855 }
856 ++iw;
857 }
858 UTIL_CHECK(wavePtr->starId == is);
859
860 // Compute component value
861 rank = dftMesh.rank(wavePtr->indicesDft);
862 //component = std::complex<double>(in[rank][0], in[rank][1]);
863 assign<CT,RT>(component, in[rank]);
864 component /= wavePtr->coeff;
865 out[ib] = component.real();
866 ++is;
867
868 } else
869 if (starPtr->invertFlag == 1) {
870
871 // Identify a characteristic wave that is not implicit:
872 // Either the first wave of the 1st star or its inverse
873 // in the second star
874 wavePtr = &basis.wave(starPtr->beginId);
875 UTIL_CHECK(wavePtr->starId == is);
876 if (wavePtr->implicit) {
877 iw = wavePtr->inverseId;
878 starPtr = &(basis.star(is+1));
879 UTIL_CHECK(starPtr->invertFlag == -1);
880 wavePtr = &basis.wave(iw);
881 UTIL_CHECK(!(wavePtr->implicit));
882 UTIL_CHECK(wavePtr->starId == is+1);
883 }
884 rank = dftMesh.rank(wavePtr->indicesDft);
885 //component = std::complex<double>(in[rank][0], in[rank][1]);
886 assign<CT, RT>(component, in[rank]);
887 UTIL_CHECK(std::abs(wavePtr->coeff) > 1.0E-8);
888 component /= wavePtr->coeff;
889 component *= sqrt(2.0);
890
891 // Compute basis function coefficient values
892 if (starPtr->invertFlag == 1) {
893 out[ib] = component.real();
894 out[ib+1] = -component.imag();
895 } else {
896 out[ib] = component.real();
897 out[ib+1] = component.imag();
898 }
899
900 is += 2;
901 } else {
902 UTIL_THROW("Invalid invertFlag value");
903 }
904
905 } // loop over star index is
906 }
907
908 /*
909 * Test if an K-grid array has the declared space group symmetry.
910 * Return true if symmetric, false otherwise. Print error values
911 * if verbose == true and hasSymmetry == false.
912 */
913 template <int D, class ACT>
914 bool hasSymmetry(ACT const & in,
915 Basis<D> const& basis,
916 IntVec<D> const& dftDimensions,
917 double epsilon,
918 bool verbose)
919 {
920 UTIL_CHECK(basis.isInitialized());
921
922 typedef typename ACT::Complex CT;
923 typedef typename ACT::Real RT;
924
925 typename Basis<D>::Star const* starPtr; // pointer to current star
926 typename Basis<D>::Wave const* wavePtr; // pointer to current wave
927 std::complex<double> waveCoeff; // coefficient from wave
928 std::complex<double> rootCoeff; // coefficient from root
929 std::complex<double> diff; // coefficient difference
930 int is; // star index
931 int iw; // wave index
932 int beginId, endId; // star begin, end ids
933 int rank; // dft grid rank of wave
934
935 double cancelledError(0.0); // max error from cancelled stars
936 double uncancelledError(0.0); // max error from uncancelled stars
937
938 // Create Mesh<D> with dimensions of DFT Fourier grid.
939 Mesh<D> dftMesh(dftDimensions);
940
941 // Loop over all stars
942 for (is = 0; is < basis.nStar(); ++is) {
943 starPtr = &(basis.star(is));
944
945 if (starPtr->cancel) {
946
947 // Check that coefficients are zero for all waves in star
948 beginId = starPtr->beginId;
949 endId = starPtr->endId;
950 for (iw = beginId; iw < endId; ++iw) {
951 wavePtr = &basis.wave(iw);
952 if (!wavePtr->implicit) {
953 rank = dftMesh.rank(wavePtr->indicesDft);
954 //waveCoeff
955 // = std::complex<double>(in[rank][0], in[rank][1]);
956 assign<CT, RT>(waveCoeff, in[rank]);
957 if (std::abs(waveCoeff) > cancelledError) {
958 cancelledError = std::abs(waveCoeff);
959 if ((!verbose) && (cancelledError > epsilon)) {
960 return false;
961 }
962 }
963 }
964 }
965
966 } else {
967
968 // Check consistency of coeff values from all waves
969 bool hasRoot = false;
970 beginId = starPtr->beginId;
971 endId = starPtr->endId;
972 for (iw = beginId; iw < endId; ++iw) {
973 wavePtr = &basis.wave(iw);
974 if (!(wavePtr->implicit)) {
975 rank = dftMesh.rank(wavePtr->indicesDft);
976 //waveCoeff
977 // = std::complex<double>(in[rank][0], in[rank][1]);
978 assign<CT, RT>(waveCoeff, in[rank]);
979 waveCoeff /= wavePtr->coeff;
980 if (hasRoot) {
981 diff = waveCoeff - rootCoeff;
982 if (std::abs(diff) > uncancelledError) {
983 uncancelledError = std::abs(diff);
984 if ((!verbose) && (uncancelledError > epsilon)) {
985 return false;
986 }
987 }
988 } else {
989 rootCoeff = waveCoeff;
990 hasRoot = true;
991 }
992 }
993 }
994
995 }
996
997 } // end loop over star index is
998
999 if ((cancelledError < epsilon) && (uncancelledError < epsilon)) {
1000 return true;
1001 } else if (verbose) {
1002 Log::file()
1003 << std::endl
1004 << "Maximum coefficient of a cancelled star: "
1005 << cancelledError << std::endl
1006 << "Maximum error of coefficient for an uncancelled star: "
1007 << uncancelledError << std::endl;
1008 }
1009 return false;
1010 }
1011
1012 // Field file manipulations
1013
1014 template <int D, class ART>
1015 void replicateUnitCell(std::ostream &out,
1016 DArray<ART> const & fields,
1017 IntVec<D> const & meshDimensions,
1018 UnitCell<D> const & unitCell,
1019 IntVec<D> const & replicas)
1020 {
1021 // Obtain number of monomer types
1022 int nMonomer = fields.capacity();
1023 UTIL_CHECK(nMonomer > 0);
1024
1025 // Compute properties of mesh for replicated fields
1026 IntVec<D> repDimensions; // Dimensions
1027 int repSize = 1; // Total number of grid points
1028 for (int i = 0; i < D; ++i) {
1029 UTIL_CHECK(replicas[i] > 0);
1030 UTIL_CHECK(meshDimensions[i] > 0);
1031 repDimensions[i] = replicas[i] * meshDimensions[i];
1032 repSize *= repDimensions[i];
1033 }
1034
1035 // Allocate arrays for replicated fields
1036 DArray< DArray<double> > repFields;
1037 repFields.allocate(nMonomer);
1038 for (int i = 0; i < nMonomer; ++i) {
1039 repFields[i].allocate(repSize);
1040 }
1041
1042 // Replicate data
1043 Mesh<D> mesh(meshDimensions);
1044 Mesh<D> cellMesh(replicas);
1045 Mesh<D> repMesh(repDimensions);
1046 MeshIterator<D> iter(meshDimensions);
1047 MeshIterator<D> cellIter(replicas);
1048 IntVec<D> position;
1049 IntVec<D> cellPosition;
1050 IntVec<D> repPosition;
1051 double value;
1052 int repRank;
1053 for (int i = 0; i < nMonomer; ++i) {
1054 for (iter.begin(); !iter.atEnd(); ++iter) {
1055 position = iter.position();
1056 value = fields[i][iter.rank()];
1057 for (cellIter.begin(); !cellIter.atEnd(); ++cellIter) {
1058 cellPosition = cellIter.position();
1059 for (int j=0; j < D; ++j) {
1060 repPosition[j] = position[j]
1061 + meshDimensions[j]*cellPosition[j];
1062 }
1063 repRank = repMesh.rank(repPosition);
1064 repFields[i][repRank] = value;
1065 }
1066 }
1067 }
1068
1069 // Set up UnitCell for replicated fields
1070 UnitCell<D> cell;
1071 FSArray<double, 6> parameters;
1072 int nParameter = unitCell.nParameter();
1073 for (int i = 0; i < nParameter; i++) {
1074 parameters.append(replicas[i] * unitCell.parameter(i));
1075 }
1076 cell.set(unitCell.lattice(), parameters);
1077
1078 // Write header
1079 int v1 = 1;
1080 int v2 = 0;
1081 std::string gName = "";
1082 Pscf::Prdc::writeFieldHeader(out, v1, v2, cell, gName, nMonomer);
1083 writeMeshDimensions(out, repDimensions);
1084
1085 // Write field data
1086 writeRGridData(out, repFields, nMonomer, repDimensions);
1087 }
1088
1089 template <int D, class ART>
1090 void
1091 expandRGridDimension(std::ostream &out,
1092 DArray<ART> const & fields,
1093 IntVec<D> const & meshDimensions,
1094 UnitCell<D> const & unitCell,
1095 int d,
1096 DArray<int> newGridDimensions)
1097 {
1098 UTIL_THROW("Unimplemented base template");
1099 }
1100
1101 template <class ART>
1102 void
1103 expandRGridDimension(std::ostream &out,
1104 DArray<ART> const & fields,
1105 IntVec<1> const & meshDimensions,
1106 UnitCell<1> const & unitCell,
1107 int d,
1108 DArray<int> newGridDimensions)
1109
1110 {
1111 // Check validity of expanded dimension d and newGridDimensions
1112 UTIL_CHECK(d > 1);
1113 UTIL_CHECK(d <= 3);
1114 UTIL_CHECK(newGridDimensions.capacity() == (d - 1));
1115
1116
1117 // Obtain number of monomer types
1118 int nMonomer = fields.capacity();
1119 UTIL_CHECK(nMonomer > 0);
1120
1121 // Set up necessary objects
1122 FSArray<double, 6> cellParameters;
1123 cellParameters.append(unitCell.parameter(0));
1124 int v1 = 1;
1125 int v2 = 0;
1126 std::string gName = "";
1127
1128 if (d == 2) {
1129
1130 // 1D expanded to 2D
1131
1132 // Set dimensions
1133 IntVec<2> dimensions;
1134 dimensions[0] = meshDimensions[0];
1135 dimensions[1] = newGridDimensions[0];
1136
1137 // Assign unit cell
1138 UnitCell<2> cell;
1139 if (dimensions[0] == dimensions[1]) {
1140 cell.set(UnitCell<2>::Square, cellParameters);
1141 } else {
1142 cellParameters.append((double)dimensions[1]/dimensions[0]
1143 * cellParameters[0]);
1144 cell.set(UnitCell<2>::Rectangular, cellParameters);
1145 }
1146
1147 // Write Header
1148 Pscf::Prdc::writeFieldHeader(out, v1, v2, cell, gName, nMonomer);
1149 out << "mesh " << std::endl
1150 << " " << dimensions << std::endl;
1151
1152 } else if (d == 3) {
1153
1154 // 1D expanded to 3D
1155
1156 // Set dimensions
1157 IntVec<3> dimensions;
1158 dimensions[0] = meshDimensions[0];
1159 dimensions[1] = newGridDimensions[0];
1160 dimensions[2] = newGridDimensions[1];
1161
1162 // Assign unit cell
1163 UnitCell<3> cell;
1164 if (dimensions[2] == dimensions[1]) {
1165 if (dimensions[1] == dimensions[0]) {
1166 cell.set(UnitCell<3>::Cubic, cellParameters);
1167 } else {
1168 cellParameters.append((double)dimensions[1]/dimensions[0]
1169 * cellParameters[0]);
1170 cellParameters.append((double)dimensions[2]/dimensions[0]
1171 * cellParameters[0]);
1172 cell.set(UnitCell<3>::Orthorhombic, cellParameters);
1173 }
1174 } else {
1175 if (dimensions[1] == dimensions[0]) {
1176 cellParameters.append((double)dimensions[2]/dimensions[0]
1177 * cellParameters[0]);
1178 cell.set(UnitCell<3>::Tetragonal, cellParameters);
1179 } else {
1180 cellParameters.append((double)dimensions[1]/dimensions[0]
1181 * cellParameters[0]);
1182 cellParameters.append((double)dimensions[2]/dimensions[0]
1183 * cellParameters[0]);
1184 cell.set(UnitCell<3>::Orthorhombic, cellParameters);
1185 }
1186 }
1187
1188 // Write Header
1189 Pscf::Prdc::writeFieldHeader(out, v1, v2, cell, gName, nMonomer);
1190 out << "mesh " << std::endl
1191 << " " << dimensions << std::endl;
1192
1193 } else {
1194
1195 UTIL_THROW("Invalid d value");
1196
1197 }
1198
1199 // Write expanded fields
1200 int nReplica = newGridDimensions[0];
1201 if (d == 3) {
1202 nReplica *= newGridDimensions[1];
1203 }
1204 MeshIteratorFortran<1> iter(meshDimensions);
1205 int rank;
1206 for (int i = 0; i < nReplica; ++i) {
1207 for (iter.begin(); !iter.atEnd(); ++iter) {
1208 rank = iter.rank();
1209 for (int j = 0; j < nMonomer; ++j) {
1210 out << " " << Dbl(fields[j][rank], 21, 13);
1211 }
1212 out << std::endl;
1213 }
1214 }
1215
1216 }
1217
1218 template <class ART>
1219 void expandRGridDimension(std::ostream &out,
1220 DArray<ART> const & fields,
1221 IntVec<2> const & meshDimensions,
1222 UnitCell<2> const & unitCell,
1223 int d,
1224 DArray<int> newGridDimensions)
1225 {
1226 // 2D expanded to 3D
1227
1228 // Check validity of expanded dimension d and newGridDimensions
1229 UTIL_CHECK(d == 3);
1230 UTIL_CHECK(newGridDimensions.capacity() == 1);
1231
1232 // Obtain number of monomer types
1233 int nMonomer = fields.capacity();
1234 UTIL_CHECK(nMonomer > 0);
1235
1236 // Set dimensions of mesh for replicated fields
1237 IntVec<3> dimensions;
1238 dimensions[0] = meshDimensions[0];
1239 dimensions[1] = meshDimensions[1];
1240 dimensions[2] = newGridDimensions[0];
1241
1242 // Set unit cell for replicated fields
1243 UnitCell<3> cell;
1244 FSArray<double, 6> cellParameters;
1245 cellParameters.append(unitCell.parameter(0));
1246 if (unitCell.lattice() == UnitCell<2>::Square) {
1247 if (newGridDimensions[0] == meshDimensions[0]){
1248 cell.set(UnitCell<3>::Cubic, cellParameters);
1249 } else {
1250 cellParameters.append((double)dimensions[2]/dimensions[0]
1251 * cellParameters[0]);
1252 cell.set(UnitCell<3>::Tetragonal, cellParameters);
1253 }
1254 } else if (unitCell.lattice() == UnitCell<2>::Rectangular) {
1255 cellParameters.append(unitCell.parameter(1));
1256 cellParameters.append((double)dimensions[2]/dimensions[0]
1257 * cellParameters[0]);
1258 cell.set(UnitCell<3>::Orthorhombic, cellParameters);
1259 } else if (unitCell.lattice() == UnitCell<2>::Hexagonal){
1260 cellParameters.append((double)dimensions[2]/dimensions[0]
1261 * cellParameters[0]);
1262 cell.set(UnitCell<3>::Hexagonal, cellParameters);
1263 } else if (unitCell.lattice() == UnitCell<2>::Rhombic) {
1264 cellParameters.append(unitCell.parameter(0));
1265 cellParameters.append((double)dimensions[2]/dimensions[0]
1266 * cellParameters[0]);
1267 cellParameters.append(Constants::Pi / 2);
1268 cellParameters.append(0.0);
1269 cellParameters.append(unitCell.parameter(1));
1270 cell.set(UnitCell<3>::Triclinic, cellParameters);
1271 } else if (unitCell.lattice() == UnitCell<2>::Oblique) {
1272 cellParameters.append(unitCell.parameter(1));
1273 cellParameters.append((double)dimensions[2]/dimensions[0]
1274 * cellParameters[0]);
1275 cellParameters.append(Constants::Pi / 2);
1276 cellParameters.append(0.0);
1277 cellParameters.append(unitCell.parameter(2));
1278 cell.set(UnitCell<3>::Triclinic, cellParameters);
1279 } else {
1280 UTIL_THROW("Unrecognized 2D lattice system.");
1281 }
1282
1283 // Write Header
1284 int v1 = 1;
1285 int v2 = 0;
1286 std::string gName = "";
1287 Pscf::Prdc::writeFieldHeader(out, v1, v2, cell, gName, nMonomer);
1288 out << "mesh " << std::endl
1289 << " " << dimensions << std::endl;
1290
1291 // Write expanded fields
1292 int nReplica = newGridDimensions[0];
1293 MeshIteratorFortran<2> iter(meshDimensions);
1294 int rank;
1295 for (int i = 0; i < nReplica; ++i) {
1296 for (iter.begin(); !iter.atEnd(); ++iter) {
1297 rank = iter.rank();
1298 for (int j = 0; j < nMonomer; ++j) {
1299 out << " " << Dbl(fields[j][rank], 21, 13);
1300 }
1301 out << std::endl;
1302 }
1303 }
1304
1305 }
1306
1307 template <class ART>
1308 void expandRGridDimension(std::ostream &out,
1309 DArray<ART> const & fields,
1310 IntVec<3> const & meshDimensions,
1311 UnitCell<3> const & unitCell,
1312 int d,
1313 DArray<int> newGridDimensions)
1314
1315 { UTIL_THROW("expandRGridDimension is invalid when D = 3."); }
1316
1317} // namespace Prdc
1318} // namespace Pscf
1319#endif
An IntVec<D, T> is a D-component vector of elements of integer type T.
Definition IntVec.h:27
Iterator over points in a mesh in "Fortran" order.
Description of a regular grid of points in a periodic domain.
IntVec< D > dimensions() const
Get an IntVec<D> of the grid dimensions.
Definition Mesh.h:217
int shift(int &coordinate, int i) const
Shift a periodic coordinate into range.
Definition Mesh.tpp:131
A list of wavevectors that are related by space-group symmetries.
Definition Basis.h:446
int basisId
Index of basis function associated with this star.
Definition Basis.h:527
IntVec< D > waveBz
Integer indices indicesBz of a characteristic wave of this star.
Definition Basis.h:508
int invertFlag
Index for inversion symmetry of star.
Definition Basis.h:495
int size
Number of wavevectors in this star.
Definition Basis.h:453
int beginId
Wave index of first wavevector in star.
Definition Basis.h:458
bool cancel
Is this star cancelled, i.e., associated with a zero function?
Definition Basis.h:542
std::complex< double > coeff
Coefficient of wave within the associated star basis function.
Definition Basis.h:362
int starId
Index of the star that contains this wavevector.
Definition Basis.h:391
Symmetry-adapted Fourier basis for pseudo-spectral scft.
Definition fieldIoUtil.h:21
Wave const & wave(int id) const
Get a specific Wave, access by integer index.
Definition Basis.h:819
int waveId(IntVec< D > vector) const
Get the integer index of a wave, as required by wave(int id).
Definition Basis.h:833
int nStar() const
Total number of stars.
Definition Basis.h:814
bool isInitialized() const
Returns true iff this basis is fully initialized.
Definition Basis.h:841
Star const & star(int id) const
Get a Star, accessed by integer star index.
Definition Basis.h:824
Base template for UnitCell<D> classes, D=1, 2 or 3.
Definition rpg/System.h:34
Vec< D, T > & negate(const Vec< D, T > &v)
Return negative of vector v.
Definition Vec.h:520
int capacity() const
Return allocated size.
Definition Array.h:159
static const double Pi
Trigonometric constant Pi.
Definition Constants.h:35
Dynamically allocatable contiguous array template.
void allocate(int capacity)
Allocate the underlying C array.
Definition DArray.h:199
bool isAllocated() const
Return true if this DArray has been allocated, false otherwise.
Definition DArray.h:247
Wrapper for a double precision number, for formatted ostream output.
Definition Dbl.h:40
A fixed capacity (static) contiguous array with a variable logical size.
Definition rpg/System.h:28
void append(Data const &data)
Append data to the end of the array.
Definition FSArray.h:258
Wrapper for an int, for formatted ostream output.
Definition Int.h:37
static std::ostream & file()
Get log ostream by reference.
Definition Log.cpp:57
#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
void writeFieldHeader(std::ostream &out, int ver1, int ver2, UnitCell< D > const &cell, std::string const &groupName, int nMonomer)
Write common part of field header (fortran PSCF format).
void replicateUnitCell(std::ostream &out, DArray< AT > const &fields, IntVec< D > const &meshDimensions, UnitCell< D > const &unitCell, IntVec< D > const &replicas)
Write r-grid fields in a replicated unit cell to std::ostream.
void writeKGridData(std::ostream &out, DArray< AT > const &fields, int nMonomer, IntVec< D > const &dftDimensions)
Write data for array of k-grid fields, with no header section.
void writeNBasis(std::ostream &out, int nBasis)
Write the number of basis functions to a basis field file header.
bool hasSymmetry(AT const &in, Basis< D > const &basis, IntVec< D > const &dftDimensions, double epsilon=1.0e-8, bool verbose=true)
Check if a k-grid field has the declared space group symmetry.
void inspectArrays(DArray< AT > const &arrays, int &nMonomer, int &capacity)
Inspect dimensions of a DArray of 1D arrays, each of type AT.
void inspectFields(DArray< FT > const &fields, int &nMonomer, IntVec< D > &dimensions)
Inspect dimensions of a DArray of fields, each of type FT.
void checkAllocateArrays(DArray< AT > &arrays, int nMonomer, int capacity)
Check allocation of a DArray of 1D arrays, allocate if necessary.
void readKGridData(std::istream &in, DArray< AT > &fields, int nMonomer, IntVec< D > const &dftDimensions)
Read data for array of k-grid fields, with no header section.
void convertBasisToKGrid(DArray< double > const &components, AT &dft, Basis< D > const &basis, IntVec< D > const &dftDimensions)
Convert a real field from symmetrized basis to Fourier grid.
void writeMeshDimensions(std::ostream &out, IntVec< D > const &meshDimensions)
Write mesh dimensions to a field file header.
void expandRGridDimension(std::ostream &out, DArray< AT > const &fields, IntVec< D > const &meshDimensions, UnitCell< D > const &unitCell, int d, DArray< int > newGridDimensions)
Expand the dimensionality of space from D to d.
void writeRGridData(std::ostream &out, DArray< AT > const &fields, int nMonomer, IntVec< D > const &dimensions)
Write data for array of r-grid fields, with no header section.
void convertKGridToBasis(AT const &in, DArray< double > &out, Basis< D > const &basis, IntVec< D > const &dftDimensions, bool checkSymmetry=true, double epsilon=1.0e-8)
Convert a real field from Fourier grid to symmetrized basis.
int readNBasis(std::istream &in)
Read the number of basis functions from a basis field file header.
void readRGridData(std::istream &in, DArray< AT > &fields, int nMonomer, IntVec< D > const &dimensions)
Read data for array of r-grid fields, with no header section.
void readMeshDimensions(std::istream &in, IntVec< D > const &meshDimensions)
Read mesh dimensions from a field file header.
void writeBasisData(std::ostream &out, DArray< DArray< double > > const &fields, Basis< D > const &basis)
Write array of fields in basis format, without a header.
void readBasisData(std::istream &in, DArray< DArray< double > > &fields, UnitCell< D > const &unitCell, Mesh< D > const &mesh, Basis< D > const &basis, int nStarIn)
Read a set of fields in basis format.
void checkAllocateFields(DArray< FT > &fields, int nMonomer, IntVec< D > const &dimensions)
Check allocation of an array of fields, allocate if necessary.
void checkAllocateField(FT &field, IntVec< D > const &dimensions)
Check allocation of a single field, allocate if necessary.
RT imag(CT const &a)
Return the imaginary part of a complex number.
void assign(CT &z, RT const &a, RT const &b)
Create a complex number from real and imaginary parts, z = a + ib.
RT real(CT const &a)
Return the real part of a complex number.
PSCF package top-level namespace.
Definition param_pc.dox:1