OGS
TH2MProcess.cpp
Go to the documentation of this file.
1 
11 #include "TH2MProcess.h"
12 
13 #include <cassert>
14 
15 #include "MeshLib/Elements/Utils.h"
17 #include "ProcessLib/Process.h"
19 #include "TH2MFEM.h"
20 #include "TH2MProcessData.h"
21 
22 namespace ProcessLib
23 {
24 namespace TH2M
25 {
26 template <int DisplacementDim>
28  std::string name,
29  MeshLib::Mesh& mesh,
30  std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
31  std::vector<std::unique_ptr<ParameterLib::ParameterBase>> const& parameters,
32  unsigned const integration_order,
33  std::vector<std::vector<std::reference_wrapper<ProcessVariable>>>&&
34  process_variables,
35  TH2MProcessData<DisplacementDim>&& process_data,
36  SecondaryVariableCollection&& secondary_variables,
37  bool const use_monolithic_scheme)
38  : Process(std::move(name), mesh, std::move(jacobian_assembler), parameters,
39  integration_order, std::move(process_variables),
40  std::move(secondary_variables), use_monolithic_scheme),
41  _process_data(std::move(process_data))
42 {
43  _nodal_forces = MeshLib::getOrCreateMeshProperty<double>(
44  mesh, "NodalForces", MeshLib::MeshItemType::Node, DisplacementDim);
45 
46  _hydraulic_flow = MeshLib::getOrCreateMeshProperty<double>(
47  mesh, "HydraulicFlow", MeshLib::MeshItemType::Node, 1);
48 
49  // TODO (naumov) remove ip suffix. Probably needs modification of the mesh
50  // properties, s.t. there is no "overlapping" with cell/point data.
51  // See getOrCreateMeshProperty.
52  _integration_point_writer.emplace_back(
53  std::make_unique<IntegrationPointWriter>(
54  "sigma_ip",
55  static_cast<int>(mesh.getDimension() == 2 ? 4 : 6) /*n components*/,
56  integration_order, _local_assemblers,
58 
59  _integration_point_writer.emplace_back(
60  std::make_unique<IntegrationPointWriter>(
61  "saturation_ip", 1 /*n components*/, integration_order,
63 
64  _integration_point_writer.emplace_back(
65  std::make_unique<IntegrationPointWriter>(
66  "epsilon_ip",
67  static_cast<int>(mesh.getDimension() == 2 ? 4 : 6) /*n components*/,
68  integration_order, _local_assemblers,
70 }
71 
72 template <int DisplacementDim>
74 {
75  return false;
76 }
77 
78 template <int DisplacementDim>
81  const int process_id) const
82 {
83  // For the monolithic scheme or the M process (deformation) in the staggered
84  // scheme.
85  if (_use_monolithic_scheme || process_id == deformation_process_id)
86  {
87  auto const& l = *_local_to_global_index_map;
88  return {l.dofSizeWithoutGhosts(), l.dofSizeWithoutGhosts(),
89  &l.getGhostIndices(), &this->_sparsity_pattern};
90  }
91 
92  // For staggered scheme and T or H process (pressure).
93  auto const& l = *_local_to_global_index_map_with_base_nodes;
94  return {l.dofSizeWithoutGhosts(), l.dofSizeWithoutGhosts(),
95  &l.getGhostIndices(), &_sparsity_pattern_with_linear_element};
96 }
97 
98 template <int DisplacementDim>
100 {
101  // Create single component dof in every of the mesh's nodes.
102  _mesh_subset_all_nodes =
103  std::make_unique<MeshLib::MeshSubset>(_mesh, _mesh.getNodes());
104  // Create single component dof in the mesh's base nodes.
105  _base_nodes = MeshLib::getBaseNodes(_mesh.getElements());
106  _mesh_subset_base_nodes =
107  std::make_unique<MeshLib::MeshSubset>(_mesh, _base_nodes);
108 
109  // TODO move the two data members somewhere else.
110  // for extrapolation of secondary variables of stress or strain
111  std::vector<MeshLib::MeshSubset> all_mesh_subsets_single_component{
112  *_mesh_subset_all_nodes};
113  _local_to_global_index_map_single_component =
114  std::make_unique<NumLib::LocalToGlobalIndexMap>(
115  std::move(all_mesh_subsets_single_component),
116  // by location order is needed for output
118 
119  if (_use_monolithic_scheme)
120  {
121  // For gas pressure, which is the first
122  std::vector<MeshLib::MeshSubset> all_mesh_subsets{
123  *_mesh_subset_base_nodes};
124 
125  // For capillary pressure, which is the second
126  all_mesh_subsets.push_back(*_mesh_subset_base_nodes);
127 
128  // For temperature, which is the third
129  all_mesh_subsets.push_back(*_mesh_subset_base_nodes);
130 
131  // For displacement.
132  std::generate_n(
133  std::back_inserter(all_mesh_subsets),
134  getProcessVariables(monolithic_process_id)[deformation_process_id]
135  .get()
136  .getNumberOfGlobalComponents(),
137  [&]() { return *_mesh_subset_all_nodes; });
138 
139  std::vector<int> const vec_n_components{
140  n_gas_pressure_components, n_capillary_pressure_components,
141  n_temperature_components, n_displacement_components};
142 
143  _local_to_global_index_map =
144  std::make_unique<NumLib::LocalToGlobalIndexMap>(
145  std::move(all_mesh_subsets), vec_n_components,
147  assert(_local_to_global_index_map);
148  }
149  else
150  {
151  OGS_FATAL("A Staggered version of TH2M is not implemented.");
152  }
153 }
154 
155 template <int DisplacementDim>
157  NumLib::LocalToGlobalIndexMap const& dof_table,
158  MeshLib::Mesh const& mesh,
159  unsigned const integration_order)
160 {
161  const int mechanical_process_id =
162  _use_monolithic_scheme ? 0 : deformation_process_id;
163  const int deformation_variable_id =
164  _use_monolithic_scheme ? deformation_process_id : 0;
167  mesh.getDimension(), mesh.getElements(), dof_table,
168  // use displacement process variable to set shape function order
169  getProcessVariables(mechanical_process_id)[deformation_variable_id]
170  .get()
171  .getShapeFunctionOrder(),
172  _local_assemblers, mesh.isAxiallySymmetric(), integration_order,
173  _process_data);
174 
175  auto add_secondary_variable = [&](std::string const& name,
176  int const num_components,
177  auto get_ip_values_function)
178  {
179  _secondary_variables.addSecondaryVariable(
180  name,
181  makeExtrapolator(num_components, getExtrapolator(),
182  _local_assemblers,
183  std::move(get_ip_values_function)));
184  };
185 
186  add_secondary_variable("sigma",
188  DisplacementDim>::RowsAtCompileTime,
190  add_secondary_variable("epsilon",
192  DisplacementDim>::RowsAtCompileTime,
194  add_secondary_variable("velocity_gas", mesh.getDimension(),
196  add_secondary_variable(
197  "velocity_liquid", mesh.getDimension(),
199  add_secondary_variable("saturation", 1,
201  add_secondary_variable("vapour_pressure", 1,
203  add_secondary_variable("porosity", 1,
205  add_secondary_variable("gas_density", 1,
207  add_secondary_variable("solid_density", 1,
209  add_secondary_variable("liquid_density", 1,
211  add_secondary_variable("mole_fraction_gas", 1,
213  add_secondary_variable("mass_fraction_gas", 1,
215  add_secondary_variable(
216  "mass_fraction_liquid", 1,
218 
219  add_secondary_variable(
220  "relative_permeability_gas", 1,
222  add_secondary_variable(
223  "relative_permeability_liquid", 1,
225 
226  add_secondary_variable("enthalpy_gas", 1,
228 
229  add_secondary_variable("enthalpy_liquid", 1,
231 
232  add_secondary_variable("enthalpy_solid", 1,
234 
235  _process_data.element_saturation = MeshLib::getOrCreateMeshProperty<double>(
236  const_cast<MeshLib::Mesh&>(mesh), "saturation_avg",
238 
239  _process_data.gas_pressure_interpolated =
240  MeshLib::getOrCreateMeshProperty<double>(
241  const_cast<MeshLib::Mesh&>(mesh), "gas_pressure_interpolated",
243 
244  _process_data.capillary_pressure_interpolated =
245  MeshLib::getOrCreateMeshProperty<double>(
246  const_cast<MeshLib::Mesh&>(mesh), "capillary_pressure_interpolated",
248 
249  _process_data.liquid_pressure_interpolated =
250  MeshLib::getOrCreateMeshProperty<double>(
251  const_cast<MeshLib::Mesh&>(mesh), "liquid_pressure_interpolated",
253 
254  _process_data.temperature_interpolated =
255  MeshLib::getOrCreateMeshProperty<double>(
256  const_cast<MeshLib::Mesh&>(mesh), "temperature_interpolated",
258 
259  // Set initial conditions for integration point data.
260  for (auto const& ip_writer : _integration_point_writer)
261  {
262  // Find the mesh property with integration point writer's name.
263  auto const& name = ip_writer->name();
264  if (!mesh.getProperties().existsPropertyVector<double>(name))
265  {
266  continue;
267  }
268  auto const& _meshproperty =
269  *mesh.getProperties().template getPropertyVector<double>(name);
270 
271  // The mesh property must be defined on integration points.
272  if (_meshproperty.getMeshItemType() !=
274  {
275  continue;
276  }
277 
278  auto const ip_meta_data = getIntegrationPointMetaData(mesh, name);
279 
280  // Check the number of components.
281  if (ip_meta_data.n_components !=
282  _meshproperty.getNumberOfGlobalComponents())
283  {
284  OGS_FATAL(
285  "Different number of components in meta data ({:d}) than in "
286  "the integration point field data for '{:s}': {:d}.",
287  ip_meta_data.n_components, name,
288  _meshproperty.getNumberOfGlobalComponents());
289  }
290 
291  // Now we have a properly named vtk's field data array and the
292  // corresponding meta data.
293  std::size_t position = 0;
294  for (auto& local_asm : _local_assemblers)
295  {
296  std::size_t const integration_points_read =
297  local_asm->setIPDataInitialConditions(
298  name, &_meshproperty[position],
299  ip_meta_data.integration_order);
300  if (integration_points_read == 0)
301  {
302  OGS_FATAL(
303  "No integration points read in the integration point "
304  "initial conditions set function.");
305  }
306  position += integration_points_read * ip_meta_data.n_components;
307  }
308  }
309 
310  // Initialize local assemblers after all variables have been set.
312  &LocalAssemblerInterface::initialize, _local_assemblers,
313  *_local_to_global_index_map);
314 }
315 
316 template <int DisplacementDim>
318 {
319  if (_use_monolithic_scheme)
320  {
321  initializeProcessBoundaryConditionsAndSourceTerms(
322  *_local_to_global_index_map, monolithic_process_id);
323  return;
324  }
325 
326  // Staggered scheme:
327  OGS_FATAL("A Staggered version of TH2M is not implemented.");
328 }
329 
330 template <int DisplacementDim>
332  std::vector<GlobalVector*>& x, double const t, int const process_id)
333 {
334  if (process_id != 0)
335  {
336  return;
337  }
338 
339  DBUG("Set initial conditions of TH2MProcess.");
340 
343  getDOFTable(process_id), *x[process_id], t, _use_monolithic_scheme,
344  process_id);
345 }
346 
347 template <int DisplacementDim>
349  const double t, double const dt, std::vector<GlobalVector*> const& x,
350  std::vector<GlobalVector*> const& xdot, int const process_id,
352 {
353  DBUG("Assemble the equations for TH2M");
354 
355  std::vector<std::reference_wrapper<NumLib::LocalToGlobalIndexMap>>
356  dof_table = {std::ref(*_local_to_global_index_map)};
357 
358  ProcessLib::ProcessVariable const& pv = getProcessVariables(process_id)[0];
359 
361  _global_assembler, &VectorMatrixAssembler::assemble, _local_assemblers,
362  pv.getActiveElementIDs(), dof_table, t, dt, x, xdot, process_id, M, K,
363  b);
364 }
365 
366 template <int DisplacementDim>
368  const double t, double const dt, std::vector<GlobalVector*> const& x,
369  std::vector<GlobalVector*> const& xdot, const double dxdot_dx,
370  const double dx_dx, int const process_id, GlobalMatrix& M, GlobalMatrix& K,
371  GlobalVector& b, GlobalMatrix& Jac)
372 {
373  std::vector<std::reference_wrapper<NumLib::LocalToGlobalIndexMap>>
374  dof_tables;
375  // For the monolithic scheme
376  if (_use_monolithic_scheme)
377  {
378  DBUG("Assemble the Jacobian of TH2M for the monolithic scheme.");
379  dof_tables.emplace_back(*_local_to_global_index_map);
380  }
381  else
382  {
383  // For the staggered scheme
384  OGS_FATAL("A Staggered version of TH2M is not implemented.");
385  }
386 
387  ProcessLib::ProcessVariable const& pv = getProcessVariables(process_id)[0];
388 
391  _local_assemblers, pv.getActiveElementIDs(), dof_tables, t, dt, x, xdot,
392  dxdot_dx, dx_dx, process_id, M, K, b, Jac);
393 
394  auto copyRhs = [&](int const variable_id, auto& output_vector)
395  {
396  if (_use_monolithic_scheme)
397  {
398  transformVariableFromGlobalVector(b, variable_id, dof_tables[0],
399  output_vector,
400  std::negate<double>());
401  }
402  else
403  {
404  transformVariableFromGlobalVector(b, 0, dof_tables[process_id],
405  output_vector,
406  std::negate<double>());
407  }
408  };
409  if (_use_monolithic_scheme || process_id == 1)
410  {
411  copyRhs(0, *_hydraulic_flow);
412  }
413  if (_use_monolithic_scheme || process_id == 2)
414  {
415  copyRhs(1, *_nodal_forces);
416  }
417 }
418 
419 template <int DisplacementDim>
421  std::vector<GlobalVector*> const& x, double const t, double const dt,
422  const int process_id)
423 {
424  DBUG("PreTimestep TH2MProcess.");
425 
426  if (hasMechanicalProcess(process_id))
427  {
428  ProcessLib::ProcessVariable const& pv =
429  getProcessVariables(process_id)[0];
430 
432  &LocalAssemblerInterface::preTimestep, _local_assemblers,
433  pv.getActiveElementIDs(), *_local_to_global_index_map,
434  *x[process_id], t, dt);
435  }
436 }
437 
438 template <int DisplacementDim>
440  std::vector<GlobalVector*> const& x, double const t, double const dt,
441  const int process_id)
442 {
443  DBUG("PostTimestep TH2MProcess.");
444  auto const dof_tables = getDOFTables(x.size());
445  ProcessLib::ProcessVariable const& pv = getProcessVariables(process_id)[0];
447  &LocalAssemblerInterface::postTimestep, _local_assemblers,
448  pv.getActiveElementIDs(), dof_tables, x, t, dt);
449 }
450 
451 template <int DisplacementDim>
453  double const t, double const dt, std::vector<GlobalVector*> const& x,
454  GlobalVector const& x_dot, const int process_id)
455 {
456  if (process_id != 0)
457  {
458  return;
459  }
460 
461  DBUG("Compute the secondary variables for TH2MProcess.");
462  auto const dof_tables = getDOFTables(x.size());
463 
464  ProcessLib::ProcessVariable const& pv = getProcessVariables(process_id)[0];
467  pv.getActiveElementIDs(), dof_tables, t, dt, x, x_dot, process_id);
468 }
469 
470 template <int DisplacementDim>
471 std::tuple<NumLib::LocalToGlobalIndexMap*, bool>
473 {
474  const bool manage_storage = false;
475  return std::make_tuple(_local_to_global_index_map_single_component.get(),
476  manage_storage);
477 }
478 
479 template <int DisplacementDim>
481  const int process_id) const
482 {
483  if (hasMechanicalProcess(process_id))
484  {
485  return *_local_to_global_index_map;
486  }
487 
488  // For the equation of pressure
489  return *_local_to_global_index_map_with_base_nodes;
490 }
491 
492 template <int DisplacementDim>
493 std::vector<NumLib::LocalToGlobalIndexMap const*>
494 TH2MProcess<DisplacementDim>::getDOFTables(int const number_of_processes) const
495 {
496  std::vector<NumLib::LocalToGlobalIndexMap const*> dof_tables;
497  dof_tables.reserve(number_of_processes);
498  std::generate_n(std::back_inserter(dof_tables), number_of_processes,
499  [&]() { return &getDOFTable(dof_tables.size()); });
500  return dof_tables;
501 }
502 template class TH2MProcess<2>;
503 template class TH2MProcess<3>;
504 
505 } // namespace TH2M
506 } // namespace ProcessLib
#define OGS_FATAL(...)
Definition: Error.h:26
void DBUG(char const *fmt, Args const &... args)
Definition: Logging.h:27
Global vector based on Eigen vector.
Definition: EigenVector.h:26
bool isAxiallySymmetric() const
Definition: Mesh.h:126
unsigned getDimension() const
Returns the dimension of the mesh (determined by the maximum dimension over all elements).
Definition: Mesh.h:71
std::vector< Element * > const & getElements() const
Get the element-vector for the mesh.
Definition: Mesh.h:98
Properties & getProperties()
Definition: Mesh.h:123
bool existsPropertyVector(std::string const &name) const
virtual void postTimestep(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)
virtual void preTimestep(std::size_t const mesh_item_id, NumLib::LocalToGlobalIndexMap const &dof_table, GlobalVector const &x, double const t, double const delta_t)
virtual void initialize(std::size_t const mesh_item_id, NumLib::LocalToGlobalIndexMap const &dof_table)
void setInitialConditions(std::size_t const mesh_item_id, NumLib::LocalToGlobalIndexMap const &dof_table, GlobalVector const &x, double const t, bool const use_monolithic_scheme, 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_dot, int const process_id)
std::vector< std::size_t > const & getActiveElementIDs() const
std::vector< std::unique_ptr< IntegrationPointWriter > > _integration_point_writer
Definition: Process.h:350
Handles configuration of several secondary variables from the project file.
void assembleConcreteProcess(const double t, double const dt, std::vector< GlobalVector * > const &x, std::vector< GlobalVector * > const &xdot, int const process_id, GlobalMatrix &M, GlobalMatrix &K, GlobalVector &b) override
bool isLinear() const override
Definition: TH2MProcess.cpp:73
std::vector< std::unique_ptr< LocalAssemblerInterface > > _local_assemblers
Definition: TH2MProcess.h:109
std::tuple< NumLib::LocalToGlobalIndexMap *, bool > getDOFTableForExtrapolatorData() const override
TH2MProcess(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, TH2MProcessData< DisplacementDim > &&process_data, SecondaryVariableCollection &&secondary_variables, bool const use_monolithic_scheme)
Definition: TH2MProcess.cpp:27
void setInitialConditionsConcreteProcess(std::vector< GlobalVector * > &x, double const t, int const process_id) override
MeshLib::PropertyVector< double > * _nodal_forces
Definition: TH2MProcess.h:141
std::vector< NumLib::LocalToGlobalIndexMap const * > getDOFTables(int const number_of_processes) const
void preTimestepConcreteProcess(std::vector< GlobalVector * > const &x, double const t, double const dt, const int process_id) override
void postTimestepConcreteProcess(std::vector< GlobalVector * > const &x, const double t, const double dt, int const) override
MathLib::MatrixSpecifications getMatrixSpecifications(const int process_id) const override
Definition: TH2MProcess.cpp:80
MeshLib::PropertyVector< double > * _hydraulic_flow
Definition: TH2MProcess.h:142
void constructDofTable() override
Definition: TH2MProcess.cpp:99
void computeSecondaryVariableConcrete(double const t, double const dt, std::vector< GlobalVector * > const &x, GlobalVector const &x_dot, const int process_id) override
NumLib::LocalToGlobalIndexMap const & getDOFTable(const int process_id) const override
void initializeConcreteProcess(NumLib::LocalToGlobalIndexMap const &dof_table, MeshLib::Mesh const &mesh, unsigned const integration_order) override
Process specific initialization called by initialize().
void assembleWithJacobianConcreteProcess(const double t, double const dt, std::vector< GlobalVector * > const &x, std::vector< GlobalVector * > const &xdot, const double dxdot_dx, const double dx_dx, int const process_id, GlobalMatrix &M, GlobalMatrix &K, GlobalVector &b, GlobalMatrix &Jac) override
void initializeBoundaryConditions() override
void assembleWithJacobian(std::size_t const mesh_item_id, LocalAssemblerInterface &local_assembler, std::vector< std::reference_wrapper< NumLib::LocalToGlobalIndexMap >> const &dof_tables, const double t, double const dt, std::vector< GlobalVector * > const &x, std::vector< GlobalVector * > const &xdot, const double dxdot_dx, const double dx_dx, int const process_id, GlobalMatrix &M, GlobalMatrix &K, GlobalVector &b, GlobalMatrix &Jac)
void assemble(std::size_t const mesh_item_id, LocalAssemblerInterface &local_assembler, std::vector< std::reference_wrapper< NumLib::LocalToGlobalIndexMap >> const &dof_tables, double const t, double const dt, std::vector< GlobalVector * > const &x, std::vector< GlobalVector * > const &xdot, int const process_id, GlobalMatrix &M, GlobalMatrix &K, GlobalVector &b)
Eigen::Matrix< double, kelvin_vector_dimensions(DisplacementDim), 1, Eigen::ColMajor > KelvinVectorType
Definition: KelvinVector.h:48
std::vector< Node * > getBaseNodes(std::vector< Element * > const &elements)
Definition: Utils.h:26
@ BY_LOCATION
Ordering data by spatial location.
void transformVariableFromGlobalVector(GlobalVector const &input_vector, int const variable_id, NumLib::LocalToGlobalIndexMap const &local_to_global_index_map, MeshLib::PropertyVector< double > &output_vector, Functor mapFunction)
Definition: DOFTableUtil.h:59
void createLocalAssemblers(const unsigned, std::vector< MeshLib::Element * > const &mesh_elements, NumLib::LocalToGlobalIndexMap const &dof_table, const unsigned shapefunction_order, std::vector< std::unique_ptr< LocalAssemblerInterface >> &local_assemblers, ExtraCtorArgs &&... extra_ctor_args)
IntegrationPointMetaData getIntegrationPointMetaData(MeshLib::Mesh const &mesh, std::string const &name)
SecondaryVariableFunctions makeExtrapolator(const unsigned num_components, NumLib::Extrapolator &extrapolator, LocalAssemblerCollection const &local_assemblers, typename NumLib::ExtrapolatableLocalAssemblerCollection< LocalAssemblerCollection >::IntegrationPointValuesMethod integration_point_values_method)
static void executeSelectedMemberOnDereferenced(Method method, Container const &container, std::vector< std::size_t > const &active_container_ids, Args &&... args)
static void executeSelectedMemberDereferenced(Object &object, Method method, Container const &container, std::vector< std::size_t > const &active_container_ids, Args &&... args)
static void executeMemberOnDereferenced(Method method, Container const &container, Args &&... args)
virtual std::vector< double > const & getIntPtEnthalpyLiquid(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 & getIntPtMassFractionLiquid(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 & 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 & getIntPtMoleFractionGas(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 & getIntPtSolidDensity(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 & getIntPtPorosity(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 & getIntPtGasDensity(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 > getSaturation() const =0
virtual std::vector< double > getEpsilon() const =0
virtual std::vector< double > const & getIntPtRelativePermeabilityGas(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 & getIntPtDarcyVelocityLiquid(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 & getIntPtEnthalpyGas(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 & getIntPtRelativePermeabilityLiquid(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 > getSigma() const =0
virtual std::vector< double > const & getIntPtEnthalpySolid(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 & getIntPtSigma(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 & getIntPtVapourPressure(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 & getIntPtMassFractionGas(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 & getIntPtDarcyVelocityGas(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 & getIntPtEpsilon(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 & getIntPtSaturation(const double t, std::vector< GlobalVector * > const &x, std::vector< NumLib::LocalToGlobalIndexMap const * > const &dof_table, std::vector< double > &cache) const =0