version 0.4
Ikarus::NonLinearElastic< Basis_, Material_, FERequirements_, useEigenRef > Class Template Reference

NonLinearElastic class represents a non-linear elastic finite element. More...

#include <ikarus/finiteelements/mechanics/nonlinearelastic.hh>

Inheritance diagram for Ikarus::NonLinearElastic< Basis_, Material_, FERequirements_, useEigenRef >:
[legend]

Public Types

using Traits = TraitsFromFE< Basis_, FERequirements_, useEigenRef >
 
using Basis = typename Traits::Basis
 
using FlatBasis = typename Traits::FlatBasis
 
using FERequirementType = typename Traits::FERequirementType
 
using LocalView = typename Traits::LocalView
 
using Geometry = typename Traits::Geometry
 
using GridView = typename Traits::GridView
 
using Element = typename Traits::Element
 
using ResultRequirementsType = typename Traits::ResultRequirementsType
 
using BasePowerFE = PowerBasisFE< FlatBasis >
 
using Material = Material_
 
using VolumeType = Volume< NonLinearElastic< Basis_, Material_, FERequirements_, useEigenRef >, Traits >
 
using TractionType = Traction< NonLinearElastic< Basis_, Material_, FERequirements_, useEigenRef >, Traits >
 
using LocalBasisType = decltype(std::declval< LocalView >().tree().child(0).finiteElement().localBasis())
 
using RootBasis = Basis_::FlatBasis
 Type of the root basis. More...
 
using GlobalIndex = typename LocalView::MultiIndex
 Type of the global index. More...
 
using GridElement = typename LocalView::Element
 Type of the grid element. More...
 

Public Member Functions

template<typename VolumeLoad = utils::LoadDefault, typename NeumannBoundaryLoad = utils::LoadDefault>
 NonLinearElastic (const Basis &globalBasis, const typename LocalView::Element &element, const Material &p_mat, VolumeLoad p_volumeLoad={}, const BoundaryPatch< GridView > *p_neumannBoundary=nullptr, NeumannBoundaryLoad p_neumannBoundaryLoad={})
 Constructor for the NonLinearElastic class. More...
 
template<typename ScalarType = double>
auto displacementFunction (const FERequirementType &par, const std::optional< const Eigen::VectorX< ScalarType > > &dx=std::nullopt) const
 Get the displacement function for the given FERequirementType. More...
 
template<typename ScalarType = double>
auto strainFunction (const FERequirementType &par, const std::optional< const Eigen::VectorX< ScalarType > > &dx=std::nullopt) const
 The strain function for the given FERequirementType. More...
 
template<typename ScalarType , int strainDim, bool voigt = true>
auto materialTangent (const Eigen::Vector< ScalarType, strainDim > &strain) const
 Get the material tangent for the given strain. More...
 
template<typename ScalarType , int strainDim>
auto getInternalEnergy (const Eigen::Vector< ScalarType, strainDim > &strain) const
 Get the internal energy for the given strain. More...
 
template<typename ScalarType , int strainDim, bool voigt = true>
auto getStress (const Eigen::Vector< ScalarType, strainDim > &strain) const
 Get the stress for the given strain. More...
 
const Geometrygeometry () const
 
size_t numberOfNodes () const
 
int order () const
 
double calculateScalar (const FERequirementType &par) const
 Calculate the scalar value associated with the given FERequirementType. More...
 
void calculateVector (const FERequirementType &par, typename Traits::template VectorType<> force) const
 Calculate the vector associated with the given FERequirementType. More...
 
void calculateMatrix (const FERequirementType &par, typename Traits::template MatrixType<> K) const
 Calculate the matrix associated with the given FERequirementType. More...
 
void calculateAt (const ResultRequirementsType &req, const Dune::FieldVector< double, Traits::mydim > &local, ResultTypeMap< double > &result) const
 Calculate specified results at a given local position. More...
 
constexpr size_t size () const
 Get the size of the local view. More...
 
void globalFlatIndices (std::vector< GlobalIndex > &globalIndices) const
 Get the global flat indices for the power basis. More...
 
