OGS
ProcessLib::HT::HTProcess Class Referencefinal

Detailed Description

HT process

The implementation uses a monolithic approach, i.e., both processes are assembled within one global system of equations.

Process Coupling

The advective term of the heat conduction equation is given by the confined groundwater flow process, i.e., the heat conduction depends on darcy velocity of the groundwater flow process. On the other hand the temperature dependencies of the viscosity and density in the groundwater flow couples the H process to the T process.

Note
At the moment there is not any coupling by source or sink terms, i.e., the coupling is implemented only by density changes due to temperature changes in the buoyance term in the groundwater flow. This coupling schema is referred to as the Boussinesq approximation.

Definition at line 52 of file HTProcess.h.

#include <HTProcess.h>

Inheritance diagram for ProcessLib::HT::HTProcess:
[legend]
Collaboration diagram for ProcessLib::HT::HTProcess:
[legend]

Public Member Functions

 HTProcess (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, HTProcessData &&process_data, SecondaryVariableCollection &&secondary_variables, bool const use_monolithic_scheme, std::unique_ptr< ProcessLib::SurfaceFluxData > &&surfaceflux)
 
Eigen::Vector3d getFlux (std::size_t element_id, MathLib::Point3d const &p, double const t, std::vector< GlobalVector * > const &x) const override
 
void setCoupledTermForTheStaggeredSchemeToLocalAssemblers (int const process_id) override
 
void postTimestepConcreteProcess (std::vector< GlobalVector * > const &x, const double t, const double delta_t, int const process_id) override
 
ODESystem interface
bool isLinear () const override
 
- Public Member Functions inherited from ProcessLib::Process
 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)
 
void preTimestep (std::vector< GlobalVector * > const &x, const double t, const double delta_t, const int process_id)
 Preprocessing before starting assembly for new timestep. More...
 
void postTimestep (std::vector< GlobalVector * > const &x, const double t, const double delta_t, int const process_id)
 Postprocessing after a complete timestep. More...
 
void postNonLinearSolver (GlobalVector const &x, GlobalVector const &xdot, const double t, double const dt, int const process_id)
 
void preIteration (const unsigned iter, GlobalVector const &x) final
 
void computeSecondaryVariable (double const t, double const dt, std::vector< GlobalVector * > const &x, GlobalVector const &x_dot, int const process_id)
 compute secondary variables for the coupled equations or for output. More...
 
NumLib::IterationResult postIteration (GlobalVector const &x) final
 
void initialize ()
 
void setInitialConditions (std::vector< GlobalVector * > &process_solutions, std::vector< GlobalVector * > const &process_solutions_prev, double const t, int const process_id)
 
MathLib::MatrixSpecifications getMatrixSpecifications (const int process_id) const override
 
void setCoupledSolutionsForStaggeredScheme (CoupledSolutionsForStaggeredScheme *const coupled_solutions)
 
void updateDeactivatedSubdomains (double const time, const int process_id)
 
bool isMonolithicSchemeUsed () const
 
virtual void extrapolateIntegrationPointValuesToNodes (const double, std::vector< GlobalVector * > const &, std::vector< GlobalVector * > &)
 
void preAssemble (const double t, double const dt, GlobalVector const &x) final
 
void assemble (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) final
 
void assembleWithJacobian (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) final
 
std::vector< NumLib::IndexValueVector< GlobalIndexType > > const * getKnownSolutions (double const t, GlobalVector const &x, int const process_id) const final
 
virtual NumLib::LocalToGlobalIndexMap const & getDOFTable (const int) const
 
MeshLib::MeshgetMesh () const
 
std::vector< std::reference_wrapper< ProcessVariable > > const & getProcessVariables (const int process_id) const
 
SecondaryVariableCollection const & getSecondaryVariables () const
 
std::vector< std::unique_ptr< IntegrationPointWriter > > const * getIntegrationPointWriter (MeshLib::Mesh const &mesh) const
 
virtual void solveReactionEquation (std::vector< GlobalVector * > &, std::vector< GlobalVector * > const &, double const, double const, NumLib::EquationSystem &, int const)
 

Private Member Functions

