G+Smo  23.12.0
Geometry + Simulation Modules
 All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Friends Macros Groups Pages
gsMaterialMatrixLinear< dim, T > Class Template Reference

Detailed Description

template<short_t dim, class T>
class gismo::gsMaterialMatrixLinear< dim, T >

This class defines a linear material.

Template Parameters
dimThe dimension of the problem (2 = planar, 3 = surface)
TReal type
+ Inheritance diagram for gsMaterialMatrixLinear< dim, T >:
+ Collaboration diagram for gsMaterialMatrixLinear< dim, T >:

Public Types

typedef memory::shared_ptr
< gsMaterialMatrixLinear
Ptr
 Shared pointer for gsMaterialMatrixLinear.
 
typedef memory::unique_ptr
< gsMaterialMatrixLinear
uPtr
 Unique pointer for gsMaterialMatrixLinear.
 

Public Member Functions

void _computeMetricDeformed (const index_t patch, const gsMatrix< T > &u) const
 Computes metric quantities on the deformed geometry.
 
void _computeMetricUndeformed (const index_t patch, const gsMatrix< T > &u) const
 Computes metric quantities on the undeformed geometry.
 
void _computePStrain (const gsMatrix< T > &C) const
 Computes the stretch given deformation tensor C, into class members m_stretches and m_stretchDirs.
 
void _computePStress (const gsMatrix< T > &C) const
 Computes the principal stresses of a given stress tensor S, into class members m_pstress and m_pstressvec.
 
void _computeStretch (const gsMatrix< T > &C, const gsMatrix< T > &gcon_ori) const
 Computes the stretch given deformation tensor C, into class members m_stretches and m_stretchDirs.
 
std::pair< gsVector< T >
, gsMatrix< T > > 
_evalPStrain (const gsMatrix< T > &C) const
 Computes the principal strain given deformation tensor C, into a pair.
 
std::pair< gsVector< T >
, gsMatrix< T > > 
_evalPStress (const gsMatrix< T > &S) const
 Computes the principal stress given stress tensor S, into a pair.
 
std::pair< gsVector< T >
, gsMatrix< T > > 
_evalStretch (const gsMatrix< T > &C, const gsMatrix< T > &gcon_ori) const
 Computes the stretch given deformation tensor C, into a pair.
 
gsMatrix< T > _getAcon_def (index_t k, T z) const
 Returns the contravariant a tensor on the deformed geometry.
 
gsMatrix< T > _getacon_def (index_t k, T z) const
 Returns the contravariant basis vector a on the deformed geometry.
 
gsMatrix< T > _getAcon_ori (index_t k, T z) const
 Returns the contravariant a tensor on the original geometry.
 
gsMatrix< T > _getacon_ori (index_t k, T z) const
 Returns the contravariant basis vector a on the original geometry.
 
gsMatrix< T > _getAcov_def (index_t k, T z) const
 Returns the covariant a tensor on the deformed geometry.
 
gsMatrix< T > _getacov_def (index_t k, T z) const
 Returns the covariant basis vector a on the deformed geometry.
 
gsMatrix< T > _getAcov_ori (index_t k, T z) const
 Returns the covariant a tensor on the original geometry.
 
gsMatrix< T > _getacov_ori (index_t k, T z) const
 Returns the covariant basis vector a on the original geometry.
 
gsMatrix< T > _getBcov_def (index_t k, T z) const
 Returns the covariant b tensor on the deformed geometry.
 
gsMatrix< T > _getBcov_ori (index_t k, T z) const
 Returns the covariant b tensor on the original geometry.
 
gsMatrix< T > _getGcon_def (index_t k, T z) const
 Returns the contravariant metric tensor on the deformed geometry.
 
gsMatrix< T > _getgcon_def (index_t k, T z) const
 Returns the contravariant basis vector g on the deformed geometry.
 
gsMatrix< T > _getGcon_ori (index_t k, T z) const
 Returns the contravariant metric tensor on the original geometry.
 
gsMatrix< T > _getgcon_ori (index_t k, T z) const
 Returns the contravariant basis vector g on the original geometry.
 