const GridElementgridElement () const
 Get the grid element associated with the local view. More...
 
const LocalViewlocalView () const
 Get the const reference to the local view. More...
 
LocalViewlocalView ()
 Get the reference to the local view. More...
 
double calculateScalar (const FERequirementType &req) const
 Calculate the scalar value. More...
 
void calculateVector (const FERequirementType &req, typename Traits::template VectorType<> force) const
 Calculate the vector associated with the given FERequirementType. More...
 
void calculateMatrix (const FERequirementType &req, typename Traits::template MatrixType<> K) const
 Calculate the matrix associated with the given FERequirementType. More...
 
double calculateScalar (const FERequirementType &req) const
 Calculate the scalar value. More...
 
void calculateVector (const FERequirementType &req, typename Traits::template VectorType<> force) const
 Calculate the vector associated with the given FERequirementType. More...
 
void calculateMatrix (const FERequirementType &req, typename Traits::template MatrixType<> K) const
 Calculate the matrix associated with the given FERequirementType. More...
 

Static Public Attributes

static constexpr int myDim = Traits::mydim
 
static constexpr auto strainType = StrainTags::greenLagrangian
 
static constexpr int num_children
 Number of children in the powerBasis. More...
 
static constexpr int worldDim
 
static constexpr int worldDim
 

Protected Member Functions

template<typename ScalarType >
auto calculateScalarImpl (const FERequirementType &par, const std::optional< const Eigen::VectorX< ScalarType > > &dx=std::nullopt) const -> ScalarType
 
template<typename ScalarType >
void calculateVectorImpl (const FERequirementType &par, typename Traits::template VectorType< ScalarType > force, const std::optional< const Eigen::VectorX< ScalarType > > &dx=std::nullopt) const
 
auto calculateScalarImpl (const FERequirementType &par, const std::optional< const Eigen::VectorX< ScalarType > > &dx=std::nullopt) const -> ScalarType
 
void calculateVectorImpl (const FERequirementType &par, typename Traits::template VectorType< ScalarType > force, const std::optional< const Eigen::VectorX< ScalarType > > &dx=std::nullopt) const
 
void calculateMatrixImpl (const FERequirementType &par, typename Traits::template MatrixType<> K, const std::optional< const Eigen::VectorX< ScalarType > > &dx=std::nullopt) const
 
auto calculateScalarImpl (const FERequirementType &par, const std::optional< const Eigen::VectorX< ScalarType > > &dx=std::nullopt) const -> ScalarType
 
void calculateVectorImpl (const FERequirementType &par, typename Traits::template VectorType< ScalarType > force, const std::optional< const Eigen::VectorX< ScalarType > > dx=std::nullopt) const
 
void calculateMatrixImpl (const FERequirementType &par, typename Traits::template MatrixType<> K, const std::optional< const Eigen::VectorX< ScalarType > > &dx=std::nullopt) const
 

Detailed Description

template<typename Basis_, typename Material_, typename FERequirements_ = FERequirements<>, bool useEigenRef = false>
class Ikarus::NonLinearElastic< Basis_, Material_, FERequirements_, useEigenRef >
Template Parameters
Basis_The basis type for the finite element.
Material_The material type for the finite element.
FERequirements_The requirements for the finite element.
useEigenRefA boolean flag indicating whether to use Eigen references.

Member Typedef Documentation

◆ BasePowerFE

template<typename Basis_ , typename Material_ , typename FERequirements_ = FERequirements<>, bool useEigenRef = false>
using Ikarus::NonLinearElastic< Basis_, Material_, FERequirements_, useEigenRef >::BasePowerFE = PowerBasisFE<FlatBasis>

◆ Basis

template<typename Basis_ , typename Material_ , typename FERequirements_ = FERequirements<>, bool useEigenRef = false>
using Ikarus::NonLinearElastic< Basis_, Material_, FERequirements_, useEigenRef >::Basis = typename Traits::Basis

◆ Element

template<typename Basis_ , typename Material_ , typename FERequirements_ = FERequirements<>, bool useEigenRef = false>
using Ikarus::NonLinearElastic< Basis_, Material_, FERequirements_, useEigenRef >::Element = typename Traits::Element

