sfem::element::IntTypeNodeC3dFunctions Class Reference

... the abstract base class for integration types of finite elements More...

#include <intnode_c3d_functions.hpp>

List of all members.

Public Types

typedef material::TVector3 coor_type
typedef size_t count_type
typedef unsigned int index_type
typedef material::TMatrix3 matrix3x3_type
typedef material::TMatrix matrix_type
typedef double real_type
typedef std::vector
< IntegrationTypeData > 
Type_intpts
typedef unsigned int uint
typedef unsigned short ushort
typedef material::TVector3 vector3_type
typedef material::TVector vector_type

Static Public Member Functions

template<typename SparseMatrixType>
static void assembleMatrix (const mesh::DofHandler &dofs, const material::TSparseMatrix &material_stiffness, const real_type &material_weight, const VectorOf9SparseVectors &defgradCoeffs, SparseMatrixType &stiffness_matrix)
static void assembleMatrix (const mesh::DofHandler &dofs, const material::TSparseMatrix &material_stiffness, const real_type &material_weight, const VectorOf3SparseVectors &defgradCoeffs, material::TScalarWeightedMatrix &stiffness_matrix)
template<typename SparseMatrixType>
static void assembleMatrix (const mesh::DofHandler &dofs, const material::TSparseMatrix &material_stiffness, const real_type &material_weight, const VectorOf3SparseVectors &defgradCoeffs, SparseMatrixType &stiffness_matrix)
static void assembleVector (const mesh::DofHandler &dofs, const material::TVector9 &material_stress, const real_type &material_weight, const VectorOf9SparseVectors &defgradCoeffs, mesh::DofHandler::TVector &resforce_vector)
static void assembleVector (const mesh::DofHandler &dofs, const material::TVector9 &material_stress, const real_type &material_weight, const VectorOf3SparseVectors &defgradCoeffs, material::TScalarWeightedVector &resforce_vector)
static void assembleVector (const mesh::DofHandler &dofs, const material::TVector9 &material_stress, const real_type &material_weight, const VectorOf3SparseVectors &defgradCoeffs, mesh::DofHandler::TVector &resforce_vector)
static void computeDefgradFromCoeffs (const VectorOf3SparseVectors &coeffs, const mesh::DofHandler &dofs, material::TMatrix3 &defgrad)
 computes the deformation gradient from precomputed defgrad coefficients
static void computeDefgradFromCoeffs (const IntegrationNode &intnode, const mesh::DofHandler &dofs, material::TMatrix3 &defgrad)
 computes the deformation gradient from precomputed defgrad coefficients