void initializeConcreteProcess (NumLib::LocalToGlobalIndexMap const &dof_table, MeshLib::Mesh const &mesh, unsigned const integration_order) override
 Process specific initialization called by initialize(). More...
 
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
 
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
 
std::tuple< NumLib::LocalToGlobalIndexMap *, bool > getDOFTableForExtrapolatorData () const override
 

Private Attributes

HTProcessData _process_data
 
std::vector< std::unique_ptr< HTLocalAssemblerInterface > > _local_assemblers
 
std::unique_ptr< ProcessLib::SurfaceFluxData_surfaceflux
 

Additional Inherited Members

- Public Types inherited from ProcessLib::Process
using NonlinearSolver = NumLib::NonlinearSolverBase
 
using TimeDiscretization = NumLib::TimeDiscretization
 
- Public Attributes inherited from ProcessLib::Process
std::string const name
 
- Protected Member Functions inherited from ProcessLib::Process
NumLib::ExtrapolatorgetExtrapolator () const
 
NumLib::LocalToGlobalIndexMap const & getSingleComponentDOFTable () const
 
void initializeProcessBoundaryConditionsAndSourceTerms (const NumLib::LocalToGlobalIndexMap &dof_table, const int process_id)
 
virtual void constructDofTable ()
 
void constructMonolithicProcessDofTable ()
 
void constructDofTableOfSpecifiedProcessStaggeredScheme (const int specified_prosess_id)
 
- Protected Attributes inherited from ProcessLib::Process
MeshLib::Mesh_mesh
 
std::unique_ptr< MeshLib::MeshSubset const > _mesh_subset_all_nodes
 
std::unique_ptr< NumLib::LocalToGlobalIndexMap_local_to_global_index_map
 
SecondaryVariableCollection _secondary_variables
 
VectorMatrixAssembler _global_assembler
 
const bool _use_monolithic_scheme
 
CoupledSolutionsForStaggeredScheme_coupled_solutions
 
unsigned const _integration_order
 
std::vector< std::unique_ptr< IntegrationPointWriter > > _integration_point_writer
 
GlobalSparsityPattern _sparsity_pattern
 
std::vector< std::vector< std::reference_wrapper< ProcessVariable > > > _process_variables
 
std::vector< BoundaryConditionCollection_boundary_conditions
 

Constructor & Destructor Documentation

◆ HTProcess()

ProcessLib::HT::HTProcess::HTProcess ( 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,
HTProcessData &&  process_data,
SecondaryVariableCollection &&  secondary_variables,
bool const  use_monolithic_scheme,
std::unique_ptr< ProcessLib::SurfaceFluxData > &&  surfaceflux 
)

Definition at line 26 of file HTProcess.cpp.

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  _surfaceflux(std::move(surfaceflux))
43 {
44 }
std::unique_ptr< ProcessLib::SurfaceFluxData > _surfaceflux
Definition: HTProcess.h:117
HTProcessData _process_data
Definition: HTProcess.h:113
std::string const name
Definition: Process.h:323
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:22

Member Function Documentation

◆ assembleConcreteProcess()

void ProcessLib::HT::HTProcess::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 
)
overrideprivatevirtual

Implements ProcessLib::Process.

Definition at line 80 of file HTProcess.cpp.

85 {
86  std::vector<std::reference_wrapper<NumLib::LocalToGlobalIndexMap>>
87  dof_tables;
89  {
90  DBUG("Assemble HTProcess.");
91  dof_tables.emplace_back(*_local_to_global_index_map);
92  }
93  else
94  {
95  if (process_id == _process_data.heat_transport_process_id)
96  {
97  DBUG(
98  "Assemble the equations of heat transport process within "
99  "HTProcess.");
100  }
101  else
102  {
103  DBUG(
104  "Assemble the equations of single phase fully saturated "
105  "fluid flow process within HTProcess.");
106  }
107  dof_tables.emplace_back(*_local_to_global_index_map);
108  dof_tables.emplace_back(*_local_to_global_index_map);
109  }
110 
111  ProcessLib::ProcessVariable const& pv = getProcessVariables(process_id)[0];
112  // Call global assembler for each local assembly item.
115  pv.getActiveElementIDs(), dof_tables, t, dt, x, xdot, process_id, M, K,
116  b);
117 }
void DBUG(char const *fmt, Args const &... args)
Definition: Logging.h:27
std::vector< std::unique_ptr< HTLocalAssemblerInterface > > _local_assemblers
Definition: HTProcess.h:115
std::vector< std::size_t > const & getActiveElementIDs() const
std::vector< std::reference_wrapper< ProcessVariable > > const & getProcessVariables(const int process_id) const
Definition: Process.h:145
VectorMatrixAssembler _global_assembler
Definition: Process.h:333
std::unique_ptr< NumLib::LocalToGlobalIndexMap > _local_to_global_index_map
Definition: Process.h:329
const bool _use_monolithic_scheme
Definition: Process.h:335
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)
static void executeSelectedMemberDereferenced(Object &object, Method method, Container const &container, std::vector< std::size_t > const &active_container_ids, Args &&... args)