gsMatrix< T > _getGcov_def (index_t k, T z) const
 Returns the covariant metric tensor on the deformed geometry.
 
gsMatrix< T > _getgcov_def (index_t k, T z) const
 Returns the covariant basis vector g on the deformed geometry.
 
gsMatrix< T > _getGcov_ori (index_t k, T z) const
 Returns the covariant metric tensor on the original geometry.
 
gsMatrix< T > _getgcov_ori (index_t k, T z) const
 Returns the covariant basis vector g on the original geometry.
 
void _getMetric (const index_t k, const T z) const
 Gets metric quantities on the deformed and undeformed geometries.
 
void _getMetric (index_t k, T z, const gsMatrix< T > &C) const
 Gets metric quantities on the deformed and undeformed geometries.
 
void _getMetricDeformed (const index_t k, const T z) const
 Gets metric quantities on the deformed geometry.
 
void _getMetricUndeformed (const index_t k, const T z) const
 Gets metric quantities on the undeformed geometry.
 
gsMatrix< T > _getncov_def (index_t k, T z) const
 Returns the covariant n tensor on the deformed geometry.
 
gsMatrix< T > _getncov_ori (index_t k, T z) const
 Returns the covariant n tensor on the original geometry.
 
gsMatrix< T > _transformation (const gsMatrix< T > &basis1, const gsMatrix< T > &basis2) const
 Computes the stretch given deformation tensor C, into class members m_stretches and m_stretchDirs.
 
gsMatrix< T > C (const gsMatrix< T > &C, const index_t patch, const gsMatrix< T > &u, const gsMatrix< T > &z, enum MaterialOutput out) const
 Computes the matrix C as function of the deformation tensor C=FTF.
 
gsMatrix< T > dC (const gsMatrix< T > &C, const index_t patch, const gsMatrix< T > &u, const gsMatrix< T > &z, enum MaterialOutput out) const
 Computes the derivative of the matrix C as function of the deformation tensor C=FTF.
 
void defaultOptions () override
 See gsMaterialMatrixBase for details.
 
virtual void density_into (const index_t patch, const gsMatrix< T > &u, gsMatrix< T > &result) const override
 See gsMaterialMatrixBase for details.
 
gsMatrix< T > eval3D_CauchyPStress (const index_t patch, const gsMatrix< T > &u, const gsMatrix< T > &z, enum MaterialOutput out=MaterialOutput::Generic) const override
 See gsMaterialMatrixBase for details.
 
gsMatrix< T > eval3D_CauchyStress (const index_t patch, const gsMatrix< T > &u, const gsMatrix< T > &z, enum MaterialOutput out) const override
 See gsMaterialMatrixBase for details.
 
gsMatrix< T > eval3D_CauchyVector (const index_t patch, const gsMatrix< T > &u, const gsMatrix< T > &z, enum MaterialOutput out=MaterialOutput::Generic) const override
 See gsMaterialMatrixBase for details.
 
virtual gsMatrix< T > eval3D_con2cart (const index_t patch, const gsMatrix< T > &u, const gsMatrix< T > &z) const override
 See gsMaterialMatrixBase for details.
 
virtual gsMatrix< T > eval3D_cov2cart (const index_t patch, const gsMatrix< T > &u, const gsMatrix< T > &z) const override
 See gsMaterialMatrixBase for details.
 
virtual gsMatrix< T > eval3D_deformation (const index_t patch, const gsMatrix< T > &u, const gsMatrix< T > &z) const override
 See gsMaterialMatrixBase for details.
 
gsMatrix< T > eval3D_detF (const index_t patch, const gsMatrix< T > &u, const gsMatrix< T > &z, enum MaterialOutput out=MaterialOutput::Generic) const override
 See gsMaterialMatrixBase for details.
 
gsMatrix< T > eval3D_dmatrix (const index_t patch, const gsMatrix< T > &u, const gsMatrix< T > &z, enum MaterialOutput out=MaterialOutput::Generic) const override
 See gsMaterialMatrixBase for details.
 
