26namespace HeatTransportBHE
31 std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler,
32 std::vector<std::unique_ptr<ParameterLib::ParameterBase>>
const& parameters,
33 unsigned const integration_order,
34 std::vector<std::vector<std::reference_wrapper<ProcessVariable>>>&&
39 :
Process(std::move(name), mesh, std::move(jacobian_assembler), parameters,
40 integration_order, std::move(process_variables),
41 std::move(secondary_variables)),
42 _process_data(std::move(process_data)),
43 _bheMeshData(std::move(bhe_mesh_data))
49 "The number of the given BHE properties ({:d}) are not consistent "
50 "with the number of BHE groups in the mesh ({:d}).",
56 if (material_ids ==
nullptr)
58 OGS_FATAL(
"Not able to get material IDs! ");
85 std::vector<std::vector<MeshLib::Element*>
const*> vec_var_elements;
88 std::vector<int> vec_n_components{
100 for (
int i = 0; i < n_BHEs; i++)
102 auto const number_of_unknowns =
103 visit([](
auto const& bhe) {
return bhe.number_of_unknowns; },
110 std::make_unique<MeshLib::MeshSubset const>(
_mesh, bhe_nodes));
112 std::generate_n(std::back_inserter(all_mesh_subsets),
119 vec_n_components.push_back(number_of_unknowns);
120 vec_var_elements.push_back(&bhe_elements);
124 std::make_unique<NumLib::LocalToGlobalIndexMap>(
125 std::move(all_mesh_subsets),
137 unsigned const integration_order)
140 std::unordered_map<std::size_t, BHE::BHETypes*> element_to_bhe_map;
142 for (
int i = 0; i < n_BHEs; i++)
145 for (
auto const& e : bhe_elements)
147 element_to_bhe_map[e->getID()] =
164 std::vector<std::size_t>
const bhes_node_ids =
166 ranges::views::transform([](
auto const*
const node)
167 {
return node->getID(); }) |
168 ranges::to<std::vector>;
172 es.searchByNodeIDs(bhes_node_ids);
177 for (
auto const id : es.getSearchedElementIDs())
185 const double t,
double const dt, std::vector<GlobalVector*>
const& x,
186 std::vector<GlobalVector*>
const& x_prev,
int const process_id,
189 DBUG(
"Assemble HeatTransportBHE process.");
191 std::vector<NumLib::LocalToGlobalIndexMap const*> dof_table = {
208 const double t,
double const dt, std::vector<GlobalVector*>
const& x,
209 std::vector<GlobalVector*>
const& x_prev,
int const process_id,
212 DBUG(
"AssembleWithJacobian HeatTransportBHE process.");
214 std::vector<NumLib::LocalToGlobalIndexMap const*> dof_table = {
221 process_id, &b, &Jac);
225 double const t,
double const dt, std::vector<GlobalVector*>
const& x,
228 DBUG(
"Compute heat flux for HeatTransportBHE process.");
230 std::vector<NumLib::LocalToGlobalIndexMap const*> dof_tables;
231 dof_tables.reserve(x.size());
232 std::generate_n(std::back_inserter(dof_tables), x.size(),
233 [&]() { return _local_to_global_index_map.get(); });
250 auto const Tout_nodes_id =
252 const std::size_t n_bc_nodes = Tout_nodes_id.size();
254 for (std::size_t i = 0; i < n_bc_nodes; i++)
267 DBUG(
"Method `tespySolver' not overridden in Python script.");
271 for (std::size_t i = 0; i < n_bc_nodes; i++)
274 std::get<2>(tespy_result)[i];
276 std::get<3>(tespy_result)[i];
278 auto const tespy_has_converged = std::get<1>(tespy_result);
279 if (tespy_has_converged ==
true)
286 std::vector<GlobalVector*>
const& x,
const double t,
const double dt,
287 int const process_id)
295 auto& [time, Tin_value, Tout_value, Tout_nodes_ids, flowrate] =
303 auto const& solution = *x[process_id];
306 const std::size_t n_bc_nodes = Tout_nodes_ids.size();
307 for (std::size_t i = 0; i < n_bc_nodes; i++)
310 Tout_value[i] = solution[Tout_nodes_ids[i]];
314 auto const server_communication_result =
316 t, dt, Tin_value, Tout_value, flowrate);
320 DBUG(
"Method `serverCommunication' not overridden in Python script.");
323 auto const& [server_communication_Tin_value,
324 server_communication_flowrate] = server_communication_result;
326 std::copy(begin(server_communication_Tin_value),
327 end(server_communication_Tin_value),
329 std::copy(begin(server_communication_flowrate),
330 end(server_communication_flowrate),
335 std::vector<GlobalVector*>
const& x,
336 std::vector<GlobalVector*>
const& ,
const double t,
337 const double dt,
int const process_id)
345 auto& [time, Tin_value, Tout_value, Tout_nodes_ids, flowrate] =
353 auto const& solution = *x[process_id];
356 const std::size_t n_bc_nodes = Tout_nodes_ids.size();
357 for (std::size_t i = 0; i < n_bc_nodes; i++)
360 Tout_value[i] = solution[Tout_nodes_ids[i]];
365 t, dt, Tin_value, Tout_value, flowrate);
369 DBUG(
"Method `serverCommunication' not overridden in Python script.");
374 [[maybe_unused]]
const double t,
double const ,
375 [[maybe_unused]] std::vector<GlobalVector*>
const& x,
376 std::vector<GlobalVector*>
const& ,
int const ,
381 auto M_normal = M.getRawMatrix();
382 auto K_normal = K.getRawMatrix();
383 auto n_original_rows = K_normal.rows();
391 (Eigen::RowVectorXd::Ones(K_normal.rows()) * K_normal.cwiseAbs())
394 M_normal.conservativeResize(
395 M_normal.rows() + n_BHE_bottom_pairs + n_BHE_top_pairs,
397 K_normal.conservativeResize(
398 K_normal.rows() + n_BHE_bottom_pairs + n_BHE_top_pairs,
401 for (std::size_t i = 0; i < n_BHE_bottom_pairs; i++)
403 Eigen::SparseVector<double> M_Plus(M_normal.cols());
405 M_normal.row(n_original_rows + i) = M_Plus;
407 Eigen::SparseVector<double> K_Plus(K_normal.cols());
410 auto const [bhe_idx, first_BHE_bottom_index, second_BHE_bottom_index] =
413 K_Plus.insert(first_BHE_bottom_index) = w_val;
414 K_Plus.insert(second_BHE_bottom_index) = -w_val;
416 K_normal.row(n_original_rows + i) = K_Plus;
419 auto b_normal = b.getRawVector();
420 Eigen::SparseVector<double> b_Plus(b_normal.rows() + n_BHE_bottom_pairs +
425 for (
int i = 0; i < b_normal.innerSize(); ++i)
427 b_Plus.insert(i) = b_normal.coeff(i);
430 for (std::size_t i = 0; i < n_BHE_top_pairs; i++)
432 Eigen::SparseVector<double> M_Plus(M_normal.cols());
434 M_normal.row(n_original_rows + n_BHE_bottom_pairs + i) = M_Plus;
436 Eigen::SparseVector<double> K_Plus(K_normal.cols());
439 auto const [bhe_idx, first_BHE_top_index, second_BHE_top_index] =
442 auto first_BHE_top_index_pair = first_BHE_top_index;
443 auto second_BHE_top_index_pair = second_BHE_top_index;
445 K_Plus.insert(first_BHE_top_index_pair) =
447 K_Plus.insert(second_BHE_top_index_pair) =
450 K_normal.row(n_original_rows + n_BHE_bottom_pairs + i) = K_Plus;
453 double const T_out = (*x[0])[second_BHE_top_index_pair];
455 auto calculate_delta_T = [&](
auto& bhe)
457 auto const T_in = bhe.updateFlowRateAndTemperature(T_out, t);
460 auto delta_T = std::visit(calculate_delta_T,
463 b_Plus.insert(n_original_rows + n_BHE_bottom_pairs + i) =
467 M.getRawMatrix() = M_normal;
468 K.getRawMatrix() = K_normal;
469 b.getRawVector() = b_Plus;
472 "The Algebraic Boundary Condition is not implemented for use with "
473 "PETsc Library! Simulation will be terminated.");
478 std::vector<std::vector<MeshLib::Node*>>
const& all_bhe_nodes)
480 const int process_id = 0;
486 for (std::size_t bhe_i = 0; bhe_i < n_BHEs; bhe_i++)
488 auto const& bhe_nodes = all_bhe_nodes[bhe_i];
492 const int variable_id = bhe_i + 1;
494 std::vector<MeshLib::Node*> bhe_boundary_nodes;
498 for (
auto const& bhe_node : bhe_nodes)
501 auto const& connected_elements =
503 const std::size_t n_line_elements = std::count_if(
504 connected_elements.begin(), connected_elements.end(),
506 { return (elem->getDimension() == 1); });
508 if (n_line_elements == 1)
510 bhe_boundary_nodes.push_back(bhe_node);
514 if (bhe_boundary_nodes.size() != 2)
517 "Error!!! The BHE boundary nodes are not correctly found, "
518 "for every single BHE, there should be 2 boundary nodes.");
533 if ((*bhe_boundary_nodes[0])[2] == (*bhe_boundary_nodes[1])[2])
536 "For 1P-type BHE, the BHE inflow and outflow "
537 "nodes are identified according to their mesh node id in "
545 if ((*bhe_boundary_nodes[0])[2] < (*bhe_boundary_nodes[1])[2])
547 std::swap(bhe_boundary_nodes[0], bhe_boundary_nodes[1]);
551 auto get_global_index =
552 [&](std::size_t
const node_id,
int const component)
556 variable_id, component);
559 auto get_global_bhe_bc_indices =
561 std::pair<std::size_t ,
int >, 2>
562 nodes_and_components)
564 return std::make_pair(
565 get_global_index(nodes_and_components[0].first,
566 nodes_and_components[0].second),
567 get_global_index(nodes_and_components[1].first,
568 nodes_and_components[1].second));
571 auto get_global_bhe_bc_indices_with_bhe_idx =
572 [&](std::size_t bhe_idx,
574 std::pair<std::size_t ,
int >, 2>
575 nodes_and_components)
577 return std::make_tuple(
579 get_global_index(nodes_and_components[0].first,
580 nodes_and_components[0].second),
581 get_global_index(nodes_and_components[1].first,
582 nodes_and_components[1].second));
586 [&, bc_top_node_id = bhe_boundary_nodes[0]->getID(),
587 bc_bottom_node_id = bhe_boundary_nodes[1]->getID()](
auto& bhe)
589 for (
auto const& in_out_component_id :
590 bhe.inflow_outflow_bc_component_ids)
592 if (bhe.use_python_bcs ||
593 this->_process_data._use_server_communication)
600 bcs.addBoundaryCondition(
602 get_global_bhe_bc_indices(
603 bhe.getBHEInflowDirichletBCNodesAndComponents(
604 bc_top_node_id, bc_bottom_node_id,
605 in_out_component_id.first)),
612 "The Python Boundary Condition was switched on, "
613 "but the data object does not exist! ");
625 get_global_bhe_bc_indices_with_bhe_idx(
627 {{{bc_top_node_id, in_out_component_id.first},
629 in_out_component_id.second}}}));
634 bcs.addBoundaryCondition(
636 get_global_bhe_bc_indices(
637 bhe.getBHEInflowDirichletBCNodesAndComponents(
638 bc_top_node_id, bc_bottom_node_id,
639 in_out_component_id.first)),
640 [&bhe](
double const T,
double const t) {
641 return bhe.updateFlowRateAndTemperature(T,
647 auto const bottom_nodes_and_components =
648 bhe.getBHEBottomDirichletBCNodesAndComponents(
650 in_out_component_id.first,
651 in_out_component_id.second);
653 if (bottom_nodes_and_components &&
659 bcs.addBoundaryCondition(
661 get_global_bhe_bc_indices(
662 {{{bc_bottom_node_id,
663 in_out_component_id.first},
665 in_out_component_id.second}}})));
667 else if (bottom_nodes_and_components &&
674 get_global_bhe_bc_indices_with_bhe_idx(
676 {{{bc_bottom_node_id, in_out_component_id.first},
678 in_out_component_id.second}}}));
void INFO(fmt::format_string< Args... > fmt, Args &&... args)
void DBUG(fmt::format_string< Args... > fmt, Args &&... args)
Global vector based on Eigen vector.
bool isAxiallySymmetric() const
std::vector< Node * > const & getNodes() const
Get the nodes-vector for the mesh.
std::vector< Element * > const & getElements() const
Get the element-vector for the mesh.
unsigned getDimension() const
Returns the dimension of the mesh (determined by the maximum dimension over all elements).
std::size_t getID() const
Get id of the mesh.
std::vector< Element const * > const & getElementsConnectedToNode(std::size_t node_id) const
std::size_t getNumberOfElements() const
Get the number of elements.
std::tuple< double, std::vector< double >, std::vector< double >, std::vector< int >, std::vector< double > > dataframe_network
bool isOverriddenTespy() const
virtual std::tuple< bool, bool, std::vector< double >, std::vector< double > > tespySolver(double, std::vector< double > const &, std::vector< double > const &) const
virtual void serverCommunicationPostTimestep(double, double, std::vector< double > const &, std::vector< double > const &, std::vector< double > const &) const
virtual std::tuple< std::vector< double >, std::vector< double > > serverCommunicationPreTimestep(double, double, std::vector< double > const &, std::vector< double > const &, std::vector< double > const &) const
bool isOverriddenServerCommunicationPostTimestep() const
bool isOverriddenServerCommunicationPreTimestep() const
std::unique_ptr< MeshLib::MeshSubset const > _mesh_subset_soil_nodes
const BHEMeshData _bheMeshData
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
std::vector< std::unique_ptr< MeshLib::MeshSubset const > > _mesh_subset_BHE_nodes
std::vector< std::tuple< std::size_t, GlobalIndexType, GlobalIndexType > > _vec_bottom_BHE_node_indices
void computeSecondaryVariableConcrete(double const t, double const dt, std::vector< GlobalVector * > const &x, GlobalVector const &x_prev, int const process_id) override
std::vector< std::unique_ptr< HeatTransportBHELocalAssemblerInterface > > _local_assemblers
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)
HeatTransportBHEProcessData _process_data
NumLib::IterationResult postIterationConcreteProcess(GlobalVector const &x) override
void preTimestepConcreteProcess(std::vector< GlobalVector * > const &x, const double t, const double dt, int const process_id) override
std::vector< std::tuple< std::size_t, GlobalIndexType, GlobalIndexType > > _vec_top_BHE_node_indices
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().
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)
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
void createBHEBoundaryConditionTopBottom(std::vector< std::vector< MeshLib::Node * > > const &all_bhe_nodes)
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::vector< BoundaryConditionCollection > _boundary_conditions
std::unique_ptr< MeshLib::MeshSubset const > _mesh_subset_all_nodes
std::vector< std::size_t > const & getActiveElementIDs() const
VectorMatrixAssembler _global_assembler
std::unique_ptr< NumLib::LocalToGlobalIndexMap > _local_to_global_index_map
Handles configuration of several secondary variables from the project file.
void assemble(std::size_t const mesh_item_id, LocalAssemblerInterface &local_assembler, std::vector< NumLib::LocalToGlobalIndexMap const * > const &dof_tables, 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)
void assembleWithJacobian(std::size_t const mesh_item_id, LocalAssemblerInterface &local_assembler, std::vector< NumLib::LocalToGlobalIndexMap const * > const &dof_tables, 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)
IterationResult
Status flags telling the NonlinearSolver if an iteration succeeded.
PropertyVector< int > const * materialIDs(Mesh const &mesh)
@ BY_COMPONENT
Ordering data by component type.
std::unique_ptr< BHEInflowDirichletBoundaryCondition< BHEUpdateCallback > > createBHEInflowDirichletBoundaryCondition(std::pair< GlobalIndexType, GlobalIndexType > &&in_out_global_indices, BHEUpdateCallback bhe_update_callback)
std::unique_ptr< BHEBottomDirichletBoundaryCondition > createBHEBottomDirichletBoundaryCondition(std::pair< GlobalIndexType, GlobalIndexType > &&in_out_global_indices)
void createLocalAssemblers(std::vector< MeshLib::Element * > const &mesh_elements, NumLib::LocalToGlobalIndexMap const &dof_table, std::vector< std::unique_ptr< LocalAssemblerInterface > > &local_assemblers, NumLib::IntegrationOrder const integration_order, ExtraCtorArgs &&... extra_ctor_args)
std::unique_ptr< BHEInflowPythonBoundaryCondition< BHEType > > createBHEInflowPythonBoundaryCondition(std::pair< GlobalIndexType, GlobalIndexType > &&in_out_global_indices, BHEType &bhe, BHEInflowPythonBoundaryConditionPythonSideInterface &py_bc_object)
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)
const double _weighting_factor
const bool _use_algebraic_bc
std::vector< std::vector< MeshLib::Node * > > BHE_nodes
std::vector< std::vector< MeshLib::Element * > > BHE_elements
std::vector< int > BHE_mat_IDs
std::vector< bool > mass_lumping_soil_elements
MeshLib::PropertyVector< int > const * _mesh_prop_materialIDs
BHEInflowPythonBoundaryConditionPythonSideInterface * py_bc_object
Python object computing BC values.
std::unordered_map< int, int > _map_materialID_to_BHE_ID
std::vector< BHE::BHETypes > _vec_BHE_property
const bool _use_server_communication
AlgebraicBCSetting const _algebraic_BC_Setting