References ProcessLib::Process::_global_assembler, _local_assemblers, ProcessLib::Process::_local_to_global_index_map, _process_data, ProcessLib::Process::_use_monolithic_scheme, ProcessLib::VectorMatrixAssembler::assemble(), DBUG(), NumLib::SerialExecutor::executeSelectedMemberDereferenced(), ProcessLib::ProcessVariable::getActiveElementIDs(), ProcessLib::Process::getProcessVariables(), and ProcessLib::HT::HTProcessData::heat_transport_process_id.

◆ assembleWithJacobianConcreteProcess()

void ProcessLib::HT::HTProcess::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 
)
overrideprivatevirtual

Implements ProcessLib::Process.

Definition at line 119 of file HTProcess.cpp.

124 {
125  DBUG("AssembleWithJacobian HTProcess.");
126 
127  std::vector<std::reference_wrapper<NumLib::LocalToGlobalIndexMap>>
128  dof_tables;
130  {
131  dof_tables.emplace_back(std::ref(*_local_to_global_index_map));
132  }
133  else
134  {
135  dof_tables.emplace_back(std::ref(*_local_to_global_index_map));
136  dof_tables.emplace_back(std::ref(*_local_to_global_index_map));
137  }
138 
139  // Call global assembler for each local assembly item.
140  ProcessLib::ProcessVariable const& pv = getProcessVariables(process_id)[0];
143  _local_assemblers, pv.getActiveElementIDs(), dof_tables, t, dt, x, xdot,
144  dxdot_dx, dx_dx, process_id, M, K, b, Jac);
145 }
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)

References ProcessLib::Process::_global_assembler, _local_assemblers, ProcessLib::Process::_local_to_global_index_map, ProcessLib::Process::_use_monolithic_scheme, ProcessLib::VectorMatrixAssembler::assembleWithJacobian(), DBUG(), NumLib::SerialExecutor::executeSelectedMemberDereferenced(), ProcessLib::ProcessVariable::getActiveElementIDs(), and ProcessLib::Process::getProcessVariables().

◆ getDOFTableForExtrapolatorData()

std::tuple< NumLib::LocalToGlobalIndexMap *, bool > ProcessLib::HT::HTProcess::getDOFTableForExtrapolatorData ( ) const
overrideprivatevirtual

Get the address of a LocalToGlobalIndexMap, and the status of its memory. If the LocalToGlobalIndexMap is created as new in this function, the function also returns a true boolean value to let Extrapolator manage the memory by the address returned by this function.

Returns
Address of a LocalToGlobalIndexMap and its memory status.

Reimplemented from ProcessLib::Process.

Definition at line 159 of file HTProcess.cpp.

