version 0.4.1
nonlinearelastic.hh
Go to the documentation of this file.
1// SPDX-FileCopyrightText: 2021-2025 The Ikarus Developers mueller@ibb.uni-stuttgart.de
2// SPDX-License-Identifier: LGPL-3.0-or-later
3
10#pragma once
11
12#if HAVE_DUNE_LOCALFEFUNCTIONS
13 #include <dune/fufem/boundarypatch.hh>
14 #include <dune/geometry/quadraturerules.hh>
15 #include <dune/geometry/type.hh>
16 #include <dune/localfefunctions/cachedlocalBasis/cachedlocalBasis.hh>
17 #include <dune/localfefunctions/expressions/greenLagrangeStrains.hh>
18 #include <dune/localfefunctions/impl/standardLocalFunction.hh>
19 #include <dune/localfefunctions/manifolds/realTuple.hh>
20
31
32namespace Ikarus {
33
34template <typename PreFE, typename FE, typename PRE>
35class NonLinearElastic;
36
41template <typename MAT>
43{
44 using Material = MAT;
46
47 template <typename PreFE, typename FE>
49};
50
60template <typename PreFE, typename FE, typename PRE>
61class NonLinearElastic : public ResultTypeBase<ResultTypes::PK2Stress, ResultTypes::PK2StressFull>
62{
63public:
65 using Basis = typename Traits::Basis;
66 using FlatBasis = typename Traits::FlatBasis;
68 using LocalView = typename Traits::LocalView;
69 using Geometry = typename Traits::Geometry;
70 using GridView = typename Traits::GridView;
71 using Element = typename Traits::Element;
72 using Material = PRE::Material;
73 using Pre = PRE;
74
75 using LocalBasisType = decltype(std::declval<LocalView>().tree().child(0).finiteElement().localBasis());
76
77 template <typename ST>
78 using VectorXOptRef = std::optional<std::reference_wrapper<const Eigen::VectorX<ST>>>;
79
80 static constexpr int myDim = Traits::mydim;
81 static constexpr int strainDim = myDim * (myDim + 1) / 2;
82 static constexpr auto strainType = StrainTags::greenLagrangian;
83 static constexpr auto stressType = StressTags::PK2;
84 static constexpr bool hasEAS = FE::template hasEAS<EAS::GreenLagrangeStrain> or
85 FE::template hasEAS<EAS::DisplacementGradient> or
86 FE::template hasEAS<EAS::DisplacementGradientTransposed>;
87
88 template <template <typename, int, int> class RT>
90
91 template <typename ST>
92 using StrainType = Eigen::Vector<ST, strainDim>;
93
94 template <typename ST>
95 using BopType = Eigen::Matrix<ST, strainDim, myDim>;
96
97 template <typename ST>
98 using KgType = Eigen::Matrix<ST, myDim, myDim>;
99
104 explicit NonLinearElastic(const Pre& pre)
105 : mat_{pre.material} {}
106
107protected:
111 void bindImpl() {
112 const auto& localView = underlying().localView();
113 const auto& element = localView.element();
114 auto& firstChild = localView.tree().child(0);
115 const auto& fe = firstChild.finiteElement();
116 geo_ = std::make_shared<const Geometry>(element.geometry());
117 numberOfNodes_ = fe.size();
118 order_ = 2 * (fe.localBasis().order());
119 localBasis_ = Dune::CachedLocalBasis(fe.localBasis());
120 if constexpr (requires { element.impl().getQuadratureRule(order_); })
121 if (element.impl().isTrimmed())
122 localBasis_.bind(element.impl().getQuadratureRule(order_), Dune::bindDerivatives(0, 1));
123 else
124 localBasis_.bind(Dune::QuadratureRules<double, myDim>::rule(element.type(), order_),
125 Dune::bindDerivatives(0, 1));
126 else
127 localBasis_.bind(Dune::QuadratureRules<double, myDim>::rule(element.type(), order_), Dune::bindDerivatives(0, 1));
128 }
129
130public:
139 template <typename ScalarType = double>
140 auto displacementFunction(const Requirement& par, const VectorXOptRef<ScalarType>& dx = std::nullopt) const {
141 const auto& d = par.globalSolution();
142 auto disp = Ikarus::FEHelper::localSolutionBlockVector<Traits>(d, underlying().localView(), dx);
143 Dune::StandardLocalFunction uFunction(localBasis_, disp, geo_);
144 return uFunction;
145 }
146
155 template <typename ScalarType = double>
156 inline auto strainFunction(const Requirement& par, const VectorXOptRef<ScalarType>& dx = std::nullopt) const {
157 return Dune::greenLagrangeStrains(displacementFunction(par, dx));
158 }
159
168 template <typename ScalarType, int strainDim>
169 auto internalEnergy(const Eigen::Vector<ScalarType, strainDim>& strain) const {
170 return material<ScalarType>().template storedEnergy<strainType>(strain);
171 }
172
182 template <typename ScalarType, int strainDim, bool voigt = true>
183 auto stress(const Eigen::Vector<ScalarType, strainDim>& strain) const {
184 return material<ScalarType>().template stresses<strainType, voigt>(strain);
185 }
186
196 template <typename ScalarType, int strainDim, bool voigt = true>
197 auto materialTangent(const Eigen::Vector<ScalarType, strainDim>& strain) const {
198 return material<ScalarType>().template tangentModuli<strainType, voigt>(strain);
199 }
200
201 const Geometry& geometry() const { return *geo_; }
202 [[nodiscard]] size_t numberOfNodes() const { return numberOfNodes_; }
203 [[nodiscard]] int order() const { return order_; }
204 const Dune::CachedLocalBasis<std::remove_cvref_t<LocalBasisType>>& localBasis() const { return localBasis_; }
205
206 template <typename ScalarType = double>
207 decltype(auto) material() const {
209 return mat_.template rebind<ScalarType>();
210 else
211 return mat_;
212 }
213
214public:
220 template <template <typename, int, int> class RT>
221 requires(supportsResultType<RT>())
222 auto resultFunction() const {
223 return [&](const Eigen::Vector<double, strainDim>& strainInVoigt) {
224 if constexpr (isSameResultType<RT, ResultTypes::PK2Stress> or isSameResultType<RT, ResultTypes::PK2StressFull>) {
225 decltype(auto) mat = [&]() {
226 if constexpr (isSameResultType<RT, ResultTypes::PK2StressFull> and requires { mat_.underlying(); })
227 return mat_.underlying();
228 else
229 return mat_;
230 }();
231 return RTWrapperType<RT>{mat.template stresses<strainType>(enlargeIfReduced<Material>(strainInVoigt))};
232 }
233 };
234 }
235
245 template <template <typename, int, int> class RT>
246 requires(supportsResultType<RT>())
248 Dune::PriorityTag<1>) const {
249 using namespace Dune::DerivativeDirections;
250
251 if constexpr (hasEAS)
252 return RTWrapperType<RT>{};
253 if constexpr (isSameResultType<RT, ResultTypes::PK2Stress> or isSameResultType<RT, ResultTypes::PK2StressFull>) {
254 const auto uFunction = displacementFunction(req);
255 const auto rFunction = resultFunction<RT>();
256 const auto H = uFunction.evaluateDerivative(local, Dune::wrt(spatialAll), Dune::on(gridElement));
257 const auto E = (0.5 * (H.transpose() + H + H.transpose() * H)).eval();
258
259 return rFunction(toVoigt(E));
260 }
261 }
262
263private:
264 //> CRTP
265 const auto& underlying() const { return static_cast<const FE&>(*this); }
266 auto& underlying() { return static_cast<FE&>(*this); }
267 std::shared_ptr<const Geometry> geo_;
268 Dune::CachedLocalBasis<std::remove_cvref_t<LocalBasisType>> localBasis_;
269 Material mat_;
270 size_t numberOfNodes_{0};
271 int order_{};
272
273public:
284 template <typename ST>
285 auto stiffnessMatrixFunction(const Requirement& par, typename Traits::template MatrixType<ST>& K,
286 const VectorXOptRef<ST>& dx = std::nullopt) const {
287 return [&](const StrainType<ST>& strain, const BopType<ST>& bopI, const BopType<ST>& bopJ, const KgType<ST>& kgIJ,
288 const int I, const int J, const auto& gp) {
289 const auto C = materialTangent(strain);
290 const double intElement = geo_->integrationElement(gp.position()) * gp.weight();
291 K.template block<myDim, myDim>(I * myDim, J * myDim) += (bopI.transpose() * C * bopJ + kgIJ) * intElement;
292 };
293 }
294
306 template <typename ST>
307 auto internalForcesFunction(const Requirement& par, typename Traits::template VectorType<ST>& force,
308 const VectorXOptRef<ST>& dx = std::nullopt) const {
309 return [&](const StrainType<ST>& strain, const BopType<ST>& bopI, const int I, const auto& gp) {
310 const double intElement = geo_->integrationElement(gp.position()) * gp.weight();
311 auto stresses = stress(strain);
312 force.template segment<myDim>(myDim * I) += bopI.transpose() * stresses * intElement;
313 };
314 }
315
324 template <typename ST>
325 auto energyFunction(const Requirement& par, const VectorXOptRef<ST>& dx = std::nullopt) const {
326 return [&]() -> ST {
327 using namespace Dune::DerivativeDirections;
328 using namespace Dune;
329 ST energy = 0.0;
330 const auto eps = strainFunction(par, dx);
331 for (const auto& [gpIndex, gp] : eps.viewOverIntegrationPoints()) {
332 const auto EVoigt = eps.evaluate(gpIndex, on(gridElement));
333 energy += internalEnergy(EVoigt) * geo_->integrationElement(gp.position()) * gp.weight();
334 }
335 return energy;
336 };
337 }
338
339protected:
347 template <typename ScalarType>
348 void calculateMatrixImpl(const Requirement& par, const MatrixAffordance& affordance,
349 typename Traits::template MatrixType<> K,
350 const VectorXOptRef<ScalarType>& dx = std::nullopt) const {
351 if constexpr (hasEAS)
352 return;
353 using namespace Dune::DerivativeDirections;
354 using namespace Dune;
355 const auto uFunction = displacementFunction(par, dx);
356 const auto eps = strainFunction(par, dx);
357 const auto kFunction = stiffnessMatrixFunction<ScalarType>(par, K, dx);
358 for (const auto& [gpIndex, gp] : eps.viewOverIntegrationPoints()) {
359 const auto EVoigt = (eps.evaluate(gpIndex, on(gridElement))).eval();
360 const auto stresses = stress(EVoigt);
361 for (size_t i = 0; i < numberOfNodes_; ++i) {
362 const auto bopI = eps.evaluateDerivative(gpIndex, wrt(coeff(i)), on(gridElement));
363 for (size_t j = 0; j < numberOfNodes_; ++j) {
364 const auto bopJ = eps.evaluateDerivative(gpIndex, wrt(coeff(j)), on(gridElement));
365 const auto kgIJ = eps.evaluateDerivative(gpIndex, wrt(coeff(i, j)), along(stresses), on(gridElement));
366 kFunction(EVoigt, bopI, bopJ, kgIJ, i, j, gp);
367 }
368 }
369 }
370 }
371
372 template <typename ScalarType>
374 const VectorXOptRef<ScalarType>& dx = std::nullopt) const -> ScalarType {
375 if constexpr (hasEAS)
376 return ScalarType{0.0};
377 return energyFunction(par, dx)();
378 }
379
380 template <typename ScalarType>
382 typename Traits::template VectorType<ScalarType> force,
383 const VectorXOptRef<ScalarType>& dx = std::nullopt) const {
384 if constexpr (hasEAS)
385 return;
386 using namespace Dune::DerivativeDirections;
387 using namespace Dune;
388 const auto eps = strainFunction(par, dx);
389 const auto fIntFunction = internalForcesFunction<ScalarType>(par, force, dx);
390
391 // Internal forces
392 for (const auto& [gpIndex, gp] : eps.viewOverIntegrationPoints()) {
393 const auto EVoigt = (eps.evaluate(gpIndex, on(gridElement))).eval();
394 for (size_t i = 0; i < numberOfNodes_; ++i) {
395 const auto bopI = eps.evaluateDerivative(gpIndex, wrt(coeff(i)), on(gridElement));
396 fIntFunction(EVoigt, bopI, i, gp);
397 }
398 }
399 }
400};
401
408template <typename MAT>
409auto nonLinearElastic(const MAT& mat) {
411
412 return pre;
413}
414
415} // namespace Ikarus
416
417#else
418 #error NonLinearElastic depends on dune-localfefunctions, which is not included
419#endif
Collection of fallback default functions.
Helper for transform between Dune linear algebra types and Eigen.
Helper for the autodiff library.
Definition of the LinearElastic class for finite element mechanics computations.
Contains the FE class, which is used as a base class for all finite elements. It provides information...
Material property functions and conversion utilities.
Definition of several material related enums.
Header file for types of loads in Ikarus finite element mechanics.
Header file for various EAS functions.
constexpr Eigen::Index toVoigt(Eigen::Index i, Eigen::Index j) noexcept
Converts 2D indices to Voigt notation index.
Definition: tensorutils.hh:182
Definition: assemblermanipulatorbuildingblocks.hh:22
MatrixAffordance
A strongly typed enum class representing the matrix affordance.
Definition: ferequirements.hh:64
auto nonLinearElastic(const MAT &mat)
A helper function to create a non-linear elastic pre finite element.
Definition: nonlinearelastic.hh:409
VectorAffordance
A strongly typed enum class representing the vector affordance.
Definition: ferequirements.hh:49
ScalarAffordance
A strongly typed enum class representing the scalar affordance.
Definition: ferequirements.hh:38
Definition: utils/dirichletvalues.hh:30
FE class is a base class for all finite elements.
Definition: febase.hh:79
FETraits< BH, useEigenRef, useFlat > Traits
Definition: febase.hh:38
Class representing the requirements for finite element calculations.
Definition: ferequirements.hh:223
const SolutionVectorType & globalSolution() const
Get the global solution vector.
Definition: ferequirements.hh:313
Container that is used for FE Results. It gives access to the stored value, but can also be used to a...
Definition: feresulttypes.hh:164
Base class for element definitions that provides common functionality for ResultTypes.
Definition: feresulttypes.hh:277
Traits for handling finite elements.
Definition: fetraits.hh:25
typename Basis::LocalView LocalView
Type of the local view.
Definition: fetraits.hh:42
typename Element::Geometry Geometry
Type of the element geometry.
Definition: fetraits.hh:51
std::conditional_t< useFlat, FlatBasis, UntouchedBasis > Basis
Type of the basis version.
Definition: fetraits.hh:39
typename Basis::GridView GridView
Type of the grid view.
Definition: fetraits.hh:45
typename BasisHandler::FlatBasis FlatBasis
Type of the flat basis.
Definition: fetraits.hh:33
typename LocalView::Element Element
Type of the grid element.
Definition: fetraits.hh:48
static constexpr int mydim
Dimension of the geometry.
Definition: fetraits.hh:63
NonLinearElastic class represents a non-linear elastic finite element.
Definition: nonlinearelastic.hh:62
auto strainFunction(const Requirement &par, const VectorXOptRef< ScalarType > &dx=std::nullopt) const
The strain function for the given Requirement.
Definition: nonlinearelastic.hh:156
typename Traits::Basis Basis
Definition: nonlinearelastic.hh:65
typename Traits::Geometry Geometry
Definition: nonlinearelastic.hh:69
typename Traits::FlatBasis FlatBasis
Definition: nonlinearelastic.hh:66
Eigen::Matrix< ST, strainDim, myDim > BopType
Definition: nonlinearelastic.hh:95
auto energyFunction(const Requirement &par, const VectorXOptRef< ST > &dx=std::nullopt) const
Get a lambda function that evaluates the internal energy at a given integration point and its index.
Definition: nonlinearelastic.hh:325
PRE::Material Material
Definition: nonlinearelastic.hh:72
const Dune::CachedLocalBasis< std::remove_cvref_t< LocalBasisType > > & localBasis() const
Definition: nonlinearelastic.hh:204
std::optional< std::reference_wrapper< const Eigen::VectorX< ST > > > VectorXOptRef
Definition: nonlinearelastic.hh:78
typename Traits::GridView GridView
Definition: nonlinearelastic.hh:70
void bindImpl()
A helper function to bind the local view to the element.
Definition: nonlinearelastic.hh:111
void calculateVectorImpl(const Requirement &par, VectorAffordance affordance, typename Traits::template VectorType< ScalarType > force, const VectorXOptRef< ScalarType > &dx=std::nullopt) const
Definition: nonlinearelastic.hh:381
const Geometry & geometry() const
Definition: nonlinearelastic.hh:201
static constexpr int myDim
Definition: nonlinearelastic.hh:80
auto calculateScalarImpl(const Requirement &par, ScalarAffordance affordance, const VectorXOptRef< ScalarType > &dx=std::nullopt) const -> ScalarType
Definition: nonlinearelastic.hh:373
auto calculateAtImpl(const Requirement &req, const Dune::FieldVector< double, Traits::mydim > &local, Dune::PriorityTag< 1 >) const
Calculates a requested result at a specific local position.
Definition: nonlinearelastic.hh:247
static constexpr auto stressType
Definition: nonlinearelastic.hh:83
decltype(auto) material() const
Definition: nonlinearelastic.hh:207
NonLinearElastic(const Pre &pre)
Constructor for the NonLinearElastic class.
Definition: nonlinearelastic.hh:104
typename Traits::Element Element
Definition: nonlinearelastic.hh:71
PRE Pre
Definition: nonlinearelastic.hh:73
Eigen::Matrix< ST, myDim, myDim > KgType
Definition: nonlinearelastic.hh:98
auto resultFunction() const
Get a lambda function that evaluates the requested result type for a given strain (in Voigt notation)...
Definition: nonlinearelastic.hh:222
auto stiffnessMatrixFunction(const Requirement &par, typename Traits::template MatrixType< ST > &K, const VectorXOptRef< ST > &dx=std::nullopt) const
Get a lambda function that evaluates the stiffness matrix for a given strain, integration point and i...
Definition: nonlinearelastic.hh:285
auto materialTangent(const Eigen::Vector< ScalarType, strainDim > &strain) const
Get the material tangent for the given strain for the given Requirement.
Definition: nonlinearelastic.hh:197
static constexpr int strainDim
Definition: nonlinearelastic.hh:81
auto internalEnergy(const Eigen::Vector< ScalarType, strainDim > &strain) const
Get the internal energy for the given strain.
Definition: nonlinearelastic.hh:169
static constexpr auto strainType
Definition: nonlinearelastic.hh:82
Eigen::Vector< ST, strainDim > StrainType
Definition: nonlinearelastic.hh:92
typename Traits::LocalView LocalView
Definition: nonlinearelastic.hh:68
static constexpr bool hasEAS
Definition: nonlinearelastic.hh:84
int order() const
Definition: nonlinearelastic.hh:203
decltype(std::declval< LocalView >().tree().child(0).finiteElement().localBasis()) LocalBasisType
Definition: nonlinearelastic.hh:75
auto internalForcesFunction(const Requirement &par, typename Traits::template VectorType< ST > &force, const VectorXOptRef< ST > &dx=std::nullopt) const
Get a lambda function that evaluates the internal force vector for a given strain,...
Definition: nonlinearelastic.hh:307
auto stress(const Eigen::Vector< ScalarType, strainDim > &strain) const
Get the stress for the given strain.
Definition: nonlinearelastic.hh:183
auto displacementFunction(const Requirement &par, const VectorXOptRef< ScalarType > &dx=std::nullopt) const
Get the displacement function for the given Requirement.
Definition: nonlinearelastic.hh:140
size_t numberOfNodes() const
Definition: nonlinearelastic.hh:202
void calculateMatrixImpl(const Requirement &par, const MatrixAffordance &affordance, typename Traits::template MatrixType<> K, const VectorXOptRef< ScalarType > &dx=std::nullopt) const
Calculate the matrix associated with the given Requirement.
Definition: nonlinearelastic.hh:348
A PreFE struct for non-linear elastic elements.
Definition: nonlinearelastic.hh:43
MAT Material
Definition: nonlinearelastic.hh:44
MAT material
Definition: nonlinearelastic.hh:45
Definition: utils/dirichletvalues.hh:32
Concept to check if the underlying scalar type is a dual type.
Definition: utils/concepts.hh:615