GenericTracerModel_impl.hpp
Go to the documentation of this file.
1// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*-
2// vi: set et ts=4 sw=4 sts=4:
3/*
4 This file is part of the Open Porous Media project (OPM).
5
6 OPM is free software: you can redistribute it and/or modify
7 it under the terms of the GNU General Public License as published by
8 the Free Software Foundation, either version 2 of the License, or
9 (at your option) any later version.
10
11 OPM is distributed in the hope that it will be useful,
12 but WITHOUT ANY WARRANTY; without even the implied warranty of
13 MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the
14 GNU General Public License for more details.
15
16 You should have received a copy of the GNU General Public License
17 along with OPM. If not, see <http://www.gnu.org/licenses/>.
18
19 Consult the COPYING file in the top-level source directory of this
20 module for the precise wording of the license and the list of
21 copyright holders.
22*/
28#ifndef OPM_GENERIC_TRACER_MODEL_IMPL_HPP
29#define OPM_GENERIC_TRACER_MODEL_IMPL_HPP
30
31#include <dune/istl/operators.hh>
32#include <dune/istl/solvers.hh>
33#include <dune/istl/schwarz.hh>
34#include <dune/istl/preconditioners.hh>
35#include <dune/istl/schwarz.hh>
36
37#include <opm/common/OpmLog/OpmLog.hpp>
38#include <opm/common/TimingMacros.hpp>
39
40#include <opm/grid/CpGrid.hpp>
41
42#include <opm/input/eclipse/EclipseState/EclipseState.hpp>
43#include <opm/input/eclipse/EclipseState/Tables/TracerVdTable.hpp>
44#include <opm/input/eclipse/Schedule/Well/Well.hpp>
45#include <opm/input/eclipse/Schedule/Well/WellTracerProperties.hpp>
46
48
53
54#include <fmt/format.h>
55
56#include <array>
57#include <functional>
58#include <memory>
59#include <set>
60#include <stdexcept>
61#include <string>
62
63namespace Opm {
64
65#if HAVE_MPI
66template<class M, class V>
68{
69 using Comm = Dune::OwnerOverlapCopyCommunication<int, int>;
70 using TracerOperator = Dune::OverlappingSchwarzOperator<M, V, V, Comm>;
72};
74template<class Vector, class Grid, class Matrix>
75std::tuple<std::unique_ptr<Dune::OverlappingSchwarzOperator<Matrix,Vector,Vector,
76 Dune::OwnerOverlapCopyCommunication<int,int>>>,
77 std::unique_ptr<typename TracerSolverSelector<Matrix,Vector>::type>>
78createParallelFlexibleSolver(const Grid&, const Matrix&, const PropertyTree&)
79{
80 OPM_THROW(std::logic_error, "Grid not supported for parallel Tracers.");
81 return {nullptr, nullptr};
82}
84template<class Vector, class Matrix>
85std::tuple<std::unique_ptr<Dune::OverlappingSchwarzOperator<Matrix,Vector,Vector,
86 Dune::OwnerOverlapCopyCommunication<int,int>>>,
87 std::unique_ptr<typename TracerSolverSelector<Matrix,Vector>::type>>
88createParallelFlexibleSolver(const Dune::CpGrid& grid, const Matrix& M, const PropertyTree& prm)
89{
90 using TracerOperator = Dune::OverlappingSchwarzOperator<Matrix,Vector,Vector,
91 Dune::OwnerOverlapCopyCommunication<int,int>>;
92 using TracerSolver = Dune::FlexibleSolver<TracerOperator>;
93 const auto& cellComm = grid.cellCommunication();
94 auto op = std::make_unique<TracerOperator>(M, cellComm);
95 auto dummyWeights = [](){ return Vector();};
96 return {std::move(op), std::make_unique<TracerSolver>(*op, cellComm, prm, dummyWeights, 0)};
97}
98#endif
99
100template<class Grid, class GridView, class DofMapper, class Stencil, class FluidSystem, class Scalar>
102GenericTracerModel(const GridView& gridView,
103 const EclipseState& eclState,
104 const CartesianIndexMapper& cartMapper,
105 const DofMapper& dofMapper,
106 const std::function<std::array<double,dimWorld>(int)> centroids)
107 : gridView_(gridView)
108 , eclState_(eclState)
109 , cartMapper_(cartMapper)
110 , dofMapper_(dofMapper)
111 , centroids_(centroids)
112{
113}
114
115template<class Grid, class GridView, class DofMapper, class Stencil, class FluidSystem, class Scalar>
117freeTracerConcentration(int tracerIdx, int globalDofIdx) const
118{
119 if (freeTracerConcentration_.empty()) {
120 return 0.0;
121 }
122
123 return freeTracerConcentration_[tracerIdx][globalDofIdx];
124}
125
126template<class Grid, class GridView, class DofMapper, class Stencil, class FluidSystem, class Scalar>
128solTracerConcentration(int tracerIdx, int globalDofIdx) const
130 if (solTracerConcentration_.empty()) {
131 return 0.0;
132 }
133
134 return solTracerConcentration_[tracerIdx][globalDofIdx];
136
137template<class Grid, class GridView, class DofMapper, class Stencil, class FluidSystem, class Scalar>
139setFreeTracerConcentration(int tracerIdx, int globalDofIdx, Scalar value)
140{
141 this->freeTracerConcentration_[tracerIdx][globalDofIdx] = value;
142 this->tracerConcentration_[tracerIdx][globalDofIdx][0] = value;
143}
144
145template<class Grid, class GridView, class DofMapper, class Stencil, class FluidSystem, class Scalar>
147setSolTracerConcentration(int tracerIdx, int globalDofIdx, Scalar value)
148{
149 this->solTracerConcentration_[tracerIdx][globalDofIdx] = value;
150 this->tracerConcentration_[tracerIdx][globalDofIdx][1] = value;
151}
152
153template<class Grid, class GridView, class DofMapper, class Stencil, class FluidSystem, class Scalar>
155setEnableSolTracers(int tracerIdx, bool enableSolTracer)
156{
157 this->enableSolTracers_[tracerIdx] = enableSolTracer;
158}
159
160template<class Grid, class GridView, class DofMapper, class Stencil, class FluidSystem, class Scalar>
162numTracers() const
163{
164 return this->eclState_.tracer().size();
165}
166
167template<class Grid, class GridView, class DofMapper, class Stencil, class FluidSystem, class Scalar>
169fname(int tracerIdx) const
170{
171 return this->eclState_.tracer()[tracerIdx].fname();
172}
173
174template<class Grid, class GridView, class DofMapper, class Stencil, class FluidSystem, class Scalar>
176sname(int tracerIdx) const
177{
178 return this->eclState_.tracer()[tracerIdx].sname();
179}
180
181template<class Grid, class GridView, class DofMapper, class Stencil, class FluidSystem, class Scalar>
183wellfname(int tracerIdx) const
184{
185 return this->eclState_.tracer()[tracerIdx].wellfname();
186}
187
188template<class Grid, class GridView, class DofMapper, class Stencil, class FluidSystem, class Scalar>
190wellsname(int tracerIdx) const
191{
192 return this->eclState_.tracer()[tracerIdx].wellsname();
193}
194
195template<class Grid, class GridView, class DofMapper, class Stencil, class FluidSystem, class Scalar>
197phase(int tracerIdx) const
198{
199 return this->eclState_.tracer()[tracerIdx].phase;
200}
201
202template<class Grid, class GridView, class DofMapper, class Stencil, class FluidSystem, class Scalar>
204enableSolTracers() const
205{
206 return this->enableSolTracers_;
207}
208
209template<class Grid, class GridView, class DofMapper, class Stencil, class FluidSystem, class Scalar>
211currentConcentration_(const Well& eclWell, const std::string& name) const
212{
213 return eclWell.getTracerProperties().getConcentration(name);
214}
215
216template<class Grid, class GridView, class DofMapper, class Stencil, class FluidSystem, class Scalar>
218name(int tracerIdx) const
219{
220 return this->eclState_.tracer()[tracerIdx].name;
221}
222
223template<class Grid, class GridView, class DofMapper, class Stencil, class FluidSystem, class Scalar>
225doInit(bool rst, std::size_t numGridDof,
226 std::size_t gasPhaseIdx, std::size_t oilPhaseIdx, std::size_t waterPhaseIdx)
227{
228 const auto& tracers = eclState_.tracer();
229
230 if (tracers.size() == 0) {
231 return; // tracer treatment is supposed to be disabled
232 }
233
234 // retrieve the number of tracers from the deck
235 const std::size_t numTracers = tracers.size();
236 enableSolTracers_.resize(numTracers);
237 tracerConcentration_.resize(numTracers);
238 freeTracerConcentration_.resize(numTracers);
239 solTracerConcentration_.resize(numTracers);
240
241 // the phase where the tracer is
242 tracerPhaseIdx_.resize(numTracers);
243 for (std::size_t tracerIdx = 0; tracerIdx < numTracers; tracerIdx++) {
244 const auto& tracer = tracers[tracerIdx];
245
246 if (tracer.phase == Phase::WATER)
247 tracerPhaseIdx_[tracerIdx] = waterPhaseIdx;
248 else if (tracer.phase == Phase::OIL)
249 tracerPhaseIdx_[tracerIdx] = oilPhaseIdx;
250 else if (tracer.phase == Phase::GAS)
251 tracerPhaseIdx_[tracerIdx] = gasPhaseIdx;
252
253 tracerConcentration_[tracerIdx].resize(numGridDof);
254 freeTracerConcentration_[tracerIdx].resize(numGridDof);
255 solTracerConcentration_[tracerIdx].resize(numGridDof);
256
257 if (rst)
258 continue;
259
260
261 // TBLKF keyword
262 if (tracer.free_concentration.has_value()){
263 const auto& free_concentration = tracer.free_concentration.value();
264 int tblkDatasize = free_concentration.size();
265 if (tblkDatasize < cartMapper_.cartesianSize()){
266 throw std::runtime_error("Wrong size of TBLKF for" + tracer.name);
267 }
268 for (std::size_t globalDofIdx = 0; globalDofIdx < numGridDof; ++globalDofIdx) {
269 int cartDofIdx = cartMapper_.cartesianIndex(globalDofIdx);
270 tracerConcentration_[tracerIdx][globalDofIdx][0] = free_concentration[cartDofIdx];
271 freeTracerConcentration_[tracerIdx][globalDofIdx] = free_concentration[cartDofIdx];
272 }
273 }
274 // TVDPF keyword
275 else if (tracer.free_tvdp.has_value()) {
276 const auto& free_tvdp = tracer.free_tvdp.value();
277 for (std::size_t globalDofIdx = 0; globalDofIdx < numGridDof; ++globalDofIdx) {
278 tracerConcentration_[tracerIdx][globalDofIdx][0] =
279 free_tvdp.evaluate("TRACER_CONCENTRATION",
280 centroids_(globalDofIdx)[2]);
281 freeTracerConcentration_[tracerIdx][globalDofIdx] =
282 free_tvdp.evaluate("TRACER_CONCENTRATION",
283 centroids_(globalDofIdx)[2]);
284 }
285 }
286 else {
287 OpmLog::warning(fmt::format("No TBLKF or TVDPF given for free tracer {}. "
288 "Initial values set to zero. ", tracer.name));
289 for (std::size_t globalDofIdx = 0; globalDofIdx < numGridDof; ++globalDofIdx) {
290 tracerConcentration_[tracerIdx][globalDofIdx][0] = 0.0;
291 freeTracerConcentration_[tracerIdx][globalDofIdx] = 0.0;
292 }
293 }
294
295 // Solution tracer initialization only needed for gas/oil tracers with DISGAS/VAPOIL active
296 if (tracer.phase != Phase::WATER &&
297 ((tracer.phase == Phase::GAS && FluidSystem::enableDissolvedGas()) ||
298 (tracer.phase == Phase::OIL && FluidSystem::enableVaporizedOil()))) {
299 // TBLKS keyword
300 if (tracer.solution_concentration.has_value()){
301 enableSolTracers_[tracerIdx] = true;
302 const auto& solution_concentration = tracer.solution_concentration.value();
303 int tblkDatasize = solution_concentration.size();
304 if (tblkDatasize < cartMapper_.cartesianSize()){
305 throw std::runtime_error("Wrong size of TBLKS for" + tracer.name);
306 }
307 for (std::size_t globalDofIdx = 0; globalDofIdx < numGridDof; ++globalDofIdx) {
308 int cartDofIdx = cartMapper_.cartesianIndex(globalDofIdx);
309 tracerConcentration_[tracerIdx][globalDofIdx][1] = solution_concentration[cartDofIdx];
310 solTracerConcentration_[tracerIdx][globalDofIdx] = solution_concentration[cartDofIdx];
311 }
312 }
313 // TVDPS keyword
314 else if (tracer.solution_tvdp.has_value()) {
315 enableSolTracers_[tracerIdx] = true;
316 const auto& solution_tvdp = tracer.solution_tvdp.value();
317 for (std::size_t globalDofIdx = 0; globalDofIdx < numGridDof; ++globalDofIdx) {
318 tracerConcentration_[tracerIdx][globalDofIdx][1] =
319 solution_tvdp.evaluate("TRACER_CONCENTRATION",
320 centroids_(globalDofIdx)[2]);
321 solTracerConcentration_[tracerIdx][globalDofIdx] =
322 solution_tvdp.evaluate("TRACER_CONCENTRATION",
323 centroids_(globalDofIdx)[2]);
324 }
325 }
326 else {
327 // No solution tracers, default to zero
328 enableSolTracers_[tracerIdx] = false;
329 OpmLog::warning(fmt::format("No TBLKS or TVDPS given for solution tracer {}. "
330 "Initial values set to zero. ", tracer.name));
331 for (std::size_t globalDofIdx = 0; globalDofIdx < numGridDof; ++globalDofIdx) {
332 tracerConcentration_[tracerIdx][globalDofIdx][1] = 0.0;
333 solTracerConcentration_[tracerIdx][globalDofIdx] = 0.0;
334 }
335 }
336 }
337 else {
338 // No solution tracers, default to zero
339 enableSolTracers_[tracerIdx] = false;
340 for (std::size_t globalDofIdx = 0; globalDofIdx < numGridDof; ++globalDofIdx) {
341 tracerConcentration_[tracerIdx][globalDofIdx][1] = 0.0;
342 solTracerConcentration_[tracerIdx][globalDofIdx] = 0.0;
343 }
344 }
345 }
346
347 // allocate matrix for storing the Jacobian of the tracer residual
348 tracerMatrix_ = std::make_unique<TracerMatrix>(numGridDof, numGridDof, TracerMatrix::random);
349
350 // find the sparsity pattern of the tracer matrix
351 using NeighborSet = std::set<unsigned>;
352 std::vector<NeighborSet> neighbors(numGridDof);
353
354 Stencil stencil(gridView_, dofMapper_);
355 for (const auto& elem : elements(gridView_)) {
356 stencil.update(elem);
357
358 for (unsigned primaryDofIdx = 0; primaryDofIdx < stencil.numPrimaryDof(); ++primaryDofIdx) {
359 unsigned myIdx = stencil.globalSpaceIndex(primaryDofIdx);
360
361 for (unsigned dofIdx = 0; dofIdx < stencil.numDof(); ++dofIdx) {
362 unsigned neighborIdx = stencil.globalSpaceIndex(dofIdx);
363 neighbors[myIdx].insert(neighborIdx);
364 }
365 }
366 }
367
368 // allocate space for the rows of the matrix
369 for (unsigned dofIdx = 0; dofIdx < numGridDof; ++ dofIdx) {
370 tracerMatrix_->setrowsize(dofIdx, neighbors[dofIdx].size());
371 }
372 tracerMatrix_->endrowsizes();
373
374 // fill the rows with indices. each degree of freedom talks to
375 // all of its neighbors. (it also talks to itself since
376 // degrees of freedom are sometimes quite egocentric.)
377 for (unsigned dofIdx = 0; dofIdx < numGridDof; ++ dofIdx) {
378 for (const auto& index : neighbors[dofIdx]) {
379 tracerMatrix_->addindex(dofIdx, index);
380 }
381 }
382 tracerMatrix_->endindices();
383}
384
385template<class Grid, class GridView, class DofMapper, class Stencil, class FluidSystem, class Scalar>
388{
389 x = 0.0;
390 Scalar tolerance = 1e-2;
391 int maxIter = 100;
392
393 int verbosity = 0;
394 PropertyTree prm;
395 prm.put("maxiter", maxIter);
396 prm.put("tol", tolerance);
397 prm.put("verbosity", verbosity);
398 prm.put("solver", std::string("bicgstab"));
399 prm.put("preconditioner.type", std::string("ParOverILU0"));
400
401#if HAVE_MPI
402 if(gridView_.grid().comm().size() > 1)
403 {
404 auto [tracerOperator, solver] =
405 createParallelFlexibleSolver<TracerVector>(gridView_.grid(), M, prm);
406 (void) tracerOperator;
407
409 solver->apply(x, b, result);
410
411 // return the result of the solver
412 return result.converged;
413 }
414 else
415 {
416#endif
417 using TracerSolver = Dune::BiCGSTABSolver<TracerVector>;
418 using TracerOperator = Dune::MatrixAdapter<TracerMatrix,TracerVector,TracerVector>;
419 using TracerScalarProduct = Dune::SeqScalarProduct<TracerVector>;
420 using TracerPreconditioner = Dune::SeqILU< TracerMatrix,TracerVector,TracerVector>;
421
422 TracerOperator tracerOperator(M);
423 TracerScalarProduct tracerScalarProduct;
424 TracerPreconditioner tracerPreconditioner(M, 0, 1); // results in ILU0
425
426 TracerSolver solver (tracerOperator, tracerScalarProduct,
427 tracerPreconditioner, tolerance, maxIter,
428 verbosity);
429
431 solver.apply(x, b, result);
432
433 // return the result of the solver
434 return result.converged;
435#if HAVE_MPI
436 }
437#endif
438}
439
440template<class Grid, class GridView, class DofMapper, class Stencil, class FluidSystem, class Scalar>
442linearSolveBatchwise_(const TracerMatrix& M, std::vector<TracerVector>& x, std::vector<TracerVector>& b)
443{
444 OPM_TIMEBLOCK(tracerSolve);
445 const Scalar tolerance = 1e-2;
446 const int maxIter = 100;
447 const int verbosity = 0;
448
449#if HAVE_MPI
450 if (gridView_.grid().comm().size() > 1)
451 {
452 PropertyTree prm;
453 prm.put("maxiter", maxIter);
454 prm.put("tol", tolerance);
455 prm.put("verbosity", verbosity);
456 prm.put("solver", std::string("bicgstab"));
457 prm.put("preconditioner.type", std::string("ParOverILU0"));
458 auto [tracerOperator, solver] =
459 createParallelFlexibleSolver<TracerVector>(gridView_.grid(), M, prm);
460 (void) tracerOperator;
461 bool converged = true;
462 for (std::size_t nrhs = 0; nrhs < b.size(); ++nrhs) {
463 x[nrhs] = 0.0;
465 solver->apply(x[nrhs], b[nrhs], result);
466 converged = (converged && result.converged);
467 }
468 return converged;
469 }
470 else
471#endif
472 {
473 using TracerSolver = Dune::BiCGSTABSolver<TracerVector>;
474 using TracerOperator = Dune::MatrixAdapter<TracerMatrix,TracerVector,TracerVector>;
475 using TracerScalarProduct = Dune::SeqScalarProduct<TracerVector>;
476 using TracerPreconditioner = Dune::SeqILU<TracerMatrix,TracerVector,TracerVector>;
477
478 if (std::all_of(b.begin(), b.end(),
479 [](const auto& v) { return v.infinity_norm() == 0.0; }))
480 {
481 return true;
482 }
483
484 TracerOperator tracerOperator(M);
485 TracerScalarProduct tracerScalarProduct;
486 TracerPreconditioner tracerPreconditioner(M, 0, 1); // results in ILU0
487
488 TracerSolver solver (tracerOperator, tracerScalarProduct,
489 tracerPreconditioner, tolerance, maxIter,
490 verbosity);
491
492 bool converged = true;
493 for (std::size_t nrhs = 0; nrhs < b.size(); ++nrhs) {
494 x[nrhs] = 0.0;
496 solver.apply(x[nrhs], b[nrhs], result);
497 converged = (converged && result.converged);
498 }
499
500 // return the result of the solver
501 return converged;
502 }
503}
504
505} // namespace Opm
506
507#endif // OPM_GENERIC_TRACER_MODEL_IMPL_HPP
Definition: CollectDataOnIORank.hpp:49
Definition: FlexibleSolver.hpp:45
void setEnableSolTracers(int tracerIdx, bool enableSolTracer)
Definition: GenericTracerModel_impl.hpp:155
int numTracers() const
Return the number of tracers considered by the tracerModel.
Definition: GenericTracerModel_impl.hpp:162
Scalar currentConcentration_(const Well &eclWell, const std::string &name) const
Definition: GenericTracerModel_impl.hpp:211
void doInit(bool rst, std::size_t numGridDof, std::size_t gasPhaseIdx, std::size_t oilPhaseIdx, std::size_t waterPhaseIdx)
Initialize all internal data structures needed by the tracer module.
Definition: GenericTracerModel_impl.hpp:225
std::string sname(int tracerIdx) const
Definition: GenericTracerModel_impl.hpp:176
void setSolTracerConcentration(int tracerIdx, int globalDofIdx, Scalar value)
Definition: GenericTracerModel_impl.hpp:147
std::string wellfname(int tracerIdx) const
Definition: GenericTracerModel_impl.hpp:183
GenericTracerModel(const GridView &gridView, const EclipseState &eclState, const CartesianIndexMapper &cartMapper, const DofMapper &dofMapper, const std::function< std::array< double, dimWorld >(int)> centroids)
Definition: GenericTracerModel_impl.hpp:102
const std::string & name(int tracerIdx) const
Return the tracer name.
Definition: GenericTracerModel_impl.hpp:218
const std::vector< bool > & enableSolTracers() const
Definition: GenericTracerModel_impl.hpp:204
Phase phase(int tracerIdx) const
Definition: GenericTracerModel_impl.hpp:197
std::string wellsname(int tracerIdx) const
Definition: GenericTracerModel_impl.hpp:190
std::string fname(int tracerIdx) const
Definition: GenericTracerModel_impl.hpp:169
bool linearSolve_(const TracerMatrix &M, TracerVector &x, TracerVector &b)
Definition: GenericTracerModel_impl.hpp:387
Dune::BlockVector< Dune::FieldVector< Scalar, 2 > > TracerVector
Definition: GenericTracerModel.hpp:60
void setFreeTracerConcentration(int tracerIdx, int globalDofIdx, Scalar value)
Definition: GenericTracerModel_impl.hpp:139
Scalar solTracerConcentration(int tracerIdx, int globalDofIdx) const
Definition: GenericTracerModel_impl.hpp:128
bool linearSolveBatchwise_(const TracerMatrix &M, std::vector< TracerVector > &x, std::vector< TracerVector > &b)
Definition: GenericTracerModel_impl.hpp:442
Dune::BCRSMatrix< Opm::MatrixBlock< Scalar, 2, 2 > > TracerMatrix
Definition: GenericTracerModel.hpp:59
Scalar freeTracerConcentration(int tracerIdx, int globalDofIdx) const
Return the tracer concentration for tracer index and global DofIdx.
Definition: GenericTracerModel_impl.hpp:117
Hierarchical collection of key/value pairs.
Definition: PropertyTree.hpp:39
void put(const std::string &key, const T &data)
Definition: blackoilboundaryratevector.hh:39
Dune::InverseOperatorResult InverseOperatorResult
Definition: GpuBridge.hpp:32
std::tuple< std::unique_ptr< Dune::OverlappingSchwarzOperator< Matrix, Vector, Vector, Dune::OwnerOverlapCopyCommunication< int, int > > >, std::unique_ptr< typename TracerSolverSelector< Matrix, Vector >::type > > createParallelFlexibleSolver(const Grid &, const Matrix &, const PropertyTree &)
Definition: GenericTracerModel_impl.hpp:78
Definition: GenericTracerModel_impl.hpp:68
Dune::FlexibleSolver< TracerOperator > type
Definition: GenericTracerModel_impl.hpp:71
Dune::OverlappingSchwarzOperator< M, V, V, Comm > TracerOperator
Definition: GenericTracerModel_impl.hpp:70
Dune::OwnerOverlapCopyCommunication< int, int > Comm
Definition: GenericTracerModel_impl.hpp:69