◆ FERequirementType

template<typename Basis_ , typename Material_ , typename FERequirements_ = FERequirements<>, bool useEigenRef = false>
using Ikarus::NonLinearElastic< Basis_, Material_, FERequirements_, useEigenRef >::FERequirementType = typename Traits::FERequirementType

◆ FlatBasis

template<typename Basis_ , typename Material_ , typename FERequirements_ = FERequirements<>, bool useEigenRef = false>
using Ikarus::NonLinearElastic< Basis_, Material_, FERequirements_, useEigenRef >::FlatBasis = typename Traits::FlatBasis

◆ Geometry

template<typename Basis_ , typename Material_ , typename FERequirements_ = FERequirements<>, bool useEigenRef = false>
using Ikarus::NonLinearElastic< Basis_, Material_, FERequirements_, useEigenRef >::Geometry = typename Traits::Geometry

◆ GlobalIndex

using Ikarus::PowerBasisFE< Basis_::FlatBasis >::GlobalIndex = typename LocalView::MultiIndex
inherited

◆ GridElement

using Ikarus::PowerBasisFE< Basis_::FlatBasis >::GridElement = typename LocalView::Element
inherited

◆ GridView

template<typename Basis_ , typename Material_ , typename FERequirements_ = FERequirements<>, bool useEigenRef = false>
using Ikarus::NonLinearElastic< Basis_, Material_, FERequirements_, useEigenRef >::GridView = typename Traits::GridView

◆ LocalBasisType

template<typename Basis_ , typename Material_ , typename FERequirements_ = FERequirements<>, bool useEigenRef = false>
using Ikarus::NonLinearElastic< Basis_, Material_, FERequirements_, useEigenRef >::LocalBasisType = decltype(std::declval<LocalView>().tree().child(0).finiteElement().localBasis())

◆ LocalView

template<typename Basis_ , typename Material_ , typename FERequirements_ = FERequirements<>, bool useEigenRef = false>
using Ikarus::NonLinearElastic< Basis_, Material_, FERequirements_, useEigenRef >::LocalView = typename Traits::LocalView

◆ Material

template<typename Basis_ , typename Material_ , typename FERequirements_ = FERequirements<>, bool useEigenRef = false>
using Ikarus::NonLinearElastic< Basis_, Material_, FERequirements_, useEigenRef >::Material = Material_

◆ ResultRequirementsType

template<typename Basis_ , typename Material_ , typename FERequirements_ = FERequirements<>, bool useEigenRef = false>
using Ikarus::NonLinearElastic< Basis_, Material_, FERequirements_, useEigenRef >::ResultRequirementsType = typename Traits::ResultRequirementsType

◆ RootBasis

using Ikarus::PowerBasisFE< Basis_::FlatBasis >::RootBasis = Basis_::FlatBasis
inherited

◆ TractionType

template<typename Basis_ , typename Material_ , typename FERequirements_ = FERequirements<>, bool useEigenRef = false>
using Ikarus::NonLinearElastic< Basis_, Material_, FERequirements_, useEigenRef >::TractionType = Traction<NonLinearElastic<Basis_, Material_, FERequirements_, useEigenRef>, Traits>

◆ Traits

template<typename Basis_ , typename Material_ , typename FERequirements_ = FERequirements<>, bool useEigenRef = false>
using Ikarus::NonLinearElastic< Basis_, Material_, FERequirements_, useEigenRef >::Traits = TraitsFromFE<Basis_, FERequirements_, useEigenRef>

◆ VolumeType

template<typename Basis_ , typename Material_ , typename FERequirements_ = FERequirements<>, bool useEigenRef = false>
using Ikarus::NonLinearElastic< Basis_, Material_, FERequirements_, useEigenRef >::VolumeType = Volume<NonLinearElastic<Basis_, Material_, FERequirements_, useEigenRef>, Traits>

Constructor & Destructor Documentation

◆ NonLinearElastic()

