26 typename LowerOrderShapeFunction,
int GlobalDim>
40 bool is_axially_symmetric,
47 GlobalDim>(e, is_axially_symmetric,
54 void assemble(std::size_t
const boundary_element_id,
60 Eigen::MatrixXd
const primary_variables_mat =
ProcessLib::
63 dof_table_boundary, x);
66 auto const& indices_this_component =
67 dof_table_boundary(boundary_element_id,
70 std::vector<GlobalIndexType> indices_all_components_for_Jac;
72 auto const num_dof_this_component = indices_this_component.
size();
74 Eigen::VectorXd local_rhs =
75 Eigen::VectorXd::Zero(num_dof_this_component);
76 Eigen::MatrixXd local_Jac;
80 indices_all_components_for_Jac =
83 auto const num_dof_all_components =
84 indices_all_components_for_Jac.size();
86 local_Jac = Eigen::MatrixXd::Zero(num_dof_this_component,
87 num_dof_all_components);
91 auto const num_comp_total =
93 std::vector<double> prim_vars_data(num_comp_total);
97 unsigned const num_integration_points =
102 for (
unsigned ip = 0; ip < num_integration_points; ip++)
108 primary_variables_mat,
112 auto const [flag, flux, dFlux] =
113 bc_or_st_data.getFlagAndFluxAndDFlux(t, coords, prim_vars_data);
124 if (
static_cast<int>(dFlux.size()) != num_comp_total)
130 "The Python BC or ST must return the derivative of the "
131 "flux w.r.t. each component of each primary variable. "
132 "{:d} components expected. {:d} components returned from "
134 "The expected number of components depends on multiple "
135 "factors. In the case of vectorial primary variables (such "
136 "as displacement), it will depend on the space dimension. "
137 "In the case of staggered coupling, the number of "
138 "components can be different for each staggered process "
139 "and different from monolithic coupling.",
140 num_comp_total, dFlux.size());
149 b.
add(indices_this_component, local_rhs);
154 indices_this_component, indices_all_components_for_Jac};
155 Jac->
add(rci, local_Jac);
178 Eigen::VectorXd& local_rhs)
const
180 auto const w = ns_and_weight.
weight();
181 auto const N = ns_and_weight.
N(
bc_or_st_data.shape_function_order);
183 local_rhs.noalias() += N.transpose() * (flux * w);
199 std::vector<double>
const& dFlux,
201 Eigen::MatrixXd& local_Jac)
const
203 auto const& pv_refs =
205 auto const weight = ns_and_weight.
weight();
207 auto const this_shp_fct_order =
bc_or_st_data.shape_function_order;
208 auto const N_this = ns_and_weight.
N(this_shp_fct_order);
210 Eigen::Index left = 0;
212 for (
auto pv_ref : pv_refs)
214 auto const& pv = pv_ref.get();
215 auto const other_num_comp = pv.getNumberOfGlobalComponents();
216 auto const other_shp_fct_order = pv.getShapeFunctionOrder();
217 auto const N_other = ns_and_weight.
N(other_shp_fct_order);
218 auto const width = N_other.size();
220 for (
decltype(+other_num_comp) other_comp = 0;
221 other_comp < other_num_comp;
226 local_Jac.middleCols(left, width).noalias() -=
227 N_this.transpose() * (dFlux[other_comp] * weight) * N_other;
233 assert(left == local_Jac.cols());
MathLib::EigenMatrix GlobalMatrix
MathLib::EigenVector GlobalVector
int add(IndexType row, IndexType col, double val)
void add(IndexType rowId, double v)
add entry
int getNumberOfGlobalComponents() const
Template class for isoparametric elements.
std::array< double, 3 > interpolateCoordinates(typename ShapeMatrices::ShapeType const &N) const
Interpolates the coordinates of the element with the given shape matrix.
Eigen::Map< const Vector > toVector(std::vector< double > const &data, Eigen::VectorXd::Index size)
Creates an Eigen mapped vector from the given data vector.
std::vector< GlobalIndexType > getIndices(std::size_t const mesh_item_id, NumLib::LocalToGlobalIndexMap const &dof_table)
NumLib::TemplateIsoparametric< ShapeFunction, ShapeMatricesType > createIsoparametricFiniteElement(MeshLib::Element const &e)
auto computeNsAndWeights(MeshLib::Element const &element, bool const is_axially_symmetric, IntegrationMethod const &integration_method)
Eigen::MatrixXd collectDofsToMatrix(MeshLib::Element const &element, std::size_t const mesh_id, NumLib::LocalToGlobalIndexMap const &dof_table, GlobalVector const &x)
void interpolate(Eigen::MatrixXd const &primary_variables_mat, std::vector< std::reference_wrapper< ProcessVariable > > const &pv_refs, NsAndWeight const &ns_and_weight, Eigen::Ref< Eigen::VectorXd > interpolated_primary_variables)
void assembleLocalRhs(double const flux, typename Traits::NsAndWeight const &ns_and_weight, Eigen::VectorXd &local_rhs) const
void assemble(std::size_t const boundary_element_id, NumLib::LocalToGlobalIndexMap const &dof_table_boundary, double const t, GlobalVector const &x, GlobalVector &b, GlobalMatrix *const Jac) const
BcAndStLocalAssemblerImpl(MeshLib::Element const &e, NumLib::GenericIntegrationMethod const &integration_method_, bool is_axially_symmetric, BcOrStData const &data)
std::array< double, 3 > interpolateCoords(typename Traits::NsAndWeight const &ns_and_weight, NumLib::TemplateIsoparametric< ShapeFunction, ShapeMatrixPolicy > const &fe) const
void assembleLocalJacobian(std::vector< double > const &dFlux, typename Traits::NsAndWeight const &ns_and_weight, Eigen::MatrixXd &local_Jac) const
typename Traits::ShapeMatrixPolicy ShapeMatrixPolicy
MeshLib::Element const & element
NsAndWeightsTraits< ShapeFunction, LowerOrderShapeFunction, GlobalDim > Traits
BcOrStData const & bc_or_st_data
NumLib::GenericIntegrationMethod const & integration_method
std::vector< typename Traits::NsAndWeight > const nss_and_weights
ShapeMatrix const & NHigherOrder() const
Eigen::Ref< const Eigen::RowVectorXd > N(unsigned order) const
Collects common type aliases needed when working with NsAndWeight.
ProcessLib::BoundaryConditionAndSourceTerm::Python::NsAndWeight< ShapeFunction, LowerOrderShapeFunction, ShapeMatrix, LowerOrderShapeMatrix > NsAndWeight
ShapeMatrixPolicyType< ShapeFunction, GlobalDim > ShapeMatrixPolicy