template<class VectorType>
static void computeEnergyResforce (const mesh::PhysicalIntegrationNode &intnode, const mesh::DofHandler &dofs, material::TVectorEnergy &energy, VectorType &resforce)
static void computeEnergyResforce__vector (const mesh::PhysicalIntegrationNode &intnode, const mesh::DofHandler &dofs, material::TVectorEnergy &energy, mesh::DofHandler::TVector &resforce)
static void computeEnergyResforce_Fbar (const mesh::PhysicalIntegrationNode &intnode, const mesh::DofHandler &dofs, material::TVectorEnergy &energy, mesh::DofHandler::TVector &resforce)
template<class VectorType>
static void computeEnergyResforce_Fbar_simple (const mesh::PhysicalIntegrationNode &intnode, const mesh::DofHandler &dofs, material::TVectorEnergy &energy, VectorType &resforce)
static void computeEnergyResforce_Fbar_simple__vector (const mesh::PhysicalIntegrationNode &intnode, const mesh::DofHandler &dofs, material::TVectorEnergy &energy, mesh::DofHandler::TVector &resforce)
static void computeEnergyResforce_scalarweighted (const mesh::PhysicalIntegrationNode &intnode, const mesh::DofHandler &dofs, material::TVectorEnergy &energy, material::TScalarWeightedVector &resforce)
template<class VectorType>
static void computeEnergyResforceUpdate (mesh::PhysicalIntegrationNode &intnode, const mesh::DofHandler &dofs, material::TVectorEnergy &energy, VectorType &resforce)
static void computeEnergyResforceUpdate__vector (mesh::PhysicalIntegrationNode &intnode, const mesh::DofHandler &dofs, material::TVectorEnergy &energy, mesh::DofHandler::TVector &resforce)
static void computeEnergyResforceUpdate_Fbar (mesh::PhysicalIntegrationNode &intnode, const mesh::DofHandler &dofs, material::TVectorEnergy &energy, mesh::DofHandler::TVector &resforce)
template<class VectorType>
static void computeEnergyResforceUpdate_Fbar_simple (mesh::PhysicalIntegrationNode &intnode, const mesh::DofHandler &dofs, material::TVectorEnergy &energy, VectorType &resforce)
static void computeEnergyResforceUpdate_Fbar_simple__vector (mesh::PhysicalIntegrationNode &intnode, const mesh::DofHandler &dofs, material::TVectorEnergy &energy, mesh::DofHandler::TVector &resforce)
static void computeEnergyResforceUpdate_scalarweighted (mesh::PhysicalIntegrationNode &intnode, const mesh::DofHandler &dofs, material::TVectorEnergy &energy, material::TScalarWeightedVector &resforce)
static void computeLumpedMass (const uint &part_index, const mesh::PhysicalElement &element, const mesh::DofHandler &dofs, mesh::DofHandler::TSparseMatrix_RandomSetter &mass)
static void computeMass (const uint &part_index, const mesh::PhysicalElement &element, const mesh::DofHandler &dofs, mesh::DofHandler::TSparseMatrix_RandomSetter &mass)
template<class StiffnessType>
static void computeStiffness (const mesh::PhysicalIntegrationNode &intnode, const mesh::DofHandler &dofs, StiffnessType &stiffness)
static void computeStiffness__sparsematrix (const mesh::PhysicalIntegrationNode &intnode, const mesh::DofHandler &dofs, mesh::DofHandler::TSparseMatrix_RandomSetter &stiffness)
static void computeStiffness_Fbar (const mesh::PhysicalIntegrationNode &intnode, const mesh::DofHandler &dofs, mesh::DofHandler::TSparseMatrix_RandomSetter &stiffness)
template<class StiffnessType>
static void computeStiffness_Fbar_simple (const mesh::PhysicalIntegrationNode &intnode, const mesh::DofHandler &dofs, StiffnessType &stiffness)
static void computeStiffness_Fbar_simple__sparsematrix (const mesh::PhysicalIntegrationNode &intnode, const mesh::DofHandler &dofs, mesh::DofHandler::TSparseMatrix_RandomSetter &stiffness)
static void computeStiffness_scalarweighted (const mesh::PhysicalIntegrationNode &intnode, const mesh::DofHandler &dofs, material::TScalarWeightedMatrix &stiffness)
static void createSparseVector9from3 (const VectorOf3SparseVectors &defgradCoeffs3, VectorOf9SparseVectors &defgradCoeffs9)
static void evaluateStressInElement (const mesh::PhysicalElement &element, const mesh::DofHandler &dofs, const material::TVector3 &local_coor, material::TMatrix3 &defgrad, material::TVectorEnergy &energy_density, material::TVector9 &stress)
static void fbar_1stvariation_detF (const material::TMatrix3 &F_inv_transposed, const double &det_F, const VectorOf3SparseVectors &defgradCoeffs3, material::TDynamicSparseMatrix &variation_1st)
static void fbar_2ndvariation_detF (const material::TMatrix3 &F_inv_transposed, const double &det_F, const VectorOf3SparseVectors &defgradCoeffs3, const material::TDynamicSparseMatrix &variation_1st, material::TDynamicSparseMatrix &variation_2nd)
static bool fbar_required (const mesh::PhysicalIntegrationNode &intnode, mesh::PhysicalIntegrationPoint::TPairElementIndex &element)
static const ET::matrix_type getLocalCoordinatesOfInnerNodes_c10_bubble ()
static const ET::matrix_type getLocalCoordinatesOfInnerNodes_c27_bubble ()
static const ET::matrix_type getLocalCoordinatesOfInnerNodes_c4_bubble ()
static const ET::matrix_type getLocalCoordinatesOfInnerNodes_c8_bubble ()
static const ET::matrix_type getLocalCoordinatesOfInnerNodes_c8_bubble2 ()
static const ET::matrix_type getLocalCoordinatesOfInnerNodes_noBubble ()
static const ET::matrix_type getLocalCoordinatesOfNodes_10n ()
static const ET::matrix_type getLocalCoordinatesOfNodes_27n ()
static const ET::matrix_type getLocalCoordinatesOfNodes_4n ()
static const ET::matrix_type getLocalCoordinatesOfNodes_8n ()
static const ET::matrix_type getLocalCoordinatesOfNodes_8n_i8 ()
static const ET::matrix_type intptCoordinates_c10_nodalbubble ()
static const ET::matrix_type intptCoordinates_c4_complete ()
static const ET::matrix_type intptCoordinates_c4_edge ()
static const ET::matrix_type intptCoordinates_c4_nodalbubble ()
static const ET::matrix_type intptCoordinates_c8_complete ()
static const ET::matrix_type intptCoordinates_c8_edge ()
static const ET::matrix_type intptCoordinates_c8_nodalbubble ()
static void mat_shape_c10_bubble4 (const coor_type &nat_coor, vector_type &shape)
static void mat_shape_c4_bubble1 (const coor_type &nat_coor, vector_type &shape)
static void mat_shape_c4_complete (const coor_type &nat_coor, vector_type &shape)
static void mat_shape_c4_edge1 (const coor_type &nat_coor, vector_type &shape)
static void mat_shape_c8_bubble8 (const coor_type &nat_coor, vector_type &shape)
static void mat_shape_c8_complete (const coor_type &nat_coor, vector_type &shape)
static void mat_shape_c8_edge1 (const coor_type &nat_coor, vector_type &shape)
static void precomputeElement (mesh::PhysicalElement &element, const uint &part_index, mesh::DofHandler &dofs)
static void precomputeElement_classicalFEM (mesh::PhysicalElement &element, const uint &part_index, mesh::DofHandler &dofs)
static void precomputeElement_exactIntegration (mesh::PhysicalElement &element, const uint &part_index, mesh::DofHandler &dofs)
static void precomputeElement_innerPointsExact (mesh::PhysicalElement &element, const uint &part_index, mesh::DofHandler &dofs)
static void precomputeElement_smoothIntegration (mesh::PhysicalElement &element, const uint &part_index, mesh::DofHandler &dofs)
static void precomputeET (ET &et)
 precomputing integration operators at ET