gsMatrix< T > eval3D_matrix (const index_t patch, const gsMatrix< T > &u, const gsMatrix< T > &z, enum MaterialOutput out=MaterialOutput::Generic) const override
 See gsMaterialMatrixBase for details.
 
gsMatrix< T > eval3D_matrix_C (const gsMatrix< T > &Cmat, const index_t patch, const gsVector< T > &u, const T z, enum MaterialOutput out=MaterialOutput::Generic) const override
 See gsMaterialMatrixBase for details.
 
virtual gsMatrix< T > eval3D_pstrain (const index_t patch, const gsMatrix< T > &u, const gsMatrix< T > &z) const override
 See gsMaterialMatrixBase for details.
 
gsMatrix< T > eval3D_pstress (const index_t patch, const gsMatrix< T > &u, const gsMatrix< T > &z, enum MaterialOutput out=MaterialOutput::Generic) const override
 See gsMaterialMatrixBase for details.
 
gsMatrix< T > eval3D_pstressDir (const index_t patch, const gsMatrix< T > &u, const gsMatrix< T > &z, enum MaterialOutput out=MaterialOutput::Generic) const override
 See gsMaterialMatrixBase for details.
 
virtual gsMatrix< T > eval3D_pstressTransform (const index_t patch, const gsMatrix< T > &u, const gsMatrix< T > &z) const
 Provides the transformation of the principle stresses. More...
 
virtual gsMatrix< T > eval3D_pstretch (const index_t patch, const gsMatrix< T > &u, const gsMatrix< T > &z) const override
 See gsMaterialMatrixBase for details.
 
virtual gsMatrix< T > eval3D_pstretchDir (const index_t patch, const gsMatrix< T > &u, const gsMatrix< T > &z) const override
 See gsMaterialMatrixBase for details.
 
virtual gsMatrix< T > eval3D_pstretchTransform (const index_t patch, const gsMatrix< T > &u, const gsMatrix< T > &z) const
 Provides the transformation of the principle stretches. More...
 
virtual gsMatrix< T > eval3D_spec2con (const index_t patch, const gsMatrix< T > &u, const gsMatrix< T > &z) const override
 See gsMaterialMatrixBase for details.
 
virtual gsMatrix< T > eval3D_spec2cov (const index_t patch, const gsMatrix< T > &u, const gsMatrix< T > &z) const override
 See gsMaterialMatrixBase for details.
 
virtual gsMatrix< T > eval3D_strain (const index_t patch, const gsMatrix< T > &u, const gsMatrix< T > &z) const override
 See gsMaterialMatrixBase for details.
 
gsMatrix< T > eval3D_stress (const index_t patch, const gsMatrix< T > &u, const gsMatrix< T > &z, enum MaterialOutput out) const override
 See gsMaterialMatrixBase for details.
 
virtual gsMatrix< T > eval3D_tensionfield (const index_t patch, const gsMatrix< T > &u, const gsMatrix< T > &z, enum MaterialOutput out) const override
 See gsMaterialMatrixBase for details.
 
gsMatrix< T > eval3D_vector (const index_t patch, const gsMatrix< T > &u, const gsMatrix< T > &z, enum MaterialOutput out=MaterialOutput::Generic) const override
 See gsMaterialMatrixBase for details.
 
gsMatrix< T > eval3D_vector_C (const gsMatrix< T > &Cmat, const index_t patch, const gsVector< T > &u, const T z, enum MaterialOutput out=MaterialOutput::Generic) const override
 See gsMaterialMatrixBase for details.
 
virtual const function_ptr getDensity () const
 Gets the Density.
 
virtual const function_ptr getParameter (const index_t i) const
 Gets parameter i. More...
 
const function_ptr getPoissonsRatio () const override
 Gets the Poisson's Ratio.
 
virtual const function_ptr getThickness () const
 Gets the Density.
 
const function_ptr getYoungsModulus () const override
 Gets the YoungsModulus.
 
 gsMaterialMatrixLinear ()
 Empty constructor.
 
 gsMaterialMatrixLinear (const gsFunctionSet< T > &mp, const gsFunctionSet< T > &thickness)
 Constructor without material parameters. More...
 
 gsMaterialMatrixLinear (const gsFunctionSet< T > &mp, const gsFunctionSet< T > &thickness, const gsFunctionSet< T > &YoungsModulus, const gsFunctionSet< T > &PoissonRatio)
 Constructor without deformed multipatch and density. More...
 
 gsMaterialMatrixLinear (const gsFunctionSet< T > &mp, const gsFunctionSet< T > &thickness, const gsFunctionSet< T > &YoungsModulus, const gsFunctionSet< T > &PoissonRatio, const gsFunctionSet< T > &Density)
 Full constructor. More...
 
 gsMaterialMatrixLinear (const gsFunctionSet< T > &mp, const gsFunctionSet< T > &thickness, const std::vector< gsFunctionSet< T > * > &pars)
 Constructor without density. More...
 
 gsMaterialMatrixLinear (const gsFunctionSet< T > &mp, const gsFunctionSet< T > &thickness, const std::vector< gsFunctionSet< T > * > &pars, const gsFunctionSet< T > &Density)
 Full constructor. More...
 
 gsMaterialMatrixLinear (const gsFunctionSet< T > &thickness, const std::vector< gsFunctionSet< T > * > &pars)
 Constructor without density and multipatch. More...
 
 gsMaterialMatrixLinear (const gsFunctionSet< T > &thickness, const std::vector< gsFunctionSet< T > * > &pars, const gsFunctionSet< T > &Density)
 Constructor without multipatch. More...
 
virtual bool hasDensity () const
 Returns true if a density is assigned.
 
virtual bool hasThickness () const
 Returns true if a thickness is assigned.
 
virtual void info () const
 Prints info.
 
enum MatIntegration isMatIntegrated () const override
 See gsMaterialMatrixBase for details.
 
enum MatIntegration isVecIntegrated () const override
 See gsMaterialMatrixBase for details.
 
virtual const
gsMaterialMatrixBase< T > * 
material () const
 Returns this.
 
virtual gsMaterialMatrixBase< T > * material ()
 Returns this.
 
virtual index_t numParameters () const
 Gets the number of parameters.
 
virtual gsOptionListoptions ()
 Returns the options. More...
 
virtual void parameters_into (const index_t patch, const gsMatrix< T > &u, gsMatrix< T > &result) const override
 See gsMaterialMatrixBase for details.
 
std::ostream & print (std::ostream &os) const override
 See gsMaterialMatrixBase for details.
 
virtual void pstress_into (const index_t patch, const gsMatrix< T > &u, gsMatrix< T > &result) const
 Evaluates the priciple stresses in the shell (3x1 vector) More...
 
virtual void pstressDir_into (const index_t patch, const gsMatrix< T > &u, gsMatrix< T > &result) const
 Evaluates the directions of the priciple stresses in the shell (3x1 vector per direction) More...
 
virtual void pstretch_into (const index_t patch, const gsMatrix< T > &u, gsMatrix< T > &result) const
 Evaluates the stretches in the shell (3x1 vector) More...
 
virtual void pstretchDir_into (const index_t patch, const gsMatrix< T > &u, gsMatrix< T > &result) const
 Evaluates the directions of the stretches in the shell (3x1 vector per direction) More...
 
virtual void resetParameters ()
 See gsMaterialMatrixBase for details.
 
gsMatrix< T > S (const gsMatrix< T > &C, const index_t patch, const gsMatrix< T > &u, const gsMatrix< T > &z, enum MaterialOutput out) const
 Computes the vector S as function of the deformation tensor C=FTF.
 
virtual void setDensity (function_ptr Density)
 Sets the density.
 
virtual void setDensity (const gsFunctionSet< T > &Density)
 Sets the density.
 
virtual void setOptions (gsOptionList opt)
 Sets the options. More...
 
virtual void setParameter (const index_t i, const function_ptr &par)
 Sets the material parameters. More...
 
virtual void setParameter (const index_t i, const gsFunctionSet< T > &par)
 Sets the material parameters. More...
 
virtual void setParameters (const std::vector< function_ptr > &pars)
 Sets the material parameters. More...
 
virtual void setParameters (const std::vector< gsFunctionSet< T > * > &pars)
 Sets the material parameters. More...
 
void setPoissonsRatio (const gsFunctionSet< T > &PoissonsRatio) override
 Sets the Poisson's Ratio.
 
virtual void setThickness (const function_ptr &thickness)
 Sets the thickness.
 
virtual void setThickness (const gsFunctionSet< T > &thickness)
 Sets the thickness.
 
void setYoungsModulus (const gsFunctionSet< T > &YoungsModulus) override
 Sets the YoungsModulus.
 
virtual void thickness_into (const index_t patch, const gsMatrix< T > &u, gsMatrix< T > &result) const override
 See gsMaterialMatrixBase for details.
 
virtual void transform_into (const index_t patch, const gsMatrix< T > &u, gsMatrix< T > &result) const
 Constructs a transformation matrix that transforms a quantity (IN VOIGHT NOTATION) in the spectral basis to the (undeformed) convariant basis. More...
 

Protected Member Functions

gsMatrix< T > _E (const T z, enum MaterialOutput out) const
 Computes the strain tensor. More...
 
void _initialize ()
 Initializes the object. More...
 
_Sij (const index_t i, const index_t j, const gsMatrix< T > &z) const
 Computes the linear material matrix entry with indices i j k l. More...
 
 gsMaterialMatrixLinear (const gsFunctionSet< T > *mp, const gsFunctionSet< T > *thickness, const gsFunctionSet< T > &YoungsModulus, const gsFunctionSet< T > &PoissonRatio, const gsFunctionSet< T > *Density)
 Full constructor. More...
 
 gsMaterialMatrixLinear (const gsFunctionSet< T > *mp, const gsFunctionSet< T > *thickness, const std::vector< gsFunctionSet< T > * > &pars, const gsFunctionSet< T > *Density)
 Full constructor. More...
 

Constructor & Destructor Documentation

gsMaterialMatrixLinear ( const gsFunctionSet< T > &  mp,
const gsFunctionSet< T > &  thickness 
)

Constructor without material parameters.

Parameters
[in]mpOriginal geometry
[in]thicknessThickness function
gsMaterialMatrixLinear ( const gsFunctionSet< T > &  mp,
const gsFunctionSet< T > &  thickness,
const gsFunctionSet< T > &  YoungsModulus,
const gsFunctionSet< T > &  PoissonRatio 
)

Constructor without deformed multipatch and density.

Parameters
[in]mpOriginal geometry
[in]thicknessThickness function
[in]YoungsModulusThe youngs modulus
[in]PoissonRatioThe poisson ratio
gsMaterialMatrixLinear ( const gsFunctionSet< T > &  mp,
const gsFunctionSet< T > &  thickness,
const gsFunctionSet< T > &  YoungsModulus,
const gsFunctionSet< T > &  PoissonRatio,
const gsFunctionSet< T > &  Density 
)

Full constructor.

Parameters
[in]mpOriginal geometry
[in]thicknessThickness function
[in]YoungsModulusThe youngs modulus
[in]PoissonRatioThe poisson ratio
[in]DensityThe density
gsMaterialMatrixLinear ( const gsFunctionSet< T > *  mp,
const gsFunctionSet< T > *  thickness,
const gsFunctionSet< T > &  YoungsModulus,
const gsFunctionSet< T > &  PoissonRatio,
const gsFunctionSet< T > *  Density 
)
protected

Full constructor.

Parameters
[in]mpOriginal geometry
[in]thicknessThickness function
[in]YoungsModulusThe youngs modulus
[in]PoissonRatioThe poisson ratio
[in]DensityThe density
gsMaterialMatrixLinear ( const gsFunctionSet< T > &  mp,
const gsFunctionSet< T > &  thickness,
const std::vector< gsFunctionSet< T > * > &  pars 
)

Constructor without density.

Parameters
[in]mpOriginal geometry
[in]thicknessThickness function
[in]parsVector with parameters (E, nu)
gsMaterialMatrixLinear ( const gsFunctionSet< T > &  mp,
const gsFunctionSet< T > &  thickness,
const std::vector< gsFunctionSet< T > * > &  pars,
const gsFunctionSet< T > &  Density 
)

Full constructor.

Parameters
[in]mpOriginal geometry
[in]thicknessThickness function
[in]parsVector with parameters (E, nu)
[in]DensityDensity function
gsMaterialMatrixLinear ( const gsFunctionSet< T > &  thickness,
const std::vector< gsFunctionSet< T > * > &  pars 
)

Constructor without density and multipatch.

Parameters
[in]thicknessThickness function
[in]parsVector with parameters (E, nu)
gsMaterialMatrixLinear ( const gsFunctionSet< T > &  thickness,
const std::vector< gsFunctionSet< T > * > &  pars,
const gsFunctionSet< T > &  Density 
)

Constructor without multipatch.

Parameters
[in]thicknessThickness function
[in]parsVector with parameters (E, nu)
[in]DensityDensity function
gsMaterialMatrixLinear ( const gsFunctionSet< T > *  mp,
const gsFunctionSet< T > *  thickness,
const std::vector< gsFunctionSet< T > * > &  pars,
const gsFunctionSet< T > *  Density 
)
protected

Full constructor.

Parameters
[in]mpOriginal geometry
[in]thicknessThickness function
[in]parsVector with parameters (E, nu)
[in]DensityDensity function

Member Function Documentation

gsMatrix< T > _E ( const T  z,
enum MaterialOutput  out 
) const
protected

Computes the strain tensor.

Parameters
[in]zThrough-thickness coordinate
[in]outOutput specification
Returns
E
void _initialize ( )
protected

Initializes the object.

Initializes options, flags and defines the number of parameters

T _Sij ( const index_t  i,
const index_t  j,
const gsMatrix< T > &  z 
) const
protected

Computes the linear material matrix entry with indices i j k l.