template<typename Basis_ , typename Material_ , typename FERequirements_ = FERequirements<>, bool useEigenRef = false>
template<typename VolumeLoad = utils::LoadDefault, typename NeumannBoundaryLoad = utils::LoadDefault>
Ikarus::NonLinearElastic< Basis_, Material_, FERequirements_, useEigenRef >::NonLinearElastic ( const Basis globalBasis,
const typename LocalView::Element &  element,
const Material p_mat,
VolumeLoad  p_volumeLoad = {},
const BoundaryPatch< GridView > *  p_neumannBoundary = nullptr,
NeumannBoundaryLoad  p_neumannBoundaryLoad = {} 
)
inline
Template Parameters
VolumeLoadThe type for the volume load function.
NeumannBoundaryLoadThe type for the Neumann boundary load function.
Parameters
globalBasisThe global basis for the finite element.
elementThe element for which the finite element is constructed.
p_matThe material for the non-linear elastic element.
p_volumeLoadVolume load function (default is LoadDefault).
p_neumannBoundaryNeumann boundary patch (default is nullptr).
p_neumannBoundaryLoadNeumann boundary load function (default is LoadDefault).

Member Function Documentation

◆ calculateAt()

template<typename Basis_ , typename Material_ , typename FERequirements_ = FERequirements<>, bool useEigenRef = false>
void Ikarus::NonLinearElastic< Basis_, Material_, FERequirements_, useEigenRef >::calculateAt ( const ResultRequirementsType req,
const Dune::FieldVector< double, Traits::mydim > &  local,
ResultTypeMap< double > &  result 
) const
inline
Parameters
reqThe ResultRequirementsType object specifying the required results.
localThe local position for which results are to be calculated.
resultThe ResultTypeMap object to store the calculated results.

◆ calculateMatrix() [1/3]

template<typename Basis_ , typename Material_ , typename FERequirements_ = FERequirements<>, bool useEigenRef = false>
void Ikarus::NonLinearElastic< Basis_, Material_, FERequirements_, useEigenRef >::calculateMatrix ( const FERequirementType par,
typename Traits::template MatrixType<>  K 
) const
inline
Template Parameters
ScalarTypeThe scalar type for the calculation.
Parameters
parThe FERequirementType object specifying the requirements for the calculation.
KThe matrix to store the calculated result.

◆ calculateMatrix() [2/3]

void Ikarus::Traction< NonLinearElastic< Basis_, Material_, FERequirements<>, false > , TraitsFromFE< Basis_, FERequirements<>, false > >::calculateMatrix ( const FERequirementType req,
typename Traits::template MatrixType<>  K 
) const
inlineinherited
Template Parameters
ScalarTypeThe scalar type for the calculation.
Parameters
reqThe FERequirementType object specifying the requirements for the calculation.
KThe matrix to store the calculated result.

◆ calculateMatrix() [3/3]

void Ikarus::Volume< NonLinearElastic< Basis_, Material_, FERequirements<>, false > , TraitsFromFE< Basis_, FERequirements<>, false > >::calculateMatrix ( const FERequirementType req,
typename Traits::template MatrixType<>  K 
) const
inlineinherited
Template Parameters
ScalarTypeThe scalar type for the calculation.
Parameters
reqThe FERequirementType object specifying the requirements for the calculation.
KThe matrix to store the calculated result.

◆ calculateMatrixImpl() [1/2]

void Ikarus::Traction< NonLinearElastic< Basis_, Material_, FERequirements<>, false > , TraitsFromFE< Basis_, FERequirements<>, false > >::calculateMatrixImpl ( const FERequirementType par,
typename Traits::template MatrixType<>  K,
const std::optional< const Eigen::VectorX< ScalarType > > &  dx = std::nullopt 
) const
inlineprotectedinherited

◆ calculateMatrixImpl() [2/2]

void Ikarus::Volume< NonLinearElastic< Basis_, Material_, FERequirements<>, false > , TraitsFromFE< Basis_, FERequirements<>, false > >::calculateMatrixImpl ( const FERequirementType par,
typename Traits::template MatrixType<>  K,
const std::optional< const Eigen::VectorX< ScalarType > > &  dx = std::nullopt 
) const
inlineprotectedinherited