static void precomputeIntegrationNode (mesh::PhysicalIntegrationNode &intnode)
static void precomputeIntegrationNode (const uint &part_index, const mesh::Point &node, IntegrationNode &intnode, mesh::DofHandler &dofs, mesh::DofHandler::TSparseMatrix_RandomSetter &linear_stiffness)
 precomputing integration operators at IntegrationNode
static void provideStressAtMatNode (const MaterialNode &matnode, const material::TMatrix3 &defgrad, material::TVectorEnergy &energy_density, material::TVector9 &stress)
static double provideVolumeTetrahedra (const mesh::Point &p1, const mesh::Point &p2, const mesh::Point &p3, const mesh::Point &p4)
static void removeZerosFromDefgradCoeffs (VectorOf3SparseVectors &defgradCoeffs)
static void shape_c10 (const coor_type &nat_coor, vector_type &shape)
static void shape_c10_bubble (const coor_type &nat_coor, vector_type &shape)
static void shape_c20 (const coor_type &nat_coor, vector_type &shape)
static void shape_c27 (const coor_type &nat_coor, vector_type &shape)
static void shape_c27_bubble (const coor_type &nat_coor, vector_type &shape)
static void shape_c4 (const coor_type &nat_coor, vector_type &shape)
static void shape_c4_bubble (const coor_type &nat_coor, vector_type &shape)
static void shape_c8 (const coor_type &nat_coor, vector_type &shape)
static void shape_c8_bubble (const coor_type &nat_coor, vector_type &shape)
static void shape_c8_bubble2 (const coor_type &nat_coor, vector_type &shape)
static void shape_c8_i8 (const coor_type &nat_coor, vector_type &shape)
static void shape_der_c10 (const coor_type &nat_coor, matrix_type &shape_der)
static void shape_der_c20 (const coor_type &nat_coor, matrix_type &shape_der)
static void shape_der_c27 (const coor_type &nat_coor, matrix_type &shape_der)
static void shape_der_c4 (const coor_type &nat_coor, matrix_type &shape_der)
static void shape_der_c8 (const coor_type &nat_coor, matrix_type &shape_der)
static void shape_der_c8_bubble (const coor_type &nat_coor, matrix_type &shape_der)
static void updateStateData (mesh::PhysicalIntegrationNode &intnode, const mesh::DofHandler &dofs)
static void updateStateData_Fbar (mesh::PhysicalIntegrationNode &intnode, const mesh::DofHandler &dofs)
static void updateStateData_Fbar_simple (mesh::PhysicalIntegrationNode &intnode, const mesh::DofHandler &dofs)


Detailed Description

... the abstract base class for integration types of finite elements

Member Function Documentation

static bool sfem::element::IntTypeNodeC3dFunctions::fbar_required ( const mesh::PhysicalIntegrationNode &  intnode,
mesh::PhysicalIntegrationPoint::TPairElementIndex &  element 
) [static]

returns true if the intpt must be modified with f-projection also returns the physical_element it belongs to (if true)


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

Generated on Wed Nov 17 17:35:58 2010 for 'sfem_elements_continuum' Module Programming Interface by  doxygen 1.5.6