160 {
162  {
163  // For single-variable-single-component processes reuse the existing DOF
164  // table.
165  const bool manage_storage = false;
166  return std::make_tuple(_local_to_global_index_map.get(),
167  manage_storage);
168  }
169 
170  // Otherwise construct a new DOF table.
171  std::vector<MeshLib::MeshSubset> all_mesh_subsets_single_component{
173 
174  const bool manage_storage = true;
175  return std::make_tuple(new NumLib::LocalToGlobalIndexMap(
176  std::move(all_mesh_subsets_single_component),
177  // by location order is needed for output
179  manage_storage);
180 }
std::unique_ptr< MeshLib::MeshSubset const > _mesh_subset_all_nodes
Definition: Process.h:327
@ BY_LOCATION
Ordering data by spatial location.

References ProcessLib::Process::_local_to_global_index_map, ProcessLib::Process::_mesh_subset_all_nodes, ProcessLib::Process::_use_monolithic_scheme, and NumLib::BY_LOCATION.

◆ getFlux()

Eigen::Vector3d ProcessLib::HT::HTProcess::getFlux ( std::size_t  element_id,
MathLib::Point3d const &  p,
double const  t,
std::vector< GlobalVector * > const &  x 
) const
overridevirtual

Reimplemented from ProcessLib::Process.

Definition at line 182 of file HTProcess.cpp.

186 {
187  // fetch local_x from primary variable
188  std::vector<GlobalIndexType> indices_cache;
189  auto const r_c_indices = NumLib::getRowColumnIndices(
190  element_id, *_local_to_global_index_map, indices_cache);
191  std::vector<std::vector<GlobalIndexType>> indices_of_all_coupled_processes{
192  x.size(), r_c_indices.rows};
193  auto const local_x =
194  getCoupledLocalSolutions(x, indices_of_all_coupled_processes);
195 
196  return _local_assemblers[element_id]->getFlux(p, t, local_x);
197 }
NumLib::LocalToGlobalIndexMap::RowColumnIndices getRowColumnIndices(std::size_t const id, NumLib::LocalToGlobalIndexMap const &dof_table, std::vector< GlobalIndexType > &indices)
std::vector< double > getCoupledLocalSolutions(std::vector< GlobalVector * > const &global_solutions, std::vector< std::vector< GlobalIndexType >> const &indices)

References _local_assemblers, ProcessLib::Process::_local_to_global_index_map, ProcessLib::getCoupledLocalSolutions(), and NumLib::getRowColumnIndices().

◆ initializeConcreteProcess()

void ProcessLib::HT::HTProcess::initializeConcreteProcess ( NumLib::LocalToGlobalIndexMap const &  dof_table,
MeshLib::Mesh const &  mesh,
unsigned const  integration_order 
)
overrideprivatevirtual

Process specific initialization called by initialize().

Implements ProcessLib::Process.

Definition at line 46 of file HTProcess.cpp.

50 {
51  // For the staggered scheme, both processes are assumed to use the same
52  // element order. Therefore the order of shape function can be fetched from
53  // any set of the sets of process variables of the coupled processes. Here,
54  // we take the one from the first process by setting process_id = 0.
55  const int process_id = 0;
56  ProcessLib::ProcessVariable const& pv = getProcessVariables(process_id)[0];
57 
59  {
60  ProcessLib::createLocalAssemblers<MonolithicHTFEM>(
61  mesh.getDimension(), mesh.getElements(), dof_table,
63  mesh.isAxiallySymmetric(), integration_order, _process_data);
64  }
65  else
66  {
67  ProcessLib::createLocalAssemblers<StaggeredHTFEM>(
68  mesh.getDimension(), mesh.getElements(), dof_table,
70  mesh.isAxiallySymmetric(), integration_order, _process_data);
71  }
72 
74  "darcy_velocity",
75  makeExtrapolator(mesh.getDimension(), getExtrapolator(),
78 }
virtual std::vector< double > const & getIntPtDarcyVelocity(const double, std::vector< GlobalVector * > const &x, std::vector< NumLib::LocalToGlobalIndexMap const * > const &, std::vector< double > &) const =0
unsigned getShapeFunctionOrder() const
NumLib::Extrapolator & getExtrapolator() const
Definition: Process.h:185
SecondaryVariableCollection _secondary_variables
Definition: Process.h:331
void addSecondaryVariable(std::string const &internal_name, SecondaryVariableFunctions &&fcts)
SecondaryVariableFunctions makeExtrapolator(const unsigned num_components, NumLib::Extrapolator &extrapolator, LocalAssemblerCollection const &local_assemblers, typename NumLib::ExtrapolatableLocalAssemblerCollection< LocalAssemblerCollection >::IntegrationPointValuesMethod integration_point_values_method)

References _local_assemblers, _process_data, ProcessLib::Process::_secondary_variables, ProcessLib::Process::_use_monolithic_scheme, ProcessLib::SecondaryVariableCollection::addSecondaryVariable(), MeshLib::Mesh::getDimension(), MeshLib::Mesh::getElements(), ProcessLib::Process::getExtrapolator(), ProcessLib::HT::HTLocalAssemblerInterface::getIntPtDarcyVelocity(), ProcessLib::Process::getProcessVariables(), ProcessLib::ProcessVariable::getShapeFunctionOrder(), MeshLib::Mesh::isAxiallySymmetric(), and ProcessLib::makeExtrapolator().

◆ isLinear()

bool ProcessLib::HT::HTProcess::isLinear ( ) const
inlineoverride

Definition at line 72 of file HTProcess.h.

72 { return false; }

◆ postTimestepConcreteProcess()

void ProcessLib::HT::HTProcess::postTimestepConcreteProcess ( std::vector< GlobalVector * > const &  x,
const double  t,
const double  delta_t,
int const  process_id 
)
overridevirtual

Reimplemented from ProcessLib::Process.

Definition at line 200 of file HTProcess.cpp.

204 {
205  // For the monolithic scheme, process_id is always zero.
206  if (_use_monolithic_scheme && process_id != 0)
207  {
208  OGS_FATAL(
209  "The condition of process_id = 0 must be satisfied for monolithic "
210  "HTProcess, which is a single process.");
211  }
212  if (!_use_monolithic_scheme &&
213  process_id != _process_data.hydraulic_process_id)
214  {
215  DBUG("This is the thermal part of the staggered HTProcess.");
216  return;
217  }
218  if (!_surfaceflux) // computing the surfaceflux is optional
219  {
220  return;
221  }
222 
223  ProcessLib::ProcessVariable const& pv = getProcessVariables(process_id)[0];
224 
225  _surfaceflux->integrate(x, t, *this, process_id, _integration_order, _mesh,
226  pv.getActiveElementIDs());
227 }
#define OGS_FATAL(...)
Definition: Error.h:26
MeshLib::Mesh & _mesh
Definition: Process.h:326
unsigned const _integration_order
Definition: Process.h:344

References ProcessLib::Process::_integration_order, ProcessLib::Process::_mesh, _process_data, _surfaceflux, ProcessLib::Process::_use_monolithic_scheme, DBUG(), ProcessLib::ProcessVariable::getActiveElementIDs(), ProcessLib::Process::getProcessVariables(), ProcessLib::HT::HTProcessData::hydraulic_process_id, and OGS_FATAL.

◆ setCoupledTermForTheStaggeredSchemeToLocalAssemblers()

void ProcessLib::HT::HTProcess::setCoupledTermForTheStaggeredSchemeToLocalAssemblers ( int const  process_id)
overridevirtual

Reimplemented from ProcessLib::Process.

Definition at line 147 of file HTProcess.cpp.

149 {
150  DBUG("Set the coupled term for the staggered scheme to local assembers.");
151 
152  ProcessLib::ProcessVariable const& pv = getProcessVariables(process_id)[0];
156 }
void setStaggeredCoupledSolutions(std::size_t const, CoupledSolutionsForStaggeredScheme *const coupling_term)
CoupledSolutionsForStaggeredScheme * _coupled_solutions
Definition: Process.h:339
static void executeSelectedMemberOnDereferenced(Method method, Container const &container, std::vector< std::size_t > const &active_container_ids, Args &&... args)

References ProcessLib::Process::_coupled_solutions, _local_assemblers, DBUG(), NumLib::SerialExecutor::executeSelectedMemberOnDereferenced(), ProcessLib::ProcessVariable::getActiveElementIDs(), ProcessLib::Process::getProcessVariables(), and ProcessLib::HT::HTLocalAssemblerInterface::setStaggeredCoupledSolutions().

Member Data Documentation

◆ _local_assemblers

std::vector<std::unique_ptr<HTLocalAssemblerInterface> > ProcessLib::HT::HTProcess::_local_assemblers
private

◆ _process_data

HTProcessData ProcessLib::HT::HTProcess::_process_data
private

◆ _surfaceflux

std::unique_ptr<ProcessLib::SurfaceFluxData> ProcessLib::HT::HTProcess::_surfaceflux
private

Definition at line 117 of file HTProcess.h.

Referenced by postTimestepConcreteProcess().


The documentation for this class was generated from the following files: