OGS
ComponentTransportProcess.cpp
Go to the documentation of this file.
1// SPDX-FileCopyrightText: Copyright (c) OpenGeoSys Community (opengeosys.org)
2// SPDX-License-Identifier: BSD-3-Clause
3
5
6#include <cassert>
7#include <numeric>
8#include <range/v3/algorithm/copy.hpp>
9#include <range/v3/view/drop.hpp>
10
11#include "BaseLib/RunTime.h"
29
30namespace ProcessLib
31{
32namespace ComponentTransport
33{
35 std::string name,
36 MeshLib::Mesh& mesh,
37 std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
38 std::vector<std::unique_ptr<ParameterLib::ParameterBase>> const& parameters,
39 unsigned const integration_order,
40 std::vector<std::vector<std::reference_wrapper<ProcessVariable>>>&&
41 process_variables,
42 ComponentTransportProcessData&& process_data,
43 SecondaryVariableCollection&& secondary_variables,
44 bool const use_monolithic_scheme,
45 std::unique_ptr<ProcessLib::SurfaceFluxData>&& surfaceflux,
46 std::unique_ptr<ChemistryLib::ChemicalSolverInterface>&&
47 chemical_solver_interface,
48 bool const is_linear,
49 bool const ls_compute_only_upon_timestep_change)
50 : Process(std::move(name), mesh, std::move(jacobian_assembler), parameters,
51 integration_order, std::move(process_variables),
52 std::move(secondary_variables), use_monolithic_scheme),
54 use_monolithic_scheme},
55 _process_data(std::move(process_data)),
56 _surfaceflux(std::move(surfaceflux)),
57 _chemical_solver_interface(std::move(chemical_solver_interface)),
58 _ls_compute_only_upon_timestep_change{
59 ls_compute_only_upon_timestep_change}
60{
61 this->_jacobian_assembler->checkPerturbationSize(_process_variables.size());
62
63 if (ls_compute_only_upon_timestep_change)
64 {
65 // TODO move this feature to some common location for all processes.
66 if (!is_linear)
67 {
69 "Using the linear solver compute() method only upon timestep "
70 "change only makes sense for linear model equations.");
71 }
72
73 WARN(
74 "You specified that the ComponentTransport linear solver will do "
75 "the compute() step only upon timestep change. This is an expert "
76 "option. It is your responsibility to ensure that "
77 "the conditions for the correct use of this feature are met! "
78 "Otherwise OGS might compute garbage without being recognized. "
79 "There is no safety net!");
80
81 WARN(
82 "You specified that the ComponentTransport linear solver will do "
83 "the compute() step only upon timestep change. This option will "
84 "only be used by the Picard non-linear solver. The Newton-Raphson "
85 "non-linear solver will silently ignore this setting, i.e., it "
86 "won't do any harm, there, but you won't observe the speedup you "
87 "probably expect.");
88 }
89
90 if (_use_monolithic_scheme)
91 {
92 // For numerical Jacobian:
93 std::vector<int> non_deformation_component_ids(
94 _process_variables.size());
95 std::iota(non_deformation_component_ids.begin(),
96 non_deformation_component_ids.end(), 0);
97 this->_jacobian_assembler->setNonDeformationComponentIDsNoSizeCheck(
98 non_deformation_component_ids);
99 }
100}
101
103 NumLib::LocalToGlobalIndexMap const& dof_table,
104 MeshLib::Mesh const& mesh,
105 unsigned const integration_order)
106{
107 int const mesh_space_dimension = _process_data.mesh_space_dimension;
108
110 const_cast<MeshLib::Mesh&>(mesh), "velocity",
111 MeshLib::MeshItemType::Cell, mesh_space_dimension);
112
114 const_cast<MeshLib::Mesh&>(mesh), "porosity_avg",
116
117 std::vector<std::reference_wrapper<ProcessLib::ProcessVariable>>
118 transport_process_variables;
120 {
121 const int process_id = 0;
122 for (auto pv_iter = std::next(_process_variables[process_id].begin());
123 pv_iter != _process_variables[process_id].end();
124 ++pv_iter)
125 {
126 transport_process_variables.push_back(*pv_iter);
127 }
128 }
129 else
130 {
131 // All process variables but the pressure and optionally the temperature
132 // are transport variables.
133 for (auto const& pv :
135 ranges::views::drop(_process_data.isothermal ? 1 : 2))
136 {
137 transport_process_variables.push_back(pv[0]);
138 }
139 }
140
142 mesh_space_dimension, mesh.getElements(), dof_table, local_assemblers_,
143 NumLib::IntegrationOrder{integration_order}, mesh.isAxiallySymmetric(),
144 _process_data, transport_process_variables);
145
147 {
150 local_assemblers_, _chemical_solver_interface->activeElementIDs());
151
152 _chemical_solver_interface->initialize();
153 }
154
155 _secondary_variables.addSecondaryVariable(
156 "liquid_density",
160
161 _secondary_variables.addSecondaryVariable(
162 "darcy_velocity",
164 mesh_space_dimension, getExtrapolator(), local_assemblers_,
166
167 for (std::size_t component_id = 0;
168 component_id < transport_process_variables.size();
169 ++component_id)
170 {
171 auto const& pv = transport_process_variables[component_id].get();
172
173 auto integration_point_values_accessor =
174 [component_id](
176 const double t,
177 std::vector<GlobalVector*> const& x,
178 std::vector<NumLib::LocalToGlobalIndexMap const*> const&
179 dof_tables,
180 std::vector<double>& cache) -> auto const&
181 {
182 return loc_asm.getIntPtMolarFlux(t, x, dof_tables, cache,
183 component_id);
184 };
185
186 _secondary_variables.addSecondaryVariable(
187 pv.getName() + "Flux",
188 makeExtrapolator(mesh_space_dimension, getExtrapolator(),
190 integration_point_values_accessor));
191 }
192}
193
195 std::vector<GlobalVector*>& x, double const t, int const process_id)
196{
198 {
199 return;
200 }
201
202 if (process_id != static_cast<int>(x.size() - 1))
203 {
204 return;
205 }
206
207 std::for_each(
208 x.begin(), x.end(), [](auto const process_solution)
209 { MathLib::LinAlg::setLocalAccessibleVector(*process_solution); });
210
211 std::vector<NumLib::LocalToGlobalIndexMap const*> dof_tables;
212 dof_tables.reserve(x.size());
213 std::generate_n(std::back_inserter(dof_tables), x.size(),
214 [&]() { return _local_to_global_index_map.get(); });
215
219 dof_tables, x, t);
220}
221
223 const double t, double const dt, std::vector<GlobalVector*> const& x,
224 std::vector<GlobalVector*> const& x_prev, int const process_id,
226{
227 DBUG("Assemble ComponentTransportProcess.");
228
230 {
231 this->_jacobian_assembler->setNonDeformationComponentIDsNoSizeCheck(
232 {process_id});
233 }
234
236 process_id, M, K, b);
237
238 // TODO (naumov) What about temperature? A test with FCT would reveal any
239 // problems.
240 if (process_id == _process_data.hydraulic_process_id)
241 {
242 return;
243 }
244 auto const matrix_specification = getMatrixSpecifications(process_id);
245
247 x_prev, process_id,
248 matrix_specification, M, K, b);
249}
250
252 const double t, double const dt, std::vector<GlobalVector*> const& x,
253 std::vector<GlobalVector*> const& x_prev, int const process_id,
254 GlobalVector& b, GlobalMatrix& Jac)
255{
256 DBUG("AssembleWithJacobian ComponentTransportProcess.");
257
259 {
260 OGS_FATAL(
261 "The AssembleWithJacobian() for ComponentTransportProcess is "
262 "implemented only for staggered scheme.");
263 }
264
266 t, dt, x, x_prev, process_id, b, Jac);
267}
268
270 std::size_t const element_id,
271 MathLib::Point3d const& p,
272 double const t,
273 std::vector<GlobalVector*> const& x) const
274{
275 std::vector<GlobalIndexType> indices_cache;
276 auto const r_c_indices = NumLib::getRowColumnIndices(
277 element_id, *_local_to_global_index_map, indices_cache);
278
279 std::vector<std::vector<GlobalIndexType>> indices_of_all_coupled_processes{
280 x.size(), r_c_indices.rows};
281 auto const local_xs =
282 getCoupledLocalSolutions(x, indices_of_all_coupled_processes);
283
284 return local_assemblers_[element_id]->getFlux(p, t, local_xs);
285}
286
288 std::vector<GlobalVector*>& x, std::vector<GlobalVector*> const& x_prev,
289 double const t, double const dt, NumLib::EquationSystem& ode_sys,
290 int const process_id)
291{
292 // todo (renchao): move chemical calculation to elsewhere.
293 if (_process_data.lookup_table && process_id == 0)
294 {
295 INFO("Update process solutions via the look-up table approach");
296 _process_data.lookup_table->lookup(x, x_prev, _mesh.getNumberOfNodes());
297
298 return;
299 }
300
302 {
303 return;
304 }
305
306 // Sequential non-iterative approach applied here to split the reactive
307 // transport process into the transport stage followed by the reaction
308 // stage.
309 std::vector<NumLib::LocalToGlobalIndexMap const*> dof_tables;
310 dof_tables.reserve(x.size());
311 std::generate_n(std::back_inserter(dof_tables), x.size(),
312 [&]() { return _local_to_global_index_map.get(); });
313
314 if (process_id == 0)
315 {
319 dof_tables, x, t, dt);
320
321 BaseLib::RunTime time_phreeqc;
322 time_phreeqc.start();
323
324 _chemical_solver_interface->setAqueousSolutionsPrevFromDumpFile();
325
326 _chemical_solver_interface->executeSpeciationCalculation(dt);
327
328 INFO("[time] Phreeqc took {:g} s.", time_phreeqc.elapsed());
329
332 postSpeciationCalculation,
334 t, dt);
335
336 return;
337 }
338
339 auto const matrix_specification = getMatrixSpecifications(process_id);
340
341 std::size_t matrix_id = 0u;
342 auto& M = NumLib::GlobalMatrixProvider::provider.getMatrix(
343 matrix_specification, matrix_id);
344 auto& K = NumLib::GlobalMatrixProvider::provider.getMatrix(
345 matrix_specification, matrix_id);
346 auto& b =
347 NumLib::GlobalVectorProvider::provider.getVector(matrix_specification);
348
349 M.setZero();
350 K.setZero();
351 b.setZero();
352
355 local_assemblers_, getActiveElementIDs(), dof_tables, x, t, dt, M, K, b,
356 process_id);
357
358 // todo (renchao): incorporate Neumann boundary condition
362
363 auto& A = NumLib::GlobalMatrixProvider::provider.getMatrix(
364 matrix_specification, matrix_id);
365 auto& rhs =
366 NumLib::GlobalVectorProvider::provider.getVector(matrix_specification);
367
368 A.setZero();
369 rhs.setZero();
370
373
374 // compute A
376 MathLib::LinAlg::aypx(A, 1.0 / dt, K);
377
378 // compute rhs
379 MathLib::LinAlg::matMult(M, *x[process_id], rhs);
380 MathLib::LinAlg::aypx(rhs, 1.0 / dt, b);
381
382 using Tag = NumLib::NonlinearSolverTag;
384 auto& equation_system = static_cast<EqSys&>(ode_sys);
385 equation_system.applyKnownSolutionsPicard(
386 A, rhs, *x[process_id],
388
389 auto& linear_solver =
390 _process_data.chemical_solver_interface->linear_solver;
392 linear_solver.solve(A, rhs, *x[process_id]);
393
399}
400
402 double const t,
403 double const dt,
404 std::vector<GlobalVector*> const& x,
405 GlobalVector const& x_prev,
406 int const process_id)
407{
408 if (process_id != 0)
409 {
410 return;
411 }
412
413 std::vector<NumLib::LocalToGlobalIndexMap const*> dof_tables;
414 dof_tables.reserve(x.size());
415 std::generate_n(std::back_inserter(dof_tables), x.size(),
416 [&]() { return _local_to_global_index_map.get(); });
417
420 local_assemblers_, getActiveElementIDs(), dof_tables, t, dt, x, x_prev,
421 process_id);
422
424 {
425 return;
426 }
427
430 computeReactionRelatedSecondaryVariable,
431 local_assemblers_, _chemical_solver_interface->activeElementIDs());
432}
433
434std::vector<std::vector<std::string>>
436 std::vector<std::reference_wrapper<MeshLib::Mesh>> const& meshes)
437{
438 DBUG("CT process initializeSubmeshOutput().");
439
440 namespace R = ranges;
441 namespace RV = ranges::views;
442
443 auto get_residuum_name =
444 [](ProcessLib::ProcessVariable const& pv) -> std::string
445 {
446 std::string const& pv_name = pv.getName();
447 if (pv_name == "pressure")
448 {
449 return "LiquidMassFlowRate";
450 }
451 if (pv_name == "temperature")
452 {
453 return "HeatFlowRate";
454 }
455 return pv_name + "FlowRate";
456 };
457
458 auto get_residuum_names = [get_residuum_name](auto const& pvs)
459 { return pvs | RV::transform(get_residuum_name); };
460
461 auto residuum_names = _process_variables |
462 RV::transform(get_residuum_names) |
463 R::to<std::vector<std::vector<std::string>>>();
464
466 meshes, residuum_names);
467
468 return residuum_names;
469}
470
472 std::vector<GlobalVector*> const& /*x*/,
473 const double /*t*/,
474 const double /*dt*/,
475 const int process_id)
476{
477 if (process_id == 0)
478 {
480 }
481}
482
484 std::vector<GlobalVector*> const& x,
485 std::vector<GlobalVector*> const& x_prev,
486 const double t,
487 const double dt,
488 int const process_id)
489{
490 if (process_id != 0)
491 {
492 return;
493 }
494
495 std::vector<NumLib::LocalToGlobalIndexMap const*> dof_tables;
496 dof_tables.reserve(x.size());
497 std::generate_n(std::back_inserter(dof_tables), x.size(),
498 [&]() { return _local_to_global_index_map.get(); });
499
502 local_assemblers_, getActiveElementIDs(), dof_tables, x, x_prev, t, dt,
503 process_id);
504
505 if (!_surfaceflux) // computing the surfaceflux is optional
506 {
507 return;
508 }
509 _surfaceflux->integrate(x, t, *this, process_id, _integration_order, _mesh,
511}
512
514 const double t,
515 double const dt,
516 std::vector<GlobalVector*> const& x,
517 std::vector<GlobalVector*> const& x_prev,
518 int const process_id)
519{
521 process_id);
522}
523} // namespace ComponentTransport
524} // namespace ProcessLib
Interface for coupling OpenGeoSys with an external geochemical solver.
#define OGS_FATAL(...)
Definition Error.h:19
MathLib::EigenMatrix GlobalMatrix
MathLib::EigenVector GlobalVector
void INFO(fmt::format_string< Args... > fmt, Args &&... args)
Definition Logging.h:28
void DBUG(fmt::format_string< Args... > fmt, Args &&... args)
Definition Logging.h:22
void WARN(fmt::format_string< Args... > fmt, Args &&... args)
Definition Logging.h:34
Count the running time.
Definition RunTime.h:18
double elapsed() const
Get the elapsed time in seconds.
Definition RunTime.h:31
void start()
Start the timer.
Definition RunTime.h:21
bool isAxiallySymmetric() const
Definition Mesh.h:128
std::vector< Element * > const & getElements() const
Get the element-vector for the mesh.
Definition Mesh.h:100
void assemble(double const t, double const dt, std::vector< GlobalVector * > const &x, std::vector< GlobalVector * > const &x_prev, int const process_id, GlobalMatrix &M, GlobalMatrix &K, GlobalVector &b, std::vector< std::size_t > const *const sorted_element_subset=nullptr, bool const copy_residua_to_mesh=false)
void preOutput(double const t, double const dt, std::vector< GlobalVector * > const &x, std::vector< GlobalVector * > const &x_prev, int const process_id)
void initializeAssemblyOnSubmeshes(std::vector< std::reference_wrapper< MeshLib::Mesh > > const &submeshes, std::vector< std::vector< std::string > > const &residuum_names)
void assembleWithJacobian(double const t, double const dt, std::vector< GlobalVector * > const &x, std::vector< GlobalVector * > const &x_prev, int const process_id, GlobalVector &b, GlobalMatrix &Jac, std::vector< std::size_t > const *const sorted_element_subset=nullptr, bool const copy_residua_to_mesh=false)
virtual std::vector< double > const & getIntPtLiquidDensity(const double t, std::vector< GlobalVector * > const &x, std::vector< NumLib::LocalToGlobalIndexMap const * > const &dof_table, std::vector< double > &cache) const =0
virtual std::vector< double > const & getIntPtDarcyVelocity(const double t, std::vector< GlobalVector * > const &x, std::vector< NumLib::LocalToGlobalIndexMap const * > const &dof_table, std::vector< double > &cache) const =0
void initializeChemicalSystem(std::size_t const mesh_item_id, std::vector< NumLib::LocalToGlobalIndexMap const * > const &dof_tables, std::vector< GlobalVector * > const &x, double const t)
void setChemicalSystem(std::size_t const mesh_item_id, std::vector< NumLib::LocalToGlobalIndexMap const * > const &dof_tables, std::vector< GlobalVector * > const &x, double const t, double const dt)
void assembleReactionEquation(std::size_t const mesh_item_id, std::vector< NumLib::LocalToGlobalIndexMap const * > const &dof_tables, std::vector< GlobalVector * > const &x, double const t, double const dt, GlobalMatrix &M, GlobalMatrix &K, GlobalVector &b, int const process_id)
virtual std::vector< double > const & getIntPtMolarFlux(const double t, std::vector< GlobalVector * > const &x, std::vector< NumLib::LocalToGlobalIndexMap const * > const &dof_table, std::vector< double > &cache, int const component_id) const =0
std::vector< std::vector< std::string > > initializeAssemblyOnSubmeshes(std::vector< std::reference_wrapper< MeshLib::Mesh > > const &meshes) override
void setInitialConditionsConcreteProcess(std::vector< GlobalVector * > &x, double const t, int const process_id) override
void preOutputConcreteProcess(const double t, double const dt, std::vector< GlobalVector * > const &x, std::vector< GlobalVector * > const &x_prev, int const process_id) override
void assembleConcreteProcess(const double t, double const dt, std::vector< GlobalVector * > const &x, std::vector< GlobalVector * > const &x_prev, int const process_id, GlobalMatrix &M, GlobalMatrix &K, GlobalVector &b) override
void initializeConcreteProcess(NumLib::LocalToGlobalIndexMap const &dof_table, MeshLib::Mesh const &mesh, unsigned const integration_order) override
Process specific initialization called by initialize().
std::unique_ptr< ChemistryLib::ChemicalSolverInterface > _chemical_solver_interface
void preTimestepConcreteProcess(std::vector< GlobalVector * > const &, const double, const double, const int) override
void computeSecondaryVariableConcrete(double const, double const, std::vector< GlobalVector * > const &x, GlobalVector const &, int const) override
void solveReactionEquation(std::vector< GlobalVector * > &x, std::vector< GlobalVector * > const &x_prev, double const t, double const dt, NumLib::EquationSystem &ode_sys, int const process_id) override
std::vector< std::unique_ptr< ComponentTransportLocalAssemblerInterface > > local_assemblers_
void assembleWithJacobianConcreteProcess(const double t, double const dt, std::vector< GlobalVector * > const &x, std::vector< GlobalVector * > const &x_prev, int const process_id, GlobalVector &b, GlobalMatrix &Jac) override
void postTimestepConcreteProcess(std::vector< GlobalVector * > const &x, std::vector< GlobalVector * > const &x_prev, const double t, const double dt, int const process_id) override
std::unique_ptr< ProcessLib::SurfaceFluxData > _surfaceflux
ComponentTransportProcess(std::string name, MeshLib::Mesh &mesh, std::unique_ptr< ProcessLib::AbstractJacobianAssembler > &&jacobian_assembler, std::vector< std::unique_ptr< ParameterLib::ParameterBase > > const &parameters, unsigned const integration_order, std::vector< std::vector< std::reference_wrapper< ProcessVariable > > > &&process_variables, ComponentTransportProcessData &&process_data, SecondaryVariableCollection &&secondary_variables, bool const use_monolithic_scheme, std::unique_ptr< ProcessLib::SurfaceFluxData > &&surfaceflux, std::unique_ptr< ChemistryLib::ChemicalSolverInterface > &&chemical_solver_interface, bool const is_linear, bool const ls_compute_only_upon_timestep_change)
Eigen::Vector3d getFlux(std::size_t const element_id, MathLib::Point3d const &p, double const t, std::vector< GlobalVector * > const &x) const override
virtual void postTimestep(std::size_t const mesh_item_id, std::vector< NumLib::LocalToGlobalIndexMap const * > const &dof_tables, std::vector< GlobalVector * > const &x, std::vector< GlobalVector * > const &x_prev, double const t, double const dt, int const process_id)
virtual void computeSecondaryVariable(std::size_t const mesh_item_id, std::vector< NumLib::LocalToGlobalIndexMap const * > const &dof_tables, double const t, double const dt, std::vector< GlobalVector * > const &x, GlobalVector const &x_prev, int const process_id)
std::string const name
Definition Process.h:361
Process(std::string name_, MeshLib::Mesh &mesh, std::unique_ptr< AbstractJacobianAssembler > &&jacobian_assembler, std::vector< std::unique_ptr< ParameterLib::ParameterBase > > const &parameters, unsigned const integration_order, std::vector< std::vector< std::reference_wrapper< ProcessVariable > > > &&process_variables, SecondaryVariableCollection &&secondary_variables, const bool use_monolithic_scheme=true)
Definition Process.cpp:37
MeshLib::Mesh & _mesh
Definition Process.h:364
std::vector< std::vector< std::reference_wrapper< ProcessVariable > > > _process_variables
Definition Process.h:399
std::vector< std::size_t > const & getActiveElementIDs() const
Definition Process.h:160
SecondaryVariableCollection _secondary_variables
Definition Process.h:369
unsigned const _integration_order
Definition Process.h:383
std::unique_ptr< NumLib::LocalToGlobalIndexMap > _local_to_global_index_map
Definition Process.h:367
std::unique_ptr< ProcessLib::AbstractJacobianAssembler > _jacobian_assembler
Definition Process.h:375
MathLib::MatrixSpecifications getMatrixSpecifications(const int process_id) const override
Definition Process.cpp:203
NumLib::Extrapolator & getExtrapolator() const
Definition Process.h:201
const bool _use_monolithic_scheme
Definition Process.h:378
Handles configuration of several secondary variables from the project file.
NonlinearSolverTag
Tag used to specify which nonlinear solver will be used.
Definition Types.h:13
void copy(PETScVector const &x, PETScVector &y)
Definition LinAlg.cpp:30
void setLocalAccessibleVector(PETScVector const &x)
Definition LinAlg.cpp:20
void matMult(PETScMatrix const &A, PETScVector const &x, PETScVector &y)
Definition LinAlg.cpp:142
void aypx(PETScVector &y, PetscScalar const a, PETScVector const &x)
Definition LinAlg.cpp:43
@ COMPLETE_MATRIX_UPDATE
Both A and b fully updated.
Definition LinAlgEnums.h:34
void finalizeVectorAssembly(VEC_T &)
General function to finalize the vector assembly.
bool finalizeMatrixAssembly(MAT_T &)
PropertyVector< T > * getOrCreateMeshProperty(Mesh &mesh, std::string const &property_name, MeshItemType const item_type, int const number_of_components)
void computeFluxCorrectedTransport(NumericalStabilization const &stabilizer, const double t, const double dt, std::vector< GlobalVector * > const &x, std::vector< GlobalVector * > const &x_prev, int const process_id, const MathLib::MatrixSpecifications &matrix_specification, GlobalMatrix &M, GlobalMatrix &K, GlobalVector &b)
NumLib::LocalToGlobalIndexMap::RowColumnIndices getRowColumnIndices(std::size_t const id, NumLib::LocalToGlobalIndexMap const &dof_table, std::vector< GlobalIndexType > &indices)
void createLocalAssemblers(std::vector< MeshLib::Element * > const &mesh_elements, NumLib::LocalToGlobalIndexMap const &dof_table, std::vector< std::unique_ptr< LocalAssemblerInterface > > &local_assemblers, ProviderOrOrder const &provider_or_order, ExtraCtorArgs &&... extra_ctor_args)
std::vector< double > getCoupledLocalSolutions(std::vector< GlobalVector * > const &global_solutions, std::vector< std::vector< GlobalIndexType > > const &indices)
SecondaryVariableFunctions makeExtrapolator(const unsigned num_components, NumLib::Extrapolator &extrapolator, LocalAssemblerCollection const &local_assemblers, typename NumLib::ExtrapolatableLocalAssemblerCollection< LocalAssemblerCollection >::IntegrationPointValuesMethod integration_point_values_method)
static NUMLIB_EXPORT MatrixProvider & provider
static NUMLIB_EXPORT VectorProvider & provider
static void executeSelectedMemberOnDereferenced(Method method, Container const &container, std::vector< std::size_t > const &active_container_ids, Args &&... args)