◆ calculateScalar() [1/3]

template<typename Basis_ , typename Material_ , typename FERequirements_ = FERequirements<>, bool useEigenRef = false>
double Ikarus::NonLinearElastic< Basis_, Material_, FERequirements_, useEigenRef >::calculateScalar ( const FERequirementType par) const
inline
Template Parameters
ScalarTypeThe scalar type for the calculation.
Parameters
parThe FERequirementType object specifying the requirements for the calculation.
Returns
The calculated scalar value.

◆ calculateScalar() [2/3]

double Ikarus::Traction< NonLinearElastic< Basis_, Material_, FERequirements<>, false > , TraitsFromFE< Basis_, FERequirements<>, false > >::calculateScalar ( const FERequirementType req) const
inlineinherited

Calculates the scalar value based on the given FERequirements.

Parameters
reqThe FERequirements.
Returns
The calculated scalar value.

◆ calculateScalar() [3/3]

double Ikarus::Volume< NonLinearElastic< Basis_, Material_, FERequirements<>, false > , TraitsFromFE< Basis_, FERequirements<>, false > >::calculateScalar ( const FERequirementType req) const
inlineinherited

Calculates the scalar value based on the given FERequirements.

Parameters
reqThe FERequirements.
Returns
The calculated scalar value.

◆ calculateScalarImpl() [1/3]

auto Ikarus::Traction< NonLinearElastic< Basis_, Material_, FERequirements<>, false > , TraitsFromFE< Basis_, FERequirements<>, false > >::calculateScalarImpl ( const FERequirementType par,
const std::optional< const Eigen::VectorX< ScalarType > > &  dx = std::nullopt 
) const-> ScalarType
inlineprotectedinherited

◆ calculateScalarImpl() [2/3]

auto Ikarus::Volume< NonLinearElastic< Basis_, Material_, FERequirements<>, false > , TraitsFromFE< Basis_, FERequirements<>, false > >::calculateScalarImpl ( const FERequirementType par,
const std::optional< const Eigen::VectorX< ScalarType > > &  dx = std::nullopt 
) const-> ScalarType
inlineprotectedinherited

◆ calculateScalarImpl() [3/3]

template<typename Basis_ , typename Material_ , typename FERequirements_ = FERequirements<>, bool useEigenRef = false>
template<typename ScalarType >
auto Ikarus::NonLinearElastic< Basis_, Material_, FERequirements_, useEigenRef >::calculateScalarImpl ( const FERequirementType par,
const std::optional< const Eigen::VectorX< ScalarType > > &  dx = std::nullopt 
) const -> ScalarType
inlineprotected

◆ calculateVector() [1/3]

template<typename Basis_ , typename Material_ , typename FERequirements_ = FERequirements<>, bool useEigenRef = false>
void Ikarus::NonLinearElastic< Basis_, Material_, FERequirements_, useEigenRef >::calculateVector ( const FERequirementType par,
typename Traits::template VectorType<>  force 
) const
inline
Template Parameters
ScalarTypeThe scalar type for the calculation.
Parameters
parThe FERequirementType object specifying the requirements for the calculation.
forceThe vector to store the calculated result.

◆ calculateVector() [2/3]

void Ikarus::Traction< NonLinearElastic< Basis_, Material_, FERequirements<>, false > , TraitsFromFE< Basis_, FERequirements<>, false > >::calculateVector ( const FERequirementType req,
typename Traits::template VectorType<>  force 
) const
inlineinherited
Template Parameters
ScalarTypeThe scalar type for the calculation.
Parameters
reqThe FERequirementType object specifying the requirements for the calculation.
forceThe vector to store the calculated result.

◆ calculateVector() [3/3]

void Ikarus::Volume< NonLinearElastic< Basis_, Material_, FERequirements<>, false > , TraitsFromFE< Basis_, FERequirements<>, false > >::calculateVector ( const FERequirementType req,
typename Traits::template VectorType<>  force 
) const
inlineinherited
Template Parameters
ScalarTypeThe scalar type for the calculation.
Parameters
reqThe FERequirementType object specifying the requirements for the calculation.
forceThe vector to store the calculated result.

