37template <
typename NodalRowVectorType,
typename GlobalDimNodalMatrixType,
38 typename NodalMatrixType>
42 GlobalDimNodalMatrixType
const& dNdx_,
43 double const& integration_weight_,
44 NodalMatrixType
const mass_operator_)
52 NodalRowVectorType
const N;
53 GlobalDimNodalMatrixType
const dNdx;
68 std::vector<GlobalVector*>
const& x,
69 std::vector<NumLib::LocalToGlobalIndexMap const*>
const& dof_table,
70 std::vector<double>& cache)
const = 0;
74 std::vector<GlobalVector*>
const& x,
75 std::vector<NumLib::LocalToGlobalIndexMap const*>
const& dof_table,
76 std::vector<double>& cache)
const = 0;
79template <
typename ShapeFunction,
int GlobalDim>
99 std::size_t
const local_matrix_size,
101 bool is_axially_symmetric,
111 assert(local_matrix_size == ShapeFunction::NPOINTS *
NUM_NODAL_DOF);
112 (void)local_matrix_size;
114 unsigned const n_integration_points =
116 _ip_data.reserve(n_integration_points);
118 auto const shape_matrices =
120 GlobalDim>(element, is_axially_symmetric,
123 for (
unsigned ip = 0; ip < n_integration_points; ip++)
125 auto const& sm = shape_matrices[ip];
126 const double integration_factor = sm.integralMeasure * sm.detJ;
131 sm.N.transpose() * sm.N * integration_factor *
137 std::vector<double>
const& local_x,
138 std::vector<double>
const& ,
139 std::vector<double>& local_M_data,
140 std::vector<double>& local_K_data,
141 std::vector<double>& local_b_data)
override
143 auto const local_matrix_size = local_x.size();
146 assert(local_matrix_size == ShapeFunction::NPOINTS *
NUM_NODAL_DOF);
149 local_M_data, local_matrix_size, local_matrix_size);
151 local_K_data, local_matrix_size, local_matrix_size);
153 local_b_data, local_matrix_size);
155 unsigned const n_integration_points =
162 auto const& liquid_phase = medium.
phase(
"AqueousLiquid");
168 .template value<double>(vars, pos, t, dt);
170 for (
unsigned ip = 0; ip < n_integration_points; ip++)
173 double p_int_pt = 0.0;
182 auto const permeability =
185 .value(vars, pos, t, dt));
187 auto const porosity =
189 .template value<double>(vars, pos, t, dt);
193 .template value<double>(vars, pos, t, dt);
197 double const dSw_dpc =
199 .template dValue<double>(
203 auto const drhow_dp =
206 .template dValue<double>(
212 .template value<double>(vars, pos, t, dt);
213 double const mass_mat_coeff =
214 storage * Sw + porosity * Sw * drhow_dp - porosity * dSw_dpc;
216 local_M.noalias() += mass_mat_coeff *
_ip_data[ip].mass_operator;
221 relative_permeability)
222 .template value<double>(vars, pos, t, dt);
226 .template value<double>(vars, pos, t, dt);
227 local_K.noalias() +=
_ip_data[ip].dNdx.transpose() * permeability *
229 _ip_data[ip].integration_weight * (k_rel / mu);
236 .template value<double>(vars, pos, t, dt);
238 assert(body_force.size() == GlobalDim);
240 _ip_data[ip].dNdx.transpose() * permeability * body_force *
242 local_b.noalias() += (k_rel / mu) * rho_w * gravity_operator;
247 for (
int idx_ml = 0; idx_ml < local_M.cols(); idx_ml++)
249 double const mass_lump_val = local_M.col(idx_ml).sum();
250 local_M.col(idx_ml).setZero();
251 local_M(idx_ml, idx_ml) = mass_lump_val;
257 const unsigned integration_point)
const override
259 auto const& N =
_ip_data[integration_point].N;
262 return Eigen::Map<const Eigen::RowVectorXd>(N.data(), N.size());
267 std::vector<GlobalVector*>
const& ,
268 std::vector<NumLib::LocalToGlobalIndexMap const*>
const& ,
269 std::vector<double>& )
const override
277 std::vector<GlobalVector*>
const& x,
278 std::vector<NumLib::LocalToGlobalIndexMap const*>
const& dof_table,
279 std::vector<double>& cache)
const override
283 double const dt = std::numeric_limits<double>::quiet_NaN();
285 constexpr int process_id = 0;
288 assert(!indices.empty());
289 auto const local_x = x[process_id]->get(indices);
296 auto const& liquid_phase = medium.
phase(
"AqueousLiquid");
303 .template value<double>(vars, pos, t, dt);
305 auto const p_nodal_values = Eigen::Map<const NodalVectorType>(
306 &local_x[0], ShapeFunction::NPOINTS);
308 unsigned const n_integration_points =
313 Eigen::Matrix<double, GlobalDim, Eigen::Dynamic, Eigen::RowMajor>>(
314 cache, GlobalDim, n_integration_points);
316 for (
unsigned ip = 0; ip < n_integration_points; ++ip)
318 double p_int_pt = 0.0;
328 .template value<double>(vars, pos, t, dt);
331 auto const permeability =
334 .value(vars, pos, t, dt));
339 relative_permeability)
340 .template value<double>(vars, pos, t, dt);
343 .template value<double>(vars, pos, t, dt);
344 auto const K_mat_coeff = permeability * (k_rel / mu);
345 cache_vec.col(ip).noalias() =
346 -K_mat_coeff *
_ip_data[ip].dNdx * p_nodal_values;
352 .template value<double>(vars, pos, t, dt);
354 assert(body_force.size() == GlobalDim);
357 cache_vec.col(ip).noalias() += K_mat_coeff * rho_w * body_force;
Definition of the PiecewiseLinearInterpolation class.
Medium * getMedium(std::size_t element_id)
Phase const & phase(std::size_t index) const
double gas_phase_pressure
double capillary_pressure
double liquid_phase_pressure
std::size_t getID() const
Returns the ID of the element.
MathLib::WeightedPoint const & getWeightedPoint(unsigned const igp) const
unsigned getNumberOfPoints() const
void setElementID(std::size_t element_id)
void setIntegrationPoint(unsigned integration_point)
Eigen::Map< const Eigen::RowVectorXd > getShapeMatrix(const unsigned integration_point) const override
Provides the shape matrix at the given integration point.
NumLib::GenericIntegrationMethod const & _integration_method
std::vector< IntegrationPointData< NodalRowVectorType, GlobalDimNodalMatrixType, NodalMatrixType >, Eigen::aligned_allocator< IntegrationPointData< NodalRowVectorType, GlobalDimNodalMatrixType, NodalMatrixType > > > _ip_data
ShapeMatrixPolicyType< ShapeFunction, GlobalDim > ShapeMatricesType
std::vector< double > _saturation
std::vector< double > const & getIntPtDarcyVelocity(const double t, std::vector< GlobalVector * > const &x, std::vector< NumLib::LocalToGlobalIndexMap const * > const &dof_table, std::vector< double > &cache) const override
std::vector< double > const & getIntPtSaturation(const double, std::vector< GlobalVector * > const &, std::vector< NumLib::LocalToGlobalIndexMap const * > const &, std::vector< double > &) const override
typename ShapeMatricesType::ShapeMatrices ShapeMatrices
typename ShapeMatricesType::GlobalDimNodalMatrixType GlobalDimNodalMatrixType
RichardsFlowProcessData const & _process_data
LocalAssemblerData(MeshLib::Element const &element, std::size_t const local_matrix_size, NumLib::GenericIntegrationMethod const &integration_method, bool is_axially_symmetric, RichardsFlowProcessData const &process_data)
typename ShapeMatricesType::NodalRowVectorType NodalRowVectorType
typename ShapeMatricesType::GlobalDimMatrixType GlobalDimMatrixType
void assemble(double const t, double const dt, std::vector< double > const &local_x, std::vector< double > const &, std::vector< double > &local_M_data, std::vector< double > &local_K_data, std::vector< double > &local_b_data) override
typename ShapeMatricesType::NodalMatrixType NodalMatrixType
MeshLib::Element const & _element
typename ShapeMatricesType::GlobalDimVectorType GlobalDimVectorType
typename ShapeMatricesType::NodalVectorType NodalVectorType
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
virtual std::vector< double > const & getIntPtDarcyVelocity(const double t, std::vector< GlobalVector * > const &x, std::vector< NumLib::LocalToGlobalIndexMap const * > const &dof_table, std::vector< double > &cache) const =0
Eigen::Matrix< double, GlobalDim, GlobalDim > formEigenTensor(MaterialPropertyLib::PropertyDataType const &values)
Eigen::Map< Vector > createZeroedVector(std::vector< double > &data, Eigen::VectorXd::Index size)
Eigen::Map< Matrix > createZeroedMatrix(std::vector< double > &data, Eigen::MatrixXd::Index rows, Eigen::MatrixXd::Index cols)
void shapeFunctionInterpolate(const NodalValues &, const ShapeMatrix &)
std::vector< GlobalIndexType > getIndices(std::size_t const mesh_item_id, NumLib::LocalToGlobalIndexMap const &dof_table)
std::vector< typename ShapeMatricesType::ShapeMatrices, Eigen::aligned_allocator< typename ShapeMatricesType::ShapeMatrices > > initShapeMatrices(MeshLib::Element const &e, bool const is_axially_symmetric, IntegrationMethod const &integration_method)
const unsigned NUM_NODAL_DOF
NumLib::ShapeMatrices< NodalRowVectorType, DimNodalMatrixType, DimMatrixType, GlobalDimNodalMatrixType > ShapeMatrices
MatrixType< ShapeFunction::NPOINTS, ShapeFunction::NPOINTS > NodalMatrixType
MatrixType< GlobalDim, ShapeFunction::NPOINTS > GlobalDimNodalMatrixType
MatrixType< GlobalDim, GlobalDim > GlobalDimMatrixType
VectorType< GlobalDim > GlobalDimVectorType
VectorType< ShapeFunction::NPOINTS > NodalVectorType
RowVectorType< ShapeFunction::NPOINTS > NodalRowVectorType
EIGEN_MAKE_ALIGNED_OPERATOR_NEW
GlobalDimNodalMatrixType const dNdx
double const integration_weight
NodalRowVectorType const N
IntegrationPointData(NodalRowVectorType const &N_, GlobalDimNodalMatrixType const &dNdx_, double const &integration_weight_, NodalMatrixType const mass_operator_)
NodalMatrixType const mass_operator
MaterialPropertyLib::MaterialSpatialDistributionMap media_map
bool const has_mass_lumping
Eigen::VectorXd const specific_body_force