![]() |
OGS
|
|
Definition at line 18 of file HeatTransportBHEProcess.h.
#include <HeatTransportBHEProcess.h>
Public Member Functions | |
| HeatTransportBHEProcess (std::string name, MeshLib::Mesh &mesh, std::unique_ptr< ProcessLib::AbstractJacobianAssembler > &&jacobian_assembler, std::vector< std::unique_ptr< ParameterLib::ParameterBase > > const ¶meters, unsigned const integration_order, std::vector< std::vector< std::reference_wrapper< ProcessVariable > > > &&process_variables, HeatTransportBHEProcessData &&process_data, SecondaryVariableCollection &&secondary_variables, BHEMeshData &&bhe_mesh_data) | |
| void | computeSecondaryVariableConcrete (double const t, double const dt, std::vector< GlobalVector * > const &x, GlobalVector const &x_prev, int const process_id) override |
ODESystem interface | |
| bool | isLinear () const override |
| bool | requiresNormalization () 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 ¶meters, 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. | |
| void | postTimestep (std::vector< GlobalVector * > const &x, std::vector< GlobalVector * > const &x_prev, const double t, const double delta_t, int const process_id) |
| Postprocessing after a complete timestep. | |
| void | postNonLinearSolver (std::vector< GlobalVector * > const &x, std::vector< GlobalVector * > const &x_prev, 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_prev, int const process_id) |
| compute secondary variables for the coupled equations or for output. | |
| NumLib::IterationResult | postIteration (GlobalVector const &x) final |
| void | initialize (std::map< int, std::shared_ptr< MaterialPropertyLib::Medium > > const &media) |
| 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 | updateDeactivatedSubdomains (double const time, const int process_id) |
| virtual 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 &x_prev, 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 &x_prev, int const process_id, GlobalVector &b, GlobalMatrix &Jac) final |
| void | preOutput (const double t, double const dt, std::vector< GlobalVector * > const &x, std::vector< GlobalVector * > const &x_prev, int const process_id) |
| 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::Mesh & | getMesh () const |
| std::vector< std::vector< std::reference_wrapper< ProcessVariable > > > const & | getProcessVariables () const |
| std::vector< std::reference_wrapper< ProcessVariable > > const & | getProcessVariables (const int process_id) const |
| std::vector< std::size_t > const & | getActiveElementIDs () const |
| SecondaryVariableCollection const & | getSecondaryVariables () const |
| std::vector< std::unique_ptr< MeshLib::IntegrationPointWriter > > const & | getIntegrationPointWriters () const |
| virtual Eigen::Vector3d | getFlux (std::size_t, MathLib::Point3d const &, double const, std::vector< GlobalVector * > const &) const |
| virtual void | solveReactionEquation (std::vector< GlobalVector * > &, std::vector< GlobalVector * > const &, double const, double const, NumLib::EquationSystem &, int const) |
| bool | requiresNormalization () const override |
| Public Member Functions inherited from ProcessLib::SubmeshAssemblySupport | |
| virtual | ~SubmeshAssemblySupport ()=default |
Private Member Functions | |
| void | constructDofTable () override |
| void | initializeConcreteProcess (NumLib::LocalToGlobalIndexMap const &dof_table, MeshLib::Mesh const &mesh, unsigned const integration_order) override |
| Process specific initialization called by initialize(). | |
| std::vector< std::vector< std::string > > | initializeAssemblyOnSubmeshes (std::vector< std::reference_wrapper< MeshLib::Mesh > > const &meshes) 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 | 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 | createBHEBoundaryConditionTopBottom (std::vector< std::vector< MeshLib::Node * > > const &all_bhe_nodes) |
| void | preTimestepConcreteProcess (std::vector< GlobalVector * > const &x, const double t, const double dt, int const process_id) 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 |
| void | algebraicBcConcreteProcess (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) |
| NumLib::IterationResult | postIterationConcreteProcess (GlobalVector const &x) override |
| Private Member Functions inherited from ProcessLib::AssemblyMixin< HeatTransportBHEProcess > | |
| void | initializeAssemblyOnSubmeshes (std::vector< std::reference_wrapper< MeshLib::Mesh > > const &submeshes, std::vector< std::vector< std::string > > const &residuum_names) |
| void | updateActiveElements () |
| 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 | 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) |
| void | preOutput (double const t, double const dt, std::vector< GlobalVector * > const &x, std::vector< GlobalVector * > const &x_prev, int const process_id) |
Private Attributes | |
| HeatTransportBHEProcessData | _process_data |
| std::vector< std::unique_ptr< HeatTransportBHELocalAssemblerInterface > > | local_assemblers_ |
| std::vector< std::unique_ptr< MeshLib::MeshSubset const > > | _mesh_subset_BHE_nodes |
| std::vector< std::unique_ptr< MeshLib::MeshSubset const > > | _mesh_subset_BHE_soil_nodes |
| std::vector< std::tuple< std::size_t, GlobalIndexType, GlobalIndexType > > | _vec_top_BHE_node_indices |
| std::vector< std::tuple< std::size_t, GlobalIndexType, GlobalIndexType > > | _vec_bottom_BHE_node_indices |
| std::unique_ptr< MeshLib::MeshSubset const > | _mesh_subset_soil_nodes |
| const BHEMeshData | _bheMeshData |
| std::vector< std::size_t > | _bhes_element_ids |
| std::vector< std::size_t > | _soil_element_ids |
Friends | |
| class | AssemblyMixin< HeatTransportBHEProcess > |
| ProcessLib::HeatTransportBHE::HeatTransportBHEProcess::HeatTransportBHEProcess | ( | 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, | ||
| HeatTransportBHEProcessData && | process_data, | ||
| SecondaryVariableCollection && | secondary_variables, | ||
| BHEMeshData && | bhe_mesh_data ) |
Definition at line 22 of file HeatTransportBHEProcess.cpp.
References HeatTransportBHEProcess(), ProcessLib::Process::Process(), ProcessLib::Process::_jacobian_assembler, and ProcessLib::Process::name.
Referenced by HeatTransportBHEProcess(), and AssemblyMixin< HeatTransportBHEProcess >.
|
private |
Definition at line 461 of file HeatTransportBHEProcess.cpp.
References _process_data, _vec_bottom_BHE_node_indices, _vec_top_BHE_node_indices, and OGS_FATAL.
Referenced by assembleConcreteProcess().
|
overrideprivatevirtual |
Implements ProcessLib::Process.
Definition at line 249 of file HeatTransportBHEProcess.cpp.
References _bhes_element_ids, ProcessLib::Process::_global_assembler, ProcessLib::Process::_local_to_global_index_map, _process_data, _soil_element_ids, algebraicBcConcreteProcess(), ProcessLib::AssemblyMixin< Process >::assemble(), ProcessLib::VectorMatrixAssembler::assemble(), DBUG(), NumLib::SerialExecutor::executeSelectedMemberDereferenced(), ProcessLib::Process::getActiveElementIDs(), ProcessLib::Process::getMatrixSpecifications(), local_assemblers_, OGS_FATAL, and MathLib::setMatrixSparsity().
|
overrideprivatevirtual |
Implements ProcessLib::Process.
Definition at line 299 of file HeatTransportBHEProcess.cpp.
References ProcessLib::AssemblyMixin< Process >::assembleWithJacobian(), and DBUG().
|
overridevirtual |
Reimplemented from ProcessLib::Process.
Definition at line 310 of file HeatTransportBHEProcess.cpp.
References ProcessLib::LocalAssemblerInterface::computeSecondaryVariable(), DBUG(), NumLib::SerialExecutor::executeSelectedMemberOnDereferenced(), ProcessLib::Process::getActiveElementIDs(), and local_assemblers_.
|
overrideprivatevirtual |
This function is for general cases, in which all equations of the coupled processes have the same number of unknowns. For the general cases with the staggered scheme, all equations of the coupled processes share one DOF table hold by _local_to_global_index_map. Other cases can be considered by overloading this member function in the derived class.
Reimplemented from ProcessLib::Process.
Definition at line 73 of file HeatTransportBHEProcess.cpp.
References _bheMeshData, ProcessLib::Process::_local_to_global_index_map, ProcessLib::Process::_mesh, ProcessLib::Process::_mesh_subset_all_nodes, _mesh_subset_BHE_nodes, _mesh_subset_soil_nodes, _process_data, and NumLib::BY_COMPONENT.
|
private |
Definition at line 562 of file HeatTransportBHEProcess.cpp.
References ProcessLib::Process::_boundary_conditions, ProcessLib::Process::_local_to_global_index_map, ProcessLib::Process::_mesh, _process_data, _vec_bottom_BHE_node_indices, _vec_top_BHE_node_indices, ProcessLib::HeatTransportBHE::createBHEBottomDirichletBoundaryCondition(), ProcessLib::HeatTransportBHE::createBHEInflowDirichletBoundaryCondition(), ProcessLib::createBHEInflowPythonBoundaryCondition(), INFO(), MeshLib::Node, and OGS_FATAL.
Referenced by initializeConcreteProcess().
|
overrideprivatevirtual |
Initializes the assembly on submeshes
| meshes | the submeshes on whom the assembly shall proceed. |
meshes must be a must be a non-overlapping cover of the entire simulation domain (bulk mesh)!Reimplemented from ProcessLib::SubmeshAssemblySupport.
Definition at line 213 of file HeatTransportBHEProcess.cpp.
References ProcessLib::Process::_process_variables, DBUG(), ProcessLib::AssemblyMixin< Process >::initializeAssemblyOnSubmeshes(), and OGS_FATAL.
|
overrideprivatevirtual |
Process specific initialization called by initialize().
Implements ProcessLib::Process.
Definition at line 135 of file HeatTransportBHEProcess.cpp.
References _bheMeshData, _bhes_element_ids, _process_data, _soil_element_ids, createBHEBoundaryConditionTopBottom(), ProcessLib::HeatTransportBHE::createLocalAssemblers(), MeshLib::Mesh::getDimension(), MeshLib::Mesh::getElements(), MeshLib::Mesh::getNumberOfElements(), MeshLib::views::ids, MeshLib::Mesh::isAxiallySymmetric(), local_assemblers_, and MeshLib::ElementSearch::searchByNodeIDs().
|
inlineoverride |
Definition at line 41 of file HeatTransportBHEProcess.h.
References _process_data.
|
overrideprivatevirtual |
Reimplemented from ProcessLib::Process.
Definition at line 327 of file HeatTransportBHEProcess.cpp.
References _process_data, DBUG(), NumLib::REPEAT_ITERATION, and NumLib::SUCCESS.
|
overrideprivatevirtual |
Reimplemented from ProcessLib::Process.
Definition at line 422 of file HeatTransportBHEProcess.cpp.
References _process_data, and DBUG().
|
overrideprivatevirtual |
Reimplemented from ProcessLib::Process.
Definition at line 371 of file HeatTransportBHEProcess.cpp.
References _process_data, DBUG(), and ProcessLib::AssemblyMixin< Process >::updateActiveElements().
|
inlineoverride |
Definition at line 49 of file HeatTransportBHEProcess.h.
References _process_data.
|
friend |
Definition at line 18 of file HeatTransportBHEProcess.h.
References HeatTransportBHEProcess(), ProcessLib::Process::Process(), and ProcessLib::Process::name.
|
private |
Definition at line 130 of file HeatTransportBHEProcess.h.
Referenced by constructDofTable(), and initializeConcreteProcess().
|
private |
Definition at line 132 of file HeatTransportBHEProcess.h.
Referenced by assembleConcreteProcess(), and initializeConcreteProcess().
|
private |
Definition at line 111 of file HeatTransportBHEProcess.h.
Referenced by constructDofTable().
|
private |
Definition at line 114 of file HeatTransportBHEProcess.h.
|
private |
Definition at line 128 of file HeatTransportBHEProcess.h.
Referenced by constructDofTable().
|
private |
Definition at line 105 of file HeatTransportBHEProcess.h.
Referenced by algebraicBcConcreteProcess(), assembleConcreteProcess(), constructDofTable(), createBHEBoundaryConditionTopBottom(), initializeConcreteProcess(), isLinear(), postIterationConcreteProcess(), postTimestepConcreteProcess(), preTimestepConcreteProcess(), and requiresNormalization().
|
private |
Definition at line 134 of file HeatTransportBHEProcess.h.
Referenced by assembleConcreteProcess(), and initializeConcreteProcess().
|
private |
Definition at line 126 of file HeatTransportBHEProcess.h.
Referenced by algebraicBcConcreteProcess(), and createBHEBoundaryConditionTopBottom().
|
private |
Definition at line 121 of file HeatTransportBHEProcess.h.
Referenced by algebraicBcConcreteProcess(), and createBHEBoundaryConditionTopBottom().
|
private |
Definition at line 108 of file HeatTransportBHEProcess.h.
Referenced by assembleConcreteProcess(), computeSecondaryVariableConcrete(), and initializeConcreteProcess().