◆ calculateVectorImpl() [1/3]

void Ikarus::Volume< NonLinearElastic< Basis_, Material_, FERequirements<>, false > , TraitsFromFE< Basis_, FERequirements<>, false > >::calculateVectorImpl ( const FERequirementType par,
typename Traits::template VectorType< ScalarType >  force,
const std::optional< const Eigen::VectorX< ScalarType > > &  dx = std::nullopt 
) const
inlineprotectedinherited

◆ calculateVectorImpl() [2/3]

template<typename Basis_ , typename Material_ , typename FERequirements_ = FERequirements<>, bool useEigenRef = false>
template<typename ScalarType >
void Ikarus::NonLinearElastic< Basis_, Material_, FERequirements_, useEigenRef >::calculateVectorImpl ( const FERequirementType par,
typename Traits::template VectorType< ScalarType >  force,
const std::optional< const Eigen::VectorX< ScalarType > > &  dx = std::nullopt 
) const
inlineprotected

◆ calculateVectorImpl() [3/3]

void Ikarus::Traction< NonLinearElastic< Basis_, Material_, FERequirements<>, false > , TraitsFromFE< Basis_, FERequirements<>, false > >::calculateVectorImpl ( const FERequirementType par,
typename Traits::template VectorType< ScalarType >  force,
const std::optional< const Eigen::VectorX< ScalarType > >  dx = std::nullopt 
) const
inlineprotectedinherited

Integration rule along the boundary

The value of the local function wrt the i-th coeff

Value of the Neumann data at the current position

◆ displacementFunction()

template<typename Basis_ , typename Material_ , typename FERequirements_ = FERequirements<>, bool useEigenRef = false>
template<typename ScalarType = double>
auto Ikarus::NonLinearElastic< Basis_, Material_, FERequirements_, useEigenRef >::displacementFunction ( const FERequirementType par,
const std::optional< const Eigen::VectorX< ScalarType > > &  dx = std::nullopt 
) const
inline
Template Parameters
ScalarTypeThe scalar type for the displacement function.
Parameters
parThe FERequirementType object.
dxOptional displacement vector.
Returns
A StandardLocalFunction representing the displacement function.
Here is the caller graph for this function:

◆ geometry()

template<typename Basis_ , typename Material_ , typename FERequirements_ = FERequirements<>, bool useEigenRef = false>
const Geometry & Ikarus::NonLinearElastic< Basis_, Material_, FERequirements_, useEigenRef >::geometry ( ) const
inline

◆ getInternalEnergy()

template<typename Basis_ , typename Material_ , typename FERequirements_ = FERequirements<>, bool useEigenRef = false>
template<typename ScalarType , int strainDim>
auto Ikarus::NonLinearElastic< Basis_, Material_, FERequirements_, useEigenRef >::getInternalEnergy ( const Eigen::Vector< ScalarType, strainDim > &  strain) const
inline
Template Parameters
ScalarTypeThe scalar type for the material and strain.
strainDimThe dimension of the strain vector.
Parameters
strainThe strain vector.
Returns
The internal energy calculated using the material's storedEnergy function.
Here is the caller graph for this function:

◆ getStress()

template<typename Basis_ , typename Material_ , typename FERequirements_ = FERequirements<>, bool useEigenRef = false>
template<typename ScalarType , int strainDim, bool voigt = true>
auto Ikarus::NonLinearElastic< Basis_, Material_, FERequirements_, useEigenRef >::getStress ( const Eigen::Vector< ScalarType, strainDim > &  strain) const
inline
Template Parameters
ScalarTypeThe scalar type for the material and strain.
strainDimThe dimension of the strain vector.
voigtA boolean indicating whether to use the Voigt notation for stress.
Parameters
strainThe strain vector.
Returns
The stress vector calculated using the material's stresses function.
Here is the caller graph for this function:

◆ globalFlatIndices()

void Ikarus::PowerBasisFE< Basis_::FlatBasis >::globalFlatIndices ( std::vector< GlobalIndex > &  globalIndices) const
inlineinherited

