MaMiCo 1.2
Loading...
Searching...
No Matches
LBCouetteSolver.h
1// Copyright (C) 2015 Technische Universitaet Muenchen
2// This file is part of the Mamico project. For conditions of distribution
3// and use, please see the copyright notice in Mamico's main folder
4#ifndef _MOLECULARDYNAMICS_COUPLING_SOLVERS_LBCOUETTESOLVER_H_
5#define _MOLECULARDYNAMICS_COUPLING_SOLVERS_LBCOUETTESOLVER_H_
6
7namespace coupling {
8namespace solvers {
11} // namespace solvers
12} // namespace coupling
13
14#if defined(_OPENMP)
15#include <omp.h>
16#endif
17#include "coupling/interface/PintableMacroSolver.h"
18#include "coupling/solvers/NumericalSolver.h"
19#include <cmath>
20
22public:
23 LBCouetteSolverState(int size) : _pdf(size, 0) {}
24
25 LBCouetteSolverState(int size, double* pdf) : LBCouetteSolverState(size) { std::copy(pdf, pdf + size, _pdf.data()); }
26
27 std::unique_ptr<State> clone() const override { return std::make_unique<LBCouetteSolverState>(*this); }
28
29 ~LBCouetteSolverState() {}
30
31 int getSizeBytes() const override { return sizeof(double) * _pdf.size(); }
32
33 std::unique_ptr<State> operator+(const State& rhs) override;
34 std::unique_ptr<State> operator-(const State& rhs) override;
35
36 bool operator==(const State& rhs) const override {
37 const LBCouetteSolverState* other = dynamic_cast<const LBCouetteSolverState*>(&rhs);
38 if (other == nullptr)
39 return false;
40 return _pdf == other->_pdf;
41 }
42
43 double* getData() override { return _pdf.data(); }
44 const double* getData() const override { return _pdf.data(); }
45
46 void print(std::ostream& os) const override { os << "<LBCouetteSolverState instance with size " << getSizeBytes() << ">"; }
47
48private:
49 std::vector<double> _pdf;
50};
51
57public:
72 LBCouetteSolver(const double channelheight, tarch::la::Vector<3, double> wallVelocity, const double kinVisc, const double dx, const double dt,
73 const int plotEveryTimestep, const std::string filestem, const tarch::la::Vector<3, unsigned int> processes,
74 const unsigned int numThreads = 1, const Scenario* scen = nullptr)
75 : coupling::solvers::NumericalSolver(channelheight, dx, dt, kinVisc, plotEveryTimestep, filestem, processes, scen), _mode(Mode::coupling), _dt_pint(dt),
76 _omega(1.0 / (3.0 * (kinVisc * dt / (dx * dx)) + 0.5)), _wallVelocity((dt / dx) * wallVelocity) {
77 // return if required
78 if (skipRank()) {
79 return;
80 }
81 _pdfsize = 19 * (_domainSizeX + 2) * (_domainSizeY + 2) * (_domainSizeZ + 2);
82 _pdf1 = new double[_pdfsize];
83 _pdf2 = new double[_pdfsize];
84#if defined(_OPENMP)
85 omp_set_num_threads(numThreads);
86#endif
87#if (COUPLING_MD_DEBUG == COUPLING_MD_YES)
88 std::cout << "Domain size=" << _domainSizeX << "," << _domainSizeY << "," << _domainSizeZ << std::endl;
89 std::cout << "tau=" << 1.0 / _omega << std::endl;
90 std::cout << "wallVelocity=" << _wallVelocity << std::endl;
91 for (int z = 0; z < _domainSizeZ + 2; z++) {
92 for (int y = 0; y < _domainSizeY + 2; y++) {
93 for (int x = 0; x < _domainSizeX + 2; x++) {
94 std::cout << x << "," << y << "," << z << "FLAG=" << _flag[get(x, y, z)] << std::endl;
95 }
96 }
97 }
98#endif
99 // check pointers
100 if ((_pdf1 == NULL) || (_pdf2 == NULL) || (_vel == NULL) || (_density == NULL) || (_flag == NULL)) {
101 std::cout << "ERROR LBCouetteSolver: NULL ptr!" << std::endl;
102 exit(EXIT_FAILURE);
103 }
104#if (COUPLING_MD_PARALLEL == COUPLING_MD_YES)
105 if ((_sendBufferX == NULL) || (_recvBufferX == NULL) || (_sendBufferY == NULL) || (_recvBufferY == NULL) || (_sendBufferZ == NULL) ||
106 (_recvBufferZ == NULL)) {
107 std::cout << "ERROR LBCouetteSolver: NULL ptr in send/recv!" << std::endl;
108 exit(EXIT_FAILURE);
109 }
110#endif
111// init everything with lattice weights
112#pragma omp parallel for
113 for (int i = 0; i < (_domainSizeX + 2) * (_domainSizeY + 2) * (_domainSizeZ + 2); i++) {
114 for (int q = 0; q < 19; q++) {
115 _pdf1[get(i) * 19 + q] = _W[q];
116 _pdf2[get(i) * 19 + q] = _W[q];
117 }
118 }
119 computeDensityAndVelocityEverywhere();
120 }
121
124 if (_pdf1 != NULL) {
125 delete[] _pdf1;
126 _pdf1 = NULL;
127 }
128 if (_pdf2 != NULL) {
129 delete[] _pdf2;
130 _pdf2 = NULL;
131 }
132 if (_vel != NULL) {
133 delete[] _vel;
134 _vel = NULL;
135 }
136 if (_density != NULL) {
137 delete[] _density;
138 _density = NULL;
139 }
140 if (_flag != NULL) {
141 delete[] _flag;
142 _flag = NULL;
143 }
144#if (COUPLING_MD_PARALLEL == COUPLING_MD_YES)
145 if (_sendBufferX != NULL) {
146 delete[] _sendBufferX;
147 _sendBufferX = NULL;
148 }
149 if (_sendBufferY != NULL) {
150 delete[] _sendBufferY;
151 _sendBufferY = NULL;
152 }
153 if (_sendBufferZ != NULL) {
154 delete[] _sendBufferZ;
155 _sendBufferZ = NULL;
156 }
157 if (_recvBufferX != NULL) {
158 delete[] _recvBufferX;
159 _recvBufferX = NULL;
160 }
161 if (_recvBufferY != NULL) {
162 delete[] _recvBufferY;
163 _recvBufferY = NULL;
164 }
165 if (_recvBufferZ != NULL) {
166 delete[] _recvBufferZ;
167 _recvBufferZ = NULL;
168 }
169#endif
170 }
171
174 void advance(double dt) override {
175 if (skipRank()) {
176 return;
177 }
178 const int timesteps = floor(dt / _dt + 0.5);
179 if (fabs(timesteps * _dt - dt) / _dt > 1.0e-8) {
180 std::cout << "ERROR LBCouetteSolver::advance(): time steps and dt do not match!" << std::endl;
181 exit(EXIT_FAILURE);
182 }
183 for (int i = 0; i < timesteps; i++) {
185 computeDensityAndVelocityEverywhere();
186 plot();
188 communicate(); // exchange between neighbouring MPI subdomains
189 _counter++;
190 }
191 }
192
198 if (skipRank()) {
199 return;
200 }
201#if (COUPLING_MD_ERROR == COUPLING_MD_YES)
202 if (_mode == Mode::supervising) {
203 std::cout << "ERROR LBCouetteSolver setMDBoundaryValues() called in supervising mode" << std::endl;
204 exit(EXIT_FAILURE);
205 }
206#endif
207
208 // loop over all received cells
209 for (auto pair : md2macroBuffer) {
210 I01 idx;
212 std::tie(couplingCell, idx) = pair;
213 // determine cell index of this cell in LB domain
214 tarch::la::Vector<3, unsigned int> globalCellCoords{idx.get()};
215 globalCellCoords[0] = (globalCellCoords[0] + _offset[0]) - _coords[0] * _avgDomainSizeX;
216 globalCellCoords[1] = (globalCellCoords[1] + _offset[1]) - _coords[1] * _avgDomainSizeY;
217 globalCellCoords[2] = (globalCellCoords[2] + _offset[2]) - _coords[2] * _avgDomainSizeZ;
218#if (COUPLING_MD_DEBUG == COUPLING_MD_YES)
219 std::cout << "Process coords: " << _coords << ": GlobalCellCoords for index " << idx << ": " << globalCellCoords << std::endl;
220#endif
221 const int index = get(globalCellCoords[0], globalCellCoords[1], globalCellCoords[2]);
222#if (COUPLING_MD_ERROR == COUPLING_MD_YES)
223 if (_flag[index] != MD_BOUNDARY) {
224 std::cout << "ERROR LBCouetteSolver::setMDBoundaryValues(): Cell " << index << " is no MD boundary cell!" << std::endl;
225 exit(EXIT_FAILURE);
226 }
227#endif
228 // set velocity value and pdfs in MD boundary cell (before streaming); the
229 // boundary velocities are interpolated between the neighbouring and this
230 // cell. This interpolation is valid for FLUID-MD_BOUNDARY neighbouring
231 // relations only. determine local velocity received from MaMiCo and
232 // convert it to LB units; store the velocity in _vel
233 tarch::la::Vector<3, double> localVel((1.0 / couplingCell->getMacroscopicMass()) * (_dt / _dx) * couplingCell->getMacroscopicMomentum());
234 for (unsigned int d = 0; d < 3; d++) {
235 _vel[3 * index + d] = localVel[d];
236 }
237 // loop over all pdfs and set them according to interpolated moving-wall
238 // conditions
239 for (unsigned int q = 0; q < 19; q++) {
240 // index of neighbour cell; only if cell is located inside local domain
241 if (((int)globalCellCoords[0] + _C[q][0] > 0) && ((int)globalCellCoords[0] + _C[q][0] < _domainSizeX + 1) &&
242 ((int)globalCellCoords[1] + _C[q][1] > 0) && ((int)globalCellCoords[1] + _C[q][1] < _domainSizeY + 1) &&
243 ((int)globalCellCoords[2] + _C[q][2] > 0) && ((int)globalCellCoords[2] + _C[q][2] < _domainSizeZ + 1)) {
244 const int nbIndex = get((_C[q][0] + globalCellCoords[0]), (_C[q][1] + globalCellCoords[1]), (_C[q][2] + globalCellCoords[2]));
245 const tarch::la::Vector<3, double> interpolVel(0.5 * (_vel[3 * index] + _vel[3 * nbIndex]), 0.5 * (_vel[3 * index + 1] + _vel[3 * nbIndex + 1]),
246 0.5 * (_vel[3 * index + 2] + _vel[3 * nbIndex + 2]));
247 _pdf1[19 * index + q] =
248 _pdf1[19 * nbIndex + 18 - q] -
249 6.0 * _W[q] * _density[nbIndex] * (_C[18 - q][0] * interpolVel[0] + _C[18 - q][1] * interpolVel[1] + _C[18 - q][2] * interpolVel[2]);
250 }
251 }
252 }
253 }
254
261 // check pos-data for process locality (todo: put this in debug mode in
262 // future releases)
263 if ((pos[0] < domainOffset[0]) || (pos[0] > domainOffset[0] + _domainSizeX * _dx) || (pos[1] < domainOffset[1]) ||
264 (pos[1] > domainOffset[1] + _domainSizeY * _dx) || (pos[2] < domainOffset[2]) || (pos[2] > domainOffset[2] + _domainSizeZ * _dx)) {
265 std::cout << "ERROR LBCouetteSolver::getVelocity(): Position " << pos << " out of range!" << std::endl;
266 std::cout << "domainOffset = " << domainOffset << std::endl;
267 std::cout << "_domainSizeX = " << _domainSizeX << std::endl;
268 std::cout << "_domainSizeY = " << _domainSizeY << std::endl;
269 std::cout << "_domainSizeZ = " << _domainSizeZ << std::endl;
270 std::cout << "_dx = " << _dx << std::endl;
271 exit(EXIT_FAILURE);
272 }
273 // compute index for respective cell (_dx+... for ghost cells); use coords
274 // to store local cell coordinates
275 for (unsigned int d = 0; d < 3; d++) {
276 coords[d] = (unsigned int)((_dx + pos[d] - domainOffset[d]) / _dx);
277 }
278 const int index = get(coords[0], coords[1], coords[2]);
280 // extract and scale velocity to "real"=MD units
281 for (int d = 0; d < 3; d++) {
282 vel[d] = _dx / _dt * _vel[3 * index + d];
283 }
284#if (COUPLING_MD_DEBUG == COUPLING_MD_YES)
285 std::cout << "Position " << pos << " corresponds to cell: " << coords << "; vel=" << vel << std::endl;
286#endif
287 return vel;
288 }
289
293 double getDensity(tarch::la::Vector<3, double> pos) const override {
296 // check pos-data for process locality (todo: put this in debug mode in
297 // future releases)
298 if ((pos[0] < domainOffset[0]) || (pos[0] > domainOffset[0] + _domainSizeX * _dx) || (pos[1] < domainOffset[1]) ||
299 (pos[1] > domainOffset[1] + _domainSizeY * _dx) || (pos[2] < domainOffset[2]) || (pos[2] > domainOffset[2] + _domainSizeZ * _dx)) {
300 std::cout << "ERROR LBCouetteSolver::getDensity(): Position " << pos << " out of range!" << std::endl;
301 exit(EXIT_FAILURE);
302 }
303 // compute index for respective cell (_dx+... for ghost cells); use coords
304 // to store local cell coordinates
305 for (unsigned int d = 0; d < 3; d++) {
306 coords[d] = (unsigned int)((_dx + pos[d] - domainOffset[d]) / _dx);
307 }
308 const int index = get(coords[0], coords[1], coords[2]);
309 return _density[index];
310 }
311
314 virtual void setWallVelocity(const tarch::la::Vector<3, double> wallVelocity) override { _wallVelocity = (_dt / _dx) * wallVelocity; }
315
319
320 std::unique_ptr<State> getState() override {
321 computeDensityAndVelocityEverywhere();
322 return std::make_unique<LBCouetteSolverState>(_pdfsize, _pdf1);
323 }
324
325 void setState(const std::unique_ptr<State>& input, int cycle) override {
326 const LBCouetteSolverState* state = dynamic_cast<const LBCouetteSolverState*>(input.get());
327
328#if (COUPLING_MD_ERROR == COUPLING_MD_YES)
329 if (state == nullptr) {
330 std::cout << "ERROR LBCouetteSolver setState() wrong state type" << std::endl;
331 exit(EXIT_FAILURE);
332 }
333#endif
334
335 std::copy(state->getData(), state->getData() + _pdfsize, _pdf1);
336 computeDensityAndVelocityEverywhere();
337
338 _counter = cycle;
339 }
340
341 std::unique_ptr<State> operator()(const std::unique_ptr<State>& input, int cycle) override {
342 setState(input, cycle);
343
344#if (COUPLING_MD_ERROR == COUPLING_MD_YES)
345 if (_mode != Mode::supervising) {
346 std::cout << "ERROR LBCouetteSolver operator() called but not in supervising mode" << std::endl;
347 exit(EXIT_FAILURE);
348 }
349#endif
350
351 advance(_dt_pint);
352 return getState();
353 }
354
355 Mode getMode() const override { return _mode; }
356
363 std::unique_ptr<PintableMacroSolver> getSupervisor(int num_cycles, double visc_multiplier) const override {
364#if (COUPLING_MD_ERROR == COUPLING_MD_YES)
365 if (_mode == Mode::supervising) {
366 std::cout << "ERROR LBCouetteSolver getSupervisor(): already in supervising mode" << std::endl;
367 exit(EXIT_FAILURE);
368 }
369#endif
370
371 int numThreads = 1;
372#if defined(_OPENMP)
373 numThreads = omp_get_num_threads();
374#endif
375
376 auto res = std::make_unique<LBCouetteSolver>(_channelheight, _wallVelocity * _dx / _dt, _kinVisc * visc_multiplier, _dx, _dt, _plotEveryTimestep,
377 _filestem + std::string("_supervising"), _processes, numThreads, _scen);
378
379 res->_mode = Mode::supervising;
380 res->_dt_pint = _dt * num_cycles;
381
382 return res;
383 }
384
385 void print(std::ostream& os) const override {
386 if (_mode == Mode::supervising)
387 os << "<LBCouetteSolver instance in supervising mode >";
388 if (_mode == Mode::coupling)
389 os << "<LBCouetteSolver instance in coupling mode >";
390 }
391
392 double get_avg_vel(const std::unique_ptr<State>& state) const override {
393 double vel[3];
394 double density;
395 double res[3]{0, 0, 0};
396 for (int i = 0; i < _pdfsize; i += 19) {
397 LBCouetteSolver::computeDensityAndVelocity(vel, density, state->getData() + i);
398 res[0] += vel[0];
399 res[1] += vel[1];
400 res[2] += vel[2];
401 }
402 if (_pdfsize > 0) {
403 res[0] /= (_pdfsize / 19);
404 res[1] /= (_pdfsize / 19);
405 res[2] /= (_pdfsize / 19);
406 }
407 return std::sqrt(res[0] * res[0] + res[1] * res[1] + res[2] * res[2]);
408 }
409
410private:
411 Mode _mode;
412 double _dt_pint;
413
414 void computeDensityAndVelocityEverywhere() {
415 if (skipRank())
416 return;
417 for (int z = 1; z < _domainSizeZ + 1; z++) {
418 for (int y = 1; y < _domainSizeY + 1; y++) {
419 for (int x = 1; x < _domainSizeX + 1; x++) {
420 const int index = get(x, y, z);
421 const int pI = 19 * index;
422 double* vel = &_vel[3 * index];
423 computeDensityAndVelocity(vel, _density[index], &_pdf1[pI]);
424 }
425 }
426 }
427 }
428
432
436#pragma omp parallel for
437 for (int z = 1; z < _domainSizeZ + 1; z++) {
438 for (int y = 1; y < _domainSizeY + 1; y++) {
439 for (int x = 1; x < _domainSizeX + 1; x++) {
440 const int index = get(x, y, z);
441 if (_flag[index] == FLUID) {
442 stream(index);
443 collide(index, x, y, z);
444 }
445 }
446 }
447 }
448 // swap fields
449 double* swap = _pdf1;
450 _pdf1 = _pdf2;
451 _pdf2 = swap;
452 }
453
455 void stream(int index) {
456 const int pI = 19 * index;
457 for (int q = 0; q < 9; q++) {
458 const int nb = 19 * (_C[q][0] + _C[q][1] * _xO + _C[q][2] * _yO);
459 _pdf2[pI + q] = _pdf1[pI + q - nb];
460 _pdf2[pI + 18 - q] = _pdf1[pI + 18 - q + nb];
461 }
462 _pdf2[pI + 9] = _pdf1[pI + 9];
463 }
464
466 void collide(int index, int x, int y, int z) {
467 // index of start of cell-local pdfs in AoS
468 const int pI = 19 * index;
469 // compute and store density, velocity
470 double* vel = &_vel[3 * index];
471 computeDensityAndVelocity(vel, _density[index], &_pdf2[pI]);
472 // collide (BGK); always handle pdfs no. q and inv(q)=18-q in one step
473 const double u2 = 1.0 - 1.5 * (vel[0] * vel[0] + vel[1] * vel[1] + vel[2] * vel[2]);
474 // pdf 0,18
475 double cu = -vel[1] - vel[2];
476 int nb = -_xO - _yO;
477 double feq = _W[0] * _density[index] * (u2 + 3.0 * cu + 4.5 * cu * cu);
478 _pdf2[pI] -= _omega * (_pdf2[pI] - feq);
479 boundary(_pdf2, pI, x, y, z, 0, _flag[index + nb], pI + 19 * nb);
480 feq -= 6.0 * _W[0] * _density[index] * cu;
481 _pdf2[pI + 18] -= _omega * (_pdf2[pI + 18] - feq);
482 boundary(_pdf2, pI, x, y, z, 18, _flag[index - nb], pI - 19 * nb);
483 // pdf 1,17
484 cu = -vel[0] - vel[2];
485 nb = -1 - _yO;
486 feq = _W[1] * _density[index] * (u2 + 3.0 * cu + 4.5 * cu * cu);
487 _pdf2[pI + 1] -= _omega * (_pdf2[pI + 1] - feq);
488 boundary(_pdf2, pI, x, y, z, 1, _flag[index + nb], pI + 19 * nb);
489 feq -= 6.0 * _W[1] * _density[index] * cu;
490 _pdf2[pI + 17] -= _omega * (_pdf2[pI + 17] - feq);
491 boundary(_pdf2, pI, x, y, z, 17, _flag[index - nb], pI - 19 * nb);
492 // pdf 2,16
493 cu = -vel[2];
494 nb = -_yO;
495 feq = _W[2] * _density[index] * (u2 + 3.0 * cu + 4.5 * cu * cu);
496 _pdf2[pI + 2] -= _omega * (_pdf2[pI + 2] - feq);
497 boundary(_pdf2, pI, x, y, z, 2, _flag[index + nb], pI + 19 * nb);
498 feq -= 6.0 * _W[2] * _density[index] * cu;
499 _pdf2[pI + 16] -= _omega * (_pdf2[pI + 16] - feq);
500 boundary(_pdf2, pI, x, y, z, 16, _flag[index - nb], pI - 19 * nb);
501 // pdf 3,15
502 cu = vel[0] - vel[2];
503 nb = 1 - _yO;
504 feq = _W[3] * _density[index] * (u2 + 3.0 * cu + 4.5 * cu * cu);
505 _pdf2[pI + 3] -= _omega * (_pdf2[pI + 3] - feq);
506 boundary(_pdf2, pI, x, y, z, 3, _flag[index + nb], pI + 19 * nb);
507 feq -= 6.0 * _W[3] * _density[index] * cu;
508 _pdf2[pI + 15] -= _omega * (_pdf2[pI + 15] - feq);
509 boundary(_pdf2, pI, x, y, z, 15, _flag[index - nb], pI - 19 * nb);
510 // pdf 4,14
511 cu = vel[1] - vel[2];
512 nb = _xO - _yO;
513 feq = _W[4] * _density[index] * (u2 + 3.0 * cu + 4.5 * cu * cu);
514 _pdf2[pI + 4] -= _omega * (_pdf2[pI + 4] - feq);
515 boundary(_pdf2, pI, x, y, z, 4, _flag[index + nb], pI + 19 * nb);
516 feq -= 6.0 * _W[4] * _density[index] * cu;
517 _pdf2[pI + 14] -= _omega * (_pdf2[pI + 14] - feq);
518 boundary(_pdf2, pI, x, y, z, 14, _flag[index - nb], pI - 19 * nb);
519 // pdf 5,13
520 cu = -vel[0] - vel[1];
521 nb = -1 - _xO;
522 feq = _W[5] * _density[index] * (u2 + 3.0 * cu + 4.5 * cu * cu);
523 _pdf2[pI + 5] -= _omega * (_pdf2[pI + 5] - feq);
524 boundary(_pdf2, pI, x, y, z, 5, _flag[index + nb], pI + 19 * nb);
525 feq -= 6.0 * _W[5] * _density[index] * cu;
526 _pdf2[pI + 13] -= _omega * (_pdf2[pI + 13] - feq);
527 boundary(_pdf2, pI, x, y, z, 13, _flag[index - nb], pI - 19 * nb);
528 // pdf 6,12
529 cu = -vel[1];
530 nb = -_xO;
531 feq = _W[6] * _density[index] * (u2 + 3.0 * cu + 4.5 * cu * cu);
532 _pdf2[pI + 6] -= _omega * (_pdf2[pI + 6] - feq);
533 boundary(_pdf2, pI, x, y, z, 6, _flag[index + nb], pI + 19 * nb);
534 feq -= 6.0 * _W[6] * _density[index] * cu;
535 _pdf2[pI + 12] -= _omega * (_pdf2[pI + 12] - feq);
536 boundary(_pdf2, pI, x, y, z, 12, _flag[index - nb], pI - 19 * nb);
537 // pdf 7,11
538 cu = vel[0] - vel[1];
539 nb = 1 - _xO;
540 feq = _W[7] * _density[index] * (u2 + 3.0 * cu + 4.5 * cu * cu);
541 _pdf2[pI + 7] -= _omega * (_pdf2[pI + 7] - feq);
542 boundary(_pdf2, pI, x, y, z, 7, _flag[index + nb], pI + 19 * nb);
543 feq -= 6.0 * _W[7] * _density[index] * cu;
544 _pdf2[pI + 11] -= _omega * (_pdf2[pI + 11] - feq);
545 boundary(_pdf2, pI, x, y, z, 11, _flag[index - nb], pI - 19 * nb);
546 // pdf 8,10
547 cu = -vel[0];
548 nb = -1;
549 feq = _W[8] * _density[index] * (u2 + 3.0 * cu + 4.5 * cu * cu);
550 _pdf2[pI + 8] -= _omega * (_pdf2[pI + 8] - feq);
551 boundary(_pdf2, pI, x, y, z, 8, _flag[index + nb], pI + 19 * nb);
552 feq -= 6.0 * _W[8] * _density[index] * cu;
553 _pdf2[pI + 10] -= _omega * (_pdf2[pI + 10] - feq);
554 boundary(_pdf2, pI, x, y, z, 10, _flag[index - nb], pI - 19 * nb);
555 // pdf 9
556 _pdf2[pI + 9] -= _omega * (_pdf2[pI + 9] - _W[9] * _density[index] * u2);
557 }
558
568 void boundary(double* const pdf, int index, int x, int y, int z, int q, const Flag& flag, int nbIndex) {
569 if (flag != FLUID) {
570 if (flag == NO_SLIP) {
571 // half-way bounce back
572 pdf[nbIndex + 18 - q] = pdf[index + q];
573 } else if (flag == MOVING_WALL) {
574 // half-way bounce back + moving wall acceleration (only x-direction for
575 // wall supported at the moment)
576 pdf[nbIndex + 18 - q] =
577 pdf[index + q] - 6.0 * _W[q] * _density[index / 19] * (_C[q][0] * _wallVelocity[0] + _C[q][1] * _wallVelocity[1] + _C[q][2] * _wallVelocity[2]);
578 } else if (flag == PERIODIC) {
579 // periodic treatment
580 int target[3] = {x, y, z};
581 if (target[0] + _C[q][0] == 0) {
582 target[0] = _domainSizeX + 1;
583 } else if (target[0] + _C[q][0] == _domainSizeX + 1) {
584 target[0] = 0;
585 }
586 if (target[1] + _C[q][1] == 0) {
587 target[1] = _domainSizeY + 1;
588 } else if (target[1] + _C[q][1] == _domainSizeY + 1) {
589 target[1] = 0;
590 }
591 if (target[2] + _C[q][2] == 0) {
592 target[2] = _domainSizeZ + 1;
593 } else if (target[2] + _C[q][2] == _domainSizeZ + 1) {
594 target[2] = 0;
595 }
596 const int periodicNb = target[0] + (_domainSizeX + 2) * (target[1] + (_domainSizeY + 2) * target[2]);
597 pdf[19 * periodicNb + q] = pdf[index + q];
598 }
599 }
600 }
601
606 static void computeDensityAndVelocity(double* const vel, double& density, const double* const pdf) {
607 vel[0] = -(pdf[1] + pdf[5] + pdf[8] + pdf[11] + pdf[15]);
608 density = pdf[3] + pdf[7] + pdf[10] + pdf[13] + pdf[17];
609 vel[1] = (pdf[4] + pdf[11] + pdf[12] + pdf[13] + pdf[18]) - (pdf[0] + pdf[5] + pdf[6] + pdf[7] + pdf[14]);
610 vel[0] = density + vel[0];
611 density = density + pdf[0] + pdf[1] + pdf[2] + pdf[4] + pdf[5] + pdf[6] + pdf[8] + pdf[9] + pdf[11] + pdf[12] + pdf[14] + pdf[15] + pdf[16] + pdf[18];
612 vel[2] = (pdf[14] + pdf[15] + pdf[16] + pdf[17] + pdf[18]) - (pdf[0] + pdf[1] + pdf[2] + pdf[3] + pdf[4]);
613 vel[0] = vel[0] / density;
614 vel[1] = vel[1] / density;
615 vel[2] = vel[2] / density;
616 }
617
632 void communicatePart(double* pdf, double* sendBuffer, double* recvBuffer, NbFlag nbFlagTo, NbFlag nbFlagFrom, tarch::la::Vector<3, int> startSend,
634#if (COUPLING_MD_PARALLEL == COUPLING_MD_YES)
635 // directions that point to LEFT/RIGHT,... -> same ordering as enums!
636 const int directions[6][5] = {{1, 5, 8, 11, 15}, {3, 7, 10, 13, 17}, {4, 11, 12, 13, 18}, {0, 5, 6, 7, 14}, {0, 1, 2, 3, 4}, {14, 15, 16, 17, 18}};
637 MPI_Request requests[2];
638 MPI_Status status[2];
640 tarch::la::Vector<2, int> domainSize;
641 // find out plane coordinates
642 if (nbFlagTo == LEFT || nbFlagTo == RIGHT) {
643 plane[0] = 1;
644 plane[1] = 2;
645 domainSize[0] = _domainSizeY;
646 domainSize[1] = _domainSizeZ;
647 } else if (nbFlagTo == FRONT || nbFlagTo == BACK) {
648 plane[0] = 0;
649 plane[1] = 2;
650 domainSize[0] = _domainSizeX;
651 domainSize[1] = _domainSizeZ;
652 } else if (nbFlagTo == TOP || nbFlagTo == BOTTOM) {
653 plane[0] = 0;
654 plane[1] = 1;
655 domainSize[0] = _domainSizeX;
656 domainSize[1] = _domainSizeY;
657 } else {
658 std::cout << "ERROR LBCouetteSolver::communicatePart: d >2 or d < 0!" << std::endl;
659 exit(EXIT_FAILURE);
660 }
661 // extract data and write to send buffer
663 for (coords[2] = startSend[2]; coords[2] < endSend[2]; coords[2]++) {
664 for (coords[1] = startSend[1]; coords[1] < endSend[1]; coords[1]++) {
665 for (coords[0] = startSend[0]; coords[0] < endSend[0]; coords[0]++) {
666 for (int q = 0; q < 5; q++) {
667 sendBuffer[q + 5 * getParBuf(coords[plane[0]], coords[plane[1]], domainSize[0], domainSize[1])] =
668 pdf[directions[nbFlagTo][q] + 19 * get(coords[0], coords[1], coords[2])];
669 }
670 }
671 }
672 }
673 // send and receive data
674 MPI_Irecv(recvBuffer, (domainSize[0] + 2) * (domainSize[1] + 2) * 5, MPI_DOUBLE, _parallelNeighbours[nbFlagFrom], 1000,
675 coupling::indexing::IndexingService<3>::getInstance().getComm(), &requests[0]);
676 MPI_Isend(sendBuffer, (domainSize[0] + 2) * (domainSize[1] + 2) * 5, MPI_DOUBLE, _parallelNeighbours[nbFlagTo], 1000,
677 coupling::indexing::IndexingService<3>::getInstance().getComm(), &requests[1]);
678 MPI_Waitall(2, requests, status);
679 // write data back to pdf field
680 if (_parallelNeighbours[nbFlagFrom] != MPI_PROC_NULL) {
681 for (coords[2] = startRecv[2]; coords[2] < endRecv[2]; coords[2]++) {
682 for (coords[1] = startRecv[1]; coords[1] < endRecv[1]; coords[1]++) {
683 for (coords[0] = startRecv[0]; coords[0] < endRecv[0]; coords[0]++) {
684 for (int q = 0; q < 5; q++) {
685 if (_flag[get(coords[0], coords[1], coords[2])] == PARALLEL_BOUNDARY) {
686 pdf[directions[nbFlagTo][q] + 19 * get(coords[0], coords[1], coords[2])] =
687 recvBuffer[q + 5 * getParBuf(coords[plane[0]], coords[plane[1]], domainSize[0], domainSize[1])];
688 }
689 }
690 }
691 }
692 }
693 }
694#endif
695 }
696
699 void communicate() {
700#if (COUPLING_MD_PARALLEL == COUPLING_MD_YES)
701 // send from right to left
705 // send from left to right
709 // send from back to front
713 // send from front to back
717 // send from top to bottom
721 // send from bottom to top
725#endif
726 }
727
729 const double _omega;
732 int _pdfsize{0};
734 double* _pdf1{NULL};
736 double* _pdf2{NULL};
738 const int _C[19][3]{{0, -1, -1}, {-1, 0, -1}, {0, 0, -1}, {1, 0, -1}, {0, 1, -1}, {-1, -1, 0}, {0, -1, 0}, {1, -1, 0}, {-1, 0, 0}, {0, 0, 0},
739 {1, 0, 0}, {-1, 1, 0}, {0, 1, 0}, {1, 1, 0}, {0, -1, 1}, {-1, 0, 1}, {0, 0, 1}, {1, 0, 1}, {0, 1, 1}};
740
741 const double _W[19]{1.0 / 36.0, 1.0 / 36.0, 1.0 / 18.0, 1.0 / 36.0, 1.0 / 36.0, 1.0 / 36.0, 1.0 / 18.0, 1.0 / 36.0, 1.0 / 18.0, 1.0 / 3.0,
742 1.0 / 18.0, 1.0 / 36.0, 1.0 / 18.0, 1.0 / 36.0, 1.0 / 36.0, 1.0 / 36.0, 1.0 / 18.0, 1.0 / 36.0, 1.0 / 36.0};
743};
744
745#endif // _MOLECULARDYNAMICS_COUPLING_SOLVERS_LBCOUETTESOLVER_H_
Definition Scenario.h:15
defines the cell type with cell-averaged quantities only (no linked cells).
Definition CouplingCell.h:29
const tarch::la::Vector< dim, double > & getMacroscopicMomentum() const
Definition CouplingCell.h:64
const double & getMacroscopicMass() const
Definition CouplingCell.h:58
provides access to coupling cells, which may belong to different indexing domains
Definition FlexibleCellContainer.h:30
value_T get() const
Definition CellIndex.h:138
Definition PintableMacroSolver.h:67
Definition PintableMacroSolver.h:30
Definition LBCouetteSolver.h:21
int getSizeBytes() const override
Definition LBCouetteSolver.h:31
std::unique_ptr< State > operator+(const State &rhs) override
const double * getData() const override
Definition LBCouetteSolver.h:44
void print(std::ostream &os) const override
Definition LBCouetteSolver.h:46
std::unique_ptr< State > operator-(const State &rhs) override
bool operator==(const State &rhs) const override
Definition LBCouetteSolver.h:36
double * getData() override
Definition LBCouetteSolver.h:43
implements a three-dimensional Lattice-Boltzmann Couette flow solver.
Definition LBCouetteSolver.h:56
static void computeDensityAndVelocity(double *const vel, double &density, const double *const pdf)
refers to the LB method; computes density and velocity on pdf
Definition LBCouetteSolver.h:606
std::unique_ptr< State > operator()(const std::unique_ptr< State > &input, int cycle) override
Definition LBCouetteSolver.h:341
std::unique_ptr< PintableMacroSolver > getSupervisor(int num_cycles, double visc_multiplier) const override
Definition LBCouetteSolver.h:363
void communicatePart(double *pdf, double *sendBuffer, double *recvBuffer, NbFlag nbFlagTo, NbFlag nbFlagFrom, tarch::la::Vector< 3, int > startSend, tarch::la::Vector< 3, int > endSend, tarch::la::Vector< 3, int > startRecv, tarch::la::Vector< 3, int > endRecv)
Definition LBCouetteSolver.h:632
std::unique_ptr< State > getState() override
Definition LBCouetteSolver.h:320
double get_avg_vel(const std::unique_ptr< State > &state) const override
Definition LBCouetteSolver.h:392
const double _omega
relaxation frequency
Definition LBCouetteSolver.h:729
const int _C[19][3]
lattice velocities
Definition LBCouetteSolver.h:738
void setMDBoundaryValues(coupling::datastructures::FlexibleCellContainer< 3 > &md2macroBuffer) override
applies the values received from the MD-solver within the conntinuum solver
Definition LBCouetteSolver.h:197
double * _pdf1
partical distribution function field
Definition LBCouetteSolver.h:734
void collide(int index, int x, int y, int z)
Definition LBCouetteSolver.h:466
void boundary(double *const pdf, int index, int x, int y, int z, int q, const Flag &flag, int nbIndex)
takes care of the correct boundary treatment for the LB method
Definition LBCouetteSolver.h:568
Mode getMode() const override
Definition LBCouetteSolver.h:355
const double _W[19]
lattice weights
Definition LBCouetteSolver.h:741
void communicate()
comunicates the boundary field data between the different processes
Definition LBCouetteSolver.h:699
tarch::la::Vector< 3, double > getVelocity(tarch::la::Vector< 3, double > pos) const override
returns velocity at a certain position
Definition LBCouetteSolver.h:258
void advance(double dt) override
advances one time step dt in time and triggers vtk plot if required
Definition LBCouetteSolver.h:174
virtual ~LBCouetteSolver()
a simple destructor
Definition LBCouetteSolver.h:123
virtual void setWallVelocity(const tarch::la::Vector< 3, double > wallVelocity) override
changes the velocity at the moving wall (z=0)
Definition LBCouetteSolver.h:314
tarch::la::Vector< 3, double > _wallVelocity
velocity of moving wall of Couette flow
Definition LBCouetteSolver.h:731
void collidestream()
collide-stream algorithm for the Lattice-Boltzmann method
Definition LBCouetteSolver.h:435
void setState(const std::unique_ptr< State > &input, int cycle) override
Definition LBCouetteSolver.h:325
void print(std::ostream &os) const override
Definition LBCouetteSolver.h:385
double * _pdf2
partial distribution function field (stores the old time step)
Definition LBCouetteSolver.h:736
void stream(int index)
the stream part of the LB algorithm (from pdf1 to pdf2)
Definition LBCouetteSolver.h:455
LBCouetteSolver(const double channelheight, tarch::la::Vector< 3, double > wallVelocity, const double kinVisc, const double dx, const double dt, const int plotEveryTimestep, const std::string filestem, const tarch::la::Vector< 3, unsigned int > processes, const unsigned int numThreads=1, const Scenario *scen=nullptr)
a simple constructor
Definition LBCouetteSolver.h:72
double getDensity(tarch::la::Vector< 3, double > pos) const override
returns density at a certain position
Definition LBCouetteSolver.h:293
is a virtual base class for the interface for a numerical fluid solver for the Couette scenario
Definition NumericalSolver.h:33
const int _domainSizeX
domain size in x-direction
Definition NumericalSolver.h:554
double * _recvBufferY
buffer to receive data from from front/back neighbour
Definition NumericalSolver.h:584
double * _sendBufferX
buffer to send data from left/right to right/left neighbour
Definition NumericalSolver.h:578
const double _channelheight
the height and width of the channel in z and y direction
Definition NumericalSolver.h:539
const double _kinVisc
kinematic viscosity of the fluid
Definition NumericalSolver.h:545
int _counter
time step counter
Definition NumericalSolver.h:569
int get(int i) const
returns i and performs checks in debug mode
Definition NumericalSolver.h:360
const int _yO
offset for z-direction
Definition NumericalSolver.h:593
double * _recvBufferZ
buffer to receive data from from top/buttom neighbour
Definition NumericalSolver.h:588
const int _avgDomainSizeZ
avg. domain size in MPI-parallel simulation in z-direction
Definition NumericalSolver.h:564
int getParBuf(int x, int y, int lengthx, int lengthy) const
returns index in 2D parallel buffer with buffer dimensions lengthx+2,lengthy+2. Performs checks in de...
Definition NumericalSolver.h:409
double * _sendBufferY
buffer to send data from front/back to front/back neighbour
Definition NumericalSolver.h:582
const int _xO
offset for y-direction (lexicographic grid ordering)
Definition NumericalSolver.h:591
double * _sendBufferZ
buffer to send data from top/buttom to top/buttom neighbour
Definition NumericalSolver.h:586
NumericalSolver(const double channelheight, const double dx, const double dt, const double kinVisc, const int plotEveryTimestep, const std::string filestem, const tarch::la::Vector< 3, unsigned int > processes, const Scenario *scen=nullptr)
a simple constructor
Definition NumericalSolver.h:46
Flag * _flag
flag field
Definition NumericalSolver.h:575
const int _avgDomainSizeY
avg. domain size in MPI-parallel simulation in y-direction
Definition NumericalSolver.h:562
const tarch::la::Vector< 3, unsigned int > _coords
coordinates of this process (=1,1,1, unless parallel run of the solver )
Definition NumericalSolver.h:567
const int _domainSizeY
domain size in y-direction
Definition NumericalSolver.h:556
const double _dt
time step
Definition NumericalSolver.h:543
tarch::la::Vector< 3, unsigned int > _processes
domain decomposition on MPI rank basis; total number is given by multipling all entries
Definition NumericalSolver.h:548
double * _density
density field
Definition NumericalSolver.h:573
tarch::la::Vector< 6, int > _parallelNeighbours
neighbour ranks
Definition NumericalSolver.h:595
const std::string _filestem
file stem for vtk plot
Definition NumericalSolver.h:552
NbFlag
The flags are used on parallel boundaries to define in which direction the boundary goes.
Definition NumericalSolver.h:530
@ LEFT
a parallel boundary to the left
Definition NumericalSolver.h:531
@ RIGHT
a parallel boundary to the right
Definition NumericalSolver.h:532
@ BOTTOM
a parallel boundary to the bottom
Definition NumericalSolver.h:535
@ FRONT
a parallel boundary to the front
Definition NumericalSolver.h:534
@ TOP
a parallel boundary to the top
Definition NumericalSolver.h:536
@ BACK
a parallel boundary to the back
Definition NumericalSolver.h:533
Flag
for every cell exists a flag entry, upon this is defined how the cell is handled
Definition NumericalSolver.h:519
@ MD_BOUNDARY
a cell on the boundary to md
Definition NumericalSolver.h:524
@ PERIODIC
a cell on a periodic boundary
Definition NumericalSolver.h:523
@ PARALLEL_BOUNDARY
a cell on a inner boundary of a splitted domain in a parallel run
Definition NumericalSolver.h:525
@ NO_SLIP
a cell on the no slip (non-moving) wall
Definition NumericalSolver.h:521
@ FLUID
a normal fluid cell
Definition NumericalSolver.h:520
@ MOVING_WALL
a cell on the moving wall
Definition NumericalSolver.h:522
const int _plotEveryTimestep
number of time steps between vtk plots
Definition NumericalSolver.h:550
double * _vel
velocity field
Definition NumericalSolver.h:571
const int _avgDomainSizeX
avg. domain size in MPI-parallel simulation in x-direction
Definition NumericalSolver.h:560
bool skipRank() const
returns true, if this rank is not of relevance for the LB simulation
Definition NumericalSolver.h:509
double * _recvBufferX
buffer to receive data from from left/right neighbour
Definition NumericalSolver.h:580
tarch::la::Vector< 3, int > _offset
offset of the md domain
Definition NumericalSolver.h:597
const double _dx
mesh size, dx=dy=dz
Definition NumericalSolver.h:541
const int _domainSizeZ
domain size in z-direction
Definition NumericalSolver.h:558
Definition Vector.h:24
all numerical solvers are defined in the namespace, and their interfaces
Definition CouetteSolver.h:14
everything necessary for coupling operations, is defined in here
Definition AdditiveMomentumInsertion.h:15