44 ShapeFunctionPressure, GlobalDim>::
45 HydroMechanicsLocalAssemblerFracture(
48 std::vector<unsigned>
const& dofIndex_to_localIndex,
50 bool const is_axially_symmetric,
53 e, is_axially_symmetric, integration_method,
54 ShapeFunctionDisplacement::NPOINTS * GlobalDim +
55 ShapeFunctionPressure::NPOINTS,
56 dofIndex_to_localIndex),
57 _process_data(process_data)
61 unsigned const n_integration_points =
64 _ip_data.reserve(n_integration_points);
67 auto const shape_matrices_u =
70 e, is_axially_symmetric, integration_method);
72 auto const shape_matrices_p =
75 e, is_axially_symmetric, integration_method);
82 aperture0_node_values = frac_prop.aperture0.getNodalValuesOnElement(
85 for (
unsigned ip = 0; ip < n_integration_points; ip++)
88 auto const& sm_u = shape_matrices_u[ip];
89 auto const& sm_p = shape_matrices_p[ip];
98 ip_data.integration_weight =
99 sm_u.detJ * sm_u.integralMeasure *
102 ip_data.H_u.setZero(GlobalDim,
103 ShapeFunctionDisplacement::NPOINTS * GlobalDim);
105 GlobalDim, ShapeFunctionDisplacement::NPOINTS,
108 ip_data.N_p = sm_p.N;
109 ip_data.dNdx_p = sm_p.dNdx;
114 ip_data.w.setZero(GlobalDim);
115 ip_data.sigma_eff.setZero(GlobalDim);
118 ip_data.w_prev.resize(GlobalDim);
119 ip_data.sigma_eff_prev.resize(GlobalDim);
121 ip_data.C.resize(GlobalDim, GlobalDim);
123 ip_data.aperture0 = aperture0_node_values.dot(sm_u.N);
124 ip_data.aperture = ip_data.aperture0;
126 auto const initial_effective_stress =
127 _process_data.initial_fracture_effective_stress(0, x_position);
128 for (
int i = 0; i < GlobalDim; i++)
130 ip_data.sigma_eff[i] = initial_effective_stress[i];
131 ip_data.sigma_eff_prev[i] = initial_effective_stress[i];
139 ShapeFunctionPressure, GlobalDim>::
140 assembleWithJacobianConcrete(
double const t,
double const dt,
141 Eigen::VectorXd
const& local_x,
142 Eigen::VectorXd
const& local_x_prev,
143 Eigen::VectorXd& local_b,
144 Eigen::MatrixXd& local_J)
146 auto const p = local_x.segment(pressure_index, pressure_size);
147 auto const p_prev = local_x_prev.segment(pressure_index, pressure_size);
148 auto const g = local_x.segment(displacement_index, displacement_size);
150 local_x_prev.segment(displacement_index, displacement_size);
152 auto rhs_p = local_b.segment(pressure_index, pressure_size);
153 auto rhs_g = local_b.segment(displacement_index, displacement_size);
154 auto J_pp = local_J.block(pressure_index, pressure_index, pressure_size,
156 auto J_pg = local_J.block(pressure_index, displacement_index, pressure_size,
158 auto J_gp = local_J.block(displacement_index, pressure_index,
159 displacement_size, pressure_size);
160 auto J_gg = local_J.block(displacement_index, displacement_index,
161 displacement_size, displacement_size);
163 assembleBlockMatricesWithJacobian(t, dt, p, p_prev, g, g_prev, rhs_p, rhs_g,
164 J_pp, J_pg, J_gg, J_gp);
170 ShapeFunctionPressure, GlobalDim>::
171 assembleBlockMatricesWithJacobian(
172 double const t,
double const dt,
173 Eigen::Ref<const Eigen::VectorXd>
const& p,
174 Eigen::Ref<const Eigen::VectorXd>
const& p_prev,
175 Eigen::Ref<const Eigen::VectorXd>
const& g,
176 Eigen::Ref<const Eigen::VectorXd>
const& g_prev,
177 Eigen::Ref<Eigen::VectorXd> rhs_p, Eigen::Ref<Eigen::VectorXd> rhs_g,
178 Eigen::Ref<Eigen::MatrixXd> J_pp, Eigen::Ref<Eigen::MatrixXd> J_pg,
179 Eigen::Ref<Eigen::MatrixXd> J_gg, Eigen::Ref<Eigen::MatrixXd> J_gp)
181 auto const& frac_prop = *_process_data.fracture_property;
182 auto const& R = frac_prop.R;
186 auto constexpr index_normal = GlobalDim - 1;
189 ShapeMatricesTypePressure::NodalMatrixType::Zero(pressure_size,
193 ShapeMatricesTypePressure::NodalMatrixType::Zero(pressure_size,
196 typename ShapeMatricesTypeDisplacement::template MatrixType<
197 displacement_size, pressure_size>
198 Kgp = ShapeMatricesTypeDisplacement::template MatrixType<
199 displacement_size, pressure_size>::Zero(displacement_size,
203 Eigen::MatrixXd
const global2local_rotation =
204 R.template topLeftCorner<ShapeFunctionPressure::DIM, GlobalDim>();
207 global2local_rotation *
208 _process_data.specific_body_force;
214 auto const& medium = _process_data.media_map.getMedium(_element.getID());
215 auto const& liquid_phase = medium->phase(
"AqueousLiquid");
217 medium->property(MPL::PropertyType::reference_temperature)
218 .template value<double>(variables, x_position, t, dt);
221 unsigned const n_integration_points = _ip_data.size();
222 for (
unsigned ip = 0; ip < n_integration_points; ip++)
224 auto& ip_data = _ip_data[ip];
225 auto const& ip_w = ip_data.integration_weight;
226 auto const& N_p = ip_data.N_p;
227 auto const& dNdx_p = ip_data.dNdx_p;
228 auto const& H_g = ip_data.H_u;
229 auto const& identity2 =
233 std::nullopt, _element.getID(),
239 auto& mat = ip_data.fracture_material;
240 auto& effective_stress = ip_data.sigma_eff;
241 auto const& effective_stress_prev = ip_data.sigma_eff_prev;
243 auto const& w_prev = ip_data.w_prev;
245 auto& state = *ip_data.material_state_variables;
246 auto& b_m = ip_data.aperture;
249 liquid_phase.property(MPL::PropertyType::density)
250 .template value<double>(variables, x_position, t, dt);
254 medium->property(MPL::PropertyType::biot_coefficient)
255 .template value<double>(variables, x_position, t, dt);
258 medium->property(MPL::PropertyType::storage)
259 .template value<double>(variables, x_position, t, dt);
262 liquid_phase.property(MPL::PropertyType::viscosity)
263 .template value<double>(variables, x_position, t, dt);
266 w.noalias() = R * H_g * g;
269 b_m = ip_data.aperture0 + w[index_normal];
273 "Element {:d}, gp {:d}: Fracture aperture is {:g}, but it must "
275 "non-negative. Setting it to zero.",
276 _element.getID(), ip, b_m);
280 auto const initial_effective_stress =
281 _process_data.initial_fracture_effective_stress(0, x_position);
283 Eigen::Map<typename HMatricesType::ForceVectorType const>
const stress0(
284 initial_effective_stress.data(), initial_effective_stress.size());
287 mat.computeConstitutiveRelation(
288 t, x_position, ip_data.aperture0, stress0, w_prev, w,
289 effective_stress_prev, effective_stress, C, state);
295 H_g.transpose() * R.transpose() * effective_stress * ip_w;
296 J_gg.noalias() += H_g.transpose() * R.transpose() * C * R * H_g * ip_w;
302 H_g.transpose() * R.transpose() * alpha * identity2 * N_p * ip_w;
310 auto const permeability =
311 medium->property(MPL::PropertyType::permeability)
312 .value(variables, x_position, t, dt);
314 auto& k = ip_data.permeability;
315 k = std::get<double>(permeability);
316 double const k_over_mu = k / mu;
317 storage_p.noalias() += N_p.transpose() * b_m * S * N_p * ip_w;
318 laplace_p.noalias() +=
319 dNdx_p.transpose() * b_m * k_over_mu * dNdx_p * ip_w;
321 dNdx_p.transpose() * b_m * k_over_mu * rho_fr * gravity_vec * ip_w;
327 Eigen::Matrix<double, 1, displacement_size>
const mT_R_Hg =
328 identity2.transpose() * R * H_g;
330 ip_data.darcy_velocity = -k_over_mu * grad_head;
332 N_p.transpose() * S * N_p * (p - p_prev) / dt * mT_R_Hg * ip_w;
335 double const dk_db_over_mu =
336 medium->property(MPL::PropertyType::permeability)
337 .template dValue<double>(variables,
338 MPL::Variable::fracture_aperture,
342 dNdx_p.transpose() * k_over_mu * grad_head * mT_R_Hg * ip_w;
343 J_pg.noalias() += dNdx_p.transpose() * b_m * dk_db_over_mu * grad_head *
348 J_gp.noalias() -= Kgp;
351 J_pp.noalias() += laplace_p + storage_p / dt;
354 J_pg.noalias() += Kgp.transpose() / dt;
357 rhs_p.noalias() -= laplace_p * p + storage_p * (p - p_prev) / dt +
358 Kgp.transpose() * (g - g_prev) / dt;
361 rhs_g.noalias() -= -Kgp * p;
368 GlobalDim>::postTimestepConcreteWithVector(
const double t,
370 Eigen::VectorXd
const& local_x)
372 auto const nodal_g = local_x.segment(displacement_index, displacement_size);
374 auto const& frac_prop = *_process_data.fracture_property;
375 auto const& R = frac_prop.R;
378 auto constexpr index_normal = GlobalDim - 1;
381 auto const e_id = _element.getID();
384 unsigned const n_integration_points = _ip_data.size();
385 for (
unsigned ip = 0; ip < n_integration_points; ip++)
387 auto& ip_data = _ip_data[ip];
388 auto const& H_g = ip_data.H_u;
389 auto& mat = ip_data.fracture_material;
390 auto& effective_stress = ip_data.sigma_eff;
391 auto const& effective_stress_prev = ip_data.sigma_eff_prev;
393 auto const& w_prev = ip_data.w_prev;
395 auto& state = *ip_data.material_state_variables;
396 auto& b_m = ip_data.aperture;
403 _element, ip_data.N_p))};
406 w.noalias() = R * H_g * nodal_g;
409 b_m = ip_data.aperture0 + w[index_normal];
413 "Element {:d}, gp {:d}: Fracture aperture is {:g}, but it is "
414 "expected to be non-negative. Setting it to zero now.",
415 _element.getID(), ip, b_m);
419 auto const initial_effective_stress =
420 _process_data.initial_fracture_effective_stress(0, x_position);
422 Eigen::Map<typename HMatricesType::ForceVectorType const>
const stress0(
423 initial_effective_stress.data(), initial_effective_stress.size());
426 mat.computeConstitutiveRelation(
427 t, x_position, ip_data.aperture0, stress0, w_prev, w,
428 effective_stress_prev, effective_stress, C, state);
434 HMatricesType::ForceVectorType::Zero(GlobalDim);
436 HMatricesType::ForceVectorType::Zero(GlobalDim);
439 double ele_Fs = -std::numeric_limits<double>::max();
440 for (
auto const& ip : _ip_data)
442 ele_b += ip.aperture;
443 ele_k += ip.permeability;
445 ele_sigma_eff += ip.sigma_eff;
446 ele_velocity += ip.darcy_velocity;
448 ele_Fs, ip.material_state_variables->getShearYieldFunctionValue());
450 ele_b /=
static_cast<double>(n_integration_points);
451 ele_k /=
static_cast<double>(n_integration_points);
452 ele_w /=
static_cast<double>(n_integration_points);
453 ele_sigma_eff /=
static_cast<double>(n_integration_points);
454 ele_velocity /=
static_cast<double>(n_integration_points);
455 auto const element_id = _element.getID();
456 (*_process_data.mesh_prop_b)[element_id] = ele_b;
457 (*_process_data.mesh_prop_k_f)[element_id] = ele_k;
459 Eigen::Map<GlobalDimVectorType>(
460 &(*_process_data.element_fracture_stresses)[e_id * GlobalDim]) =
463 Eigen::Map<GlobalDimVectorType>(
464 &(*_process_data.element_fracture_velocities)[e_id * GlobalDim]) =
467 Eigen::Map<GlobalDimVectorType>(
468 &(*_process_data.element_local_jumps)[e_id * GlobalDim]) = ele_w;
470 (*_process_data.mesh_prop_fracture_shear_failure)[element_id] = ele_Fs;