The entry is computed by \( \mathcal{C}^{ijkl} = \frac{2\lambda\mu}{\lambda+2\mu}a^{ij}a^{kl} + \mu (a^{ik}a^{jl} + a^{il}a^{jk})\) where \(\lambda\) and \(\mu\) are the Lamé parameters and \(a^{ij}=\mathbf{a}^i\cdot \mathbf{a}^j$ with \){a}^i \( is the contravariant vector \) i \( @param[in] i,j,k,l Indices @return Cijkl */ T _Cijkl (const index_t i, const index_t j, const index_t k, const index_t l) const; /** @brief Computes the linear force/moment entry with indices \a i \a j at height z Computes the thickness-integrated stress tensor, i.e. the normal force (0th thickness-moment) or the bending moment (1st thickness-moment). Sij is computed as \) {C}^{ijkl} : {E}_{ij} \( where \){E}_{ij} = a_{ij} z b_{ij} \( with \) a_{ij} \( the in-plane metric and \)b_{ij} \( the curvature. According to this definition, MaterialOutput out==VectorN would return the 0th moment, hence the \){ij} \(-part would be relevant and for VectorM the \)b_{ij}$ part is relevant. The term could also be integrated (out==Generalized).

Parameters
[in]i,jIndices
[in]zThrough-thickness coordinate
[in]outOutput specification
Returns
Sij
virtual gsMatrix<T> eval3D_pstressTransform ( const index_t  patch,
const gsMatrix< T > &  u,
const gsMatrix< T > &  z 
) const
inlinevirtualinherited

Provides the transformation of the principle stresses.

Parameters
[in]patchThe patch to be evaluated on
[in]uThe in-plane shell coordinates to be eveluated on
[in]zThe point through-thickness coorinate
Returns
Matrix with the result (deformation tensor) ordered per z coordinate per point [(u1,z1) (u2,z1) .. (un,z1), (u1,z2) .. (un,z2), .., (u1,zm) .. (un,zm)]
virtual gsMatrix<T> eval3D_pstretchTransform ( const index_t  patch,
const gsMatrix< T > &  u,
const gsMatrix< T > &  z 
) const
inlinevirtualinherited

Provides the transformation of the principle stretches.

Parameters
[in]patchThe patch to be evaluated on
[in]uThe in-plane shell coordinates to be eveluated on
[in]zThe point through-thickness coorinate
Returns
Matrix with the result (deformation tensor) ordered per z coordinate per point [(u1,z1) (u2,z1) .. (un,z1), (u1,z2) .. (un,z2), .., (u1,zm) .. (un,zm)]
virtual const function_ptr getParameter ( const index_t  i) const
inlinevirtualinherited

Gets parameter i.

Parameters
[in]iThe parameter index
Returns
The parameter.
virtual gsOptionList& options ( )
inlinevirtualinherited

Returns the options.

Returns
gsOptionList

Reimplemented in gsMaterialMatrixComposite< dim, T >.

virtual void pstress_into ( const index_t  patch,
const gsMatrix< T > &  u,
gsMatrix< T > &  result 
) const
inlinevirtualinherited

Evaluates the priciple stresses in the shell (3x1 vector)

Parameters
[in]patchThe patch to be evaluated on
[in]uThe in-plane shell coordinates to be eveluated on
resultThe result

Reimplemented in gsMaterialMatrixComposite< dim, T >.

virtual void pstressDir_into ( const index_t  patch,
const gsMatrix< T > &  u,
gsMatrix< T > &  result 
) const
inlinevirtualinherited

Evaluates the directions of the priciple stresses in the shell (3x1 vector per direction)

Parameters
[in]patchThe patch to be evaluated on
[in]uThe in-plane shell coordinates to be eveluated on
resultThe result

Reimplemented in gsMaterialMatrixComposite< dim, T >.

virtual void pstretch_into ( const index_t  patch,
const gsMatrix< T > &  u,
gsMatrix< T > &  result 
) const
inlinevirtualinherited

Evaluates the stretches in the shell (3x1 vector)

Parameters
[in]patchThe patch to be evaluated on
[in]uThe in-plane shell coordinates to be eveluated on
resultThe result

Reimplemented in gsMaterialMatrixNonlinear< dim, T, matId, comp, mat, imp >, and gsMaterialMatrixComposite< dim, T >.

virtual void pstretchDir_into ( const index_t  patch,
const gsMatrix< T > &  u,
gsMatrix< T > &  result 
) const
inlinevirtualinherited

Evaluates the directions of the stretches in the shell (3x1 vector per direction)

Parameters
[in]patchThe patch to be evaluated on
[in]uThe in-plane shell coordinates to be eveluated on
resultThe result

Reimplemented in gsMaterialMatrixNonlinear< dim, T, matId, comp, mat, imp >, and gsMaterialMatrixComposite< dim, T >.

virtual void setOptions ( gsOptionList  opt)
inlinevirtualinherited

Sets the options.

Parameters
[in]optgsOptionList

Reimplemented in gsMaterialMatrixComposite< dim, T >.

virtual void setParameter ( const index_t  i,
const function_ptr &  par 
)
inlinevirtualinherited

Sets the material parameters.

Parameters
[in]parsFunction pointers for the parameters in a container
virtual void setParameter ( const index_t  i,
const gsFunctionSet< T > &  par 
)
inlinevirtualinherited

Sets the material parameters.

Parameters
[in]parsFunction pointers for the parameters in a container
virtual void setParameters ( const std::vector< function_ptr > &  pars)
inlinevirtualinherited

Sets the material parameters.

Parameters
[in]parsFunction pointers for the parameters in a container
virtual void setParameters ( const std::vector< gsFunctionSet< T > * > &  pars)
inlinevirtualinherited

Sets the material parameters.

Parameters
[in]parsFunction pointers for the parameters in a container

Reimplemented in gsMaterialMatrixTFT< dim, T, linear >, and gsMaterialMatrixTFT< 2, T >.

virtual void transform_into ( const index_t  patch,
const gsMatrix< T > &  u,
gsMatrix< T > &  result 
) const
inlinevirtualinherited

Constructs a transformation matrix that transforms a quantity (IN VOIGHT NOTATION) in the spectral basis to the (undeformed) convariant basis.

Parameters
[in]patchThe patch to be evaluated on
[in]uThe in-plane shell coordinates to be eveluated on
resultThe result

Reimplemented in gsMaterialMatrixComposite< dim, T >.