The global indices are collected in a FlatInterLeaved order. I.e. x_0, y_0, z_0, ..., x_n, y_n, z_n

Parameters
globalIndicesOutput vector to store global indices.

◆ gridElement()

const GridElement & Ikarus::PowerBasisFE< Basis_::FlatBasis >::gridElement ( ) const
inlineinherited
Returns
The grid element.

◆ localView() [1/2]

LocalView & Ikarus::PowerBasisFE< Basis_::FlatBasis >::localView ( )
inlineinherited
Returns
The reference to the local view.

◆ localView() [2/2]

const LocalView & Ikarus::PowerBasisFE< Basis_::FlatBasis >::localView ( ) const
inlineinherited
Returns
The const reference to the local view.

◆ materialTangent()

template<typename Basis_ , typename Material_ , typename FERequirements_ = FERequirements<>, bool useEigenRef = false>
template<typename ScalarType , int strainDim, bool voigt = true>
auto Ikarus::NonLinearElastic< Basis_, Material_, FERequirements_, useEigenRef >::materialTangent ( const Eigen::Vector< ScalarType, strainDim > &  strain) const
inline
Template Parameters
ScalarTypeThe scalar type for the material and strain.
strainDimThe dimension of the strain vector.
voigtFlag indicating whether to use Voigt notation.
Parameters
strainThe strain vector.
Returns
The material tangent calculated using the material's tangentModuli function.
Here is the caller graph for this function:

◆ numberOfNodes()

template<typename Basis_ , typename Material_ , typename FERequirements_ = FERequirements<>, bool useEigenRef = false>
size_t Ikarus::NonLinearElastic< Basis_, Material_, FERequirements_, useEigenRef >::numberOfNodes ( ) const
inline

◆ order()

template<typename Basis_ , typename Material_ , typename FERequirements_ = FERequirements<>, bool useEigenRef = false>
int Ikarus::NonLinearElastic< Basis_, Material_, FERequirements_, useEigenRef >::order ( ) const
inline

◆ size()

constexpr size_t Ikarus::PowerBasisFE< Basis_::FlatBasis >::size ( ) const
inlineconstexprinherited
Returns
The size of the local view.

◆ strainFunction()

template<typename Basis_ , typename Material_ , typename FERequirements_ = FERequirements<>, bool useEigenRef = false>
template<typename ScalarType = double>
auto Ikarus::NonLinearElastic< Basis_, Material_, FERequirements_, useEigenRef >::strainFunction ( const FERequirementType par,
const std::optional< const Eigen::VectorX< ScalarType > > &  dx = std::nullopt 
) const
inline
Template Parameters
ScalarTypeThe scalar type for the strain function.
Parameters
parThe FERequirementType object.
dxOptional displacement vector.
Returns
The strain function calculated using greenLagrangeStrains.
Here is the caller graph for this function:

Member Data Documentation

◆ myDim

template<typename Basis_ , typename Material_ , typename FERequirements_ = FERequirements<>, bool useEigenRef = false>
constexpr int Ikarus::NonLinearElastic< Basis_, Material_, FERequirements_, useEigenRef >::myDim = Traits::mydim
staticconstexpr

◆ num_children

constexpr int Ikarus::PowerBasisFE< Basis_::FlatBasis >::num_children
staticconstexprinherited

◆ strainType

template<typename Basis_ , typename Material_ , typename FERequirements_ = FERequirements<>, bool useEigenRef = false>
constexpr auto Ikarus::NonLinearElastic< Basis_, Material_, FERequirements_, useEigenRef >::strainType = StrainTags::greenLagrangian
staticconstexpr

◆ worldDim [1/2]

constexpr int Ikarus::Traction< NonLinearElastic< Basis_, Material_, FERequirements<>, false > , TraitsFromFE< Basis_, FERequirements<>, false > >::worldDim
staticconstexprinherited

◆ worldDim [2/2]

constexpr int Ikarus::Volume< NonLinearElastic< Basis_, Material_, FERequirements<>, false > , TraitsFromFE< Basis_, FERequirements<>, false > >::worldDim
staticconstexprinherited

The documentation for this class was generated from the following file: