hp2FEM  0.1
Class List
Here are the classes, structs, unions and interfaces with brief descriptions:
acList
acNodeList
acNodeQueue
acNodeStack
acNodeTree
acQueue
acStack
acTree
Array< Type >
atom
BoundaryConditionsClass that stores and manages the homogeneuos and non-homogeneous Dirichlet boundary conditions applied on the geometric and finite element entities of the model
BoundaryDataClass BoundaryData
BSplineClass BSpline
BuiltInArray< Type >
BuiltInTable< Type1, Type2 >
center_of_mass
ckrinfo_t
Class
cnbr_t
collocationPointsThis class is a container class that returns the collocation point coordinates according to the element shape and topological entity
collocationPoints1DCollocationPoints1D is a container class. Its aim is to call the apropriates quadrature classes to calculate the coordinates of the 1D collocation points
collocationPointsAttributes_SStruct that stores attributes for collocationPoints class
ctrl_t
DamagedMooneyRivlinMaterialImplements the isotropic quasi-incompressible Mooney-Rivlin material with isotropic damage
DamagedNeoHookeanMaterialImplements the isotropic compressible Neo-Hookean material with isotropic damage
DebInfo
DirichletBCClass that stores the Dirichlet boundary conditions applied to th model
DiscreteModelControl class that aggregates all the features and ttributes of a discrete model and provides the interfaces for other objects to access the discrete model's components
DOFsClass to manage the labels and cardinality of dofs of the finite element model
ElementElementSolverClass for the elementwise local FE solver
ElementElementTableClass thatbuild a table that store for each the element its neighbour elements
ElementTopologicalIndicesClass that stores the numbers for each element topological entity based on the polynomial order
EquationsClass for equation numbering
EtapaInfo
FEGroupsStores information for the finite element groups for the discrete model. A group collects a set of element with the same element shape, interpolation parameters and dofs
FiniteElementStore the main finite element attributes and implement the element operators
FiniteElementAttributes_SStruct that stores attributes for the FiniteElement class
FiniteElementGroupSet of finite elements with similar features such as geometric properties, shape, interpolation, material and problem type
GaussJacobiCollocationPoints1DCalculate the collocation points using the quadratures of Gauss-Jacobi (Legendre), Gauss-Radau-Jacobi (Legendre) and Gauss-Lobato-Jacobi (Legendre). This class does not store any data
GaussJacobiQuadrature1DCalculates the quadrature points and weights using the Gauss-Jacobi, Gauss-Radau-Jacobi and Gauss-Lobato-Jacobi quadratures. This class does not store any data
GeometricPropertiesClass used to storage geometric properties for the group of finite elements or, if necessary, for each element present in a group
GeometryMeshThis is a class that reads, stores and manages information for the relation between geometric and mesh entities
gk_csr_t
gk_HTable_t
gk_i2cc2i_t
gk_mcore_t
gk_mop_t
gk_optionThe structure that stores the information about the command-line options
gk_seq_t
gk_str_t
gk_StringMap_t
gk_Tokens_t
GlobalSolverClass for the global FE solver
GMEntityThis class stores the topological data relating geometry and mesh (e.g. nodes on lines, nodes on surfaces, elements on surfaces)
GradientMeasureClass used to compute the strain measures
graph_t
HeatConductionMaterialSpecialization of the Materials abstract class for isotorpic heat conduction materials
Hermite1DClass for 1D Hermite polynomialsCalculates 1D Hermite polynomials and first and second order derivatives on the given coordinates@
HexaCollocationPointsCalculates the collocation points coordinates for the hexa element. The coordinates are also calculated for the line ans square elements
HexaNumericalIntegrationCalculates the coordinates and weights for numerical integration of the hexahedron element
HexaShapeFunctionsCalculates the shape functions and their derivatives for the hexa element. The edge and face shape functions and their derivatives are also stored
HighOrderThis class manages the nodes (or modes) when the problem uses high order FE. There are specialized methods according to the problem dimension and to the topological entity. When needed those methods generates nodes and update the incidence for the whole mesh
HookeMaterialSpecialization of the Materials abstract class for isotropic elastic material (Hooke's law)
imaxdiv_t
isparams_t
Jacobi1DClass for 1D Jacobi polynomials. Calculates 1D Jacobi polynomials with weights Alpha and Beta and first and second order derivatives on the given coordinates. This class does not store any data
LagrangeJacobi1DCalculate the 1D Lagrange polynomials and the first derivative using Jacobi polynomials
LineCollocationPointsCalculates the collocation points coordinates for the line element
LineNumericalIntegrationReturns the numerical integration coordinates and weights for a line
LineShapeFunctionsCalculates the shape functions and their derivatives for line elements
LoadIntensityThis class stores and manages the parameters related to loads or boundary conditions applied to geometric entities (volume, surfaces, lines and keypoints) and finite element entities (element, faces, edges, nodes). The class variables are public to make simpler the access to the stored data. In the documentation of the class, both loads and boundary conditions are referred as loads
LoadSetClass to manage each load set in the discrete model
LoadSetsClass that manages the load sets applied to the discrete model
Lobatto1DClass for 1D Lobatto polynomialsCalculates the Lobatto polynomials and their first and second derivatives
LocalVariablesSize
Mapping
MaterialBase class for the representation of material models
Matrix
MeshThis class store the information for the elements including shape, mesh type, element order distribution, maximum element order, element order/incidence/nodal coordinates/dof numbering for each element and the local topological indices. The main purpose of this class is to collect all mesh data used during the generation of high-order nodes, solution and post-processing
mesh_t
MeshTopologyClass that creates and manages all the information related to the mesh topology
ModelControl class that aggregates all the features and ttributes of a discrete model and provides the interfaces for other objects to access the discrete model's components
MooneyRivlinMaterialImplements the isotropic Mooney-Rivlin material
NeoHookeanMaterialImplements the isotropic compressible Neo-Hookean material
NewtonCotesCollocationPoints1DCalculate the collocation points using the Newton-Cotes quadrature. This class does not store any data
NewtonCotesQuadrature1DClass to evaluate the quadrature points and weights using the Newton Cotes quadrature. This class does not store any data
Node
NodeElementTableTable that stores the elements that shares each node. Builds the nodal patch table
NodeEquationTableTable that store for each node, its neighbours dofs
NodeNodeTableBuilds a table that store for each node its neighbour nodes
NodesNodal coordinates of the discrete model
nrinfo_t
NumericalIntegrationThis container class returns the weights and coordinates for numerical integration of line, square, hexahedron and tetrahedron finite elements. The maximum integrand order is calculated by the multiplication of the maximum polynomial order Pmax and the integrand order factor IOFactor. Integration points are calculated for integrand orders obtained by [1,IOFactor] * Pmax
NumericalIntegrationAttributes_SStruct that stores attributes for NumericalIntegration class
NURBSBoundaryEntityInfoClass NURBSBoundaryEntityInfo
NURBSLineClass NURBSLine
NURBSLineBoundaryEntityClass NURBSLineBoundaryEntity
NURBSSurfaceClass NURBSSurface
NURBSSurfaceBoundaryEntityClass NURBSSurfaceBoundaryEntity
OgdenMaterialImplementation of the isotropic Ogden material
OneIndexTable< Type >
Parametric2DPointsClass Parametric2DPoints
Parametric3DCurvesClass Parametric3DCurves
Parametric3DPointsClass Parametric3DPoints
ParametricLinesClass ParametricLines
ParametricSurfacesClass ParametricSurfaces
params_t
PartitionDataStores informations about the partition
pdbf
PointerArray< Type >
Polynomials1DPolynomials1D is a container class. Its aim is to call the apropriate 1D polynomials class according to the given polynomial type. The following polynomial bases are implemented: Lagrange, Truncated Lagrange and Jacobi. Only one object of the available 1D polynomial basis is created for each instance of this class
Quadrature1DQuadrature1D is a container class. Its aim is to call the apropriate quadrature class to calculate the coordinates and weights of te quadrature points. The Gauss-Jacobi and Newton-Cotes quadratures are implemented. This class does not store any data
re_pattern_buffer
re_registers
regmatch_t
SDBINFO
sErro
ShapeFunctionsIt is a container class for line, square, triangle, hexa and tetra shape functions
ShapeFunctionsAttributes_SStruct that stores attributes for the ShapeFunctions class
SINFOOBJ
SolverGeneric solver algorithms that store the instance of the Model class and the common variables for all solver types,
SolverParam_SStruct that stores attributes for the Solver class
SOPENDB
SquareCollocationPointsCalculates the collocation points coordinates for the square element. The coordinates are also calculated for the line element
SquareNumericalIntegrationCalculates the coordinates and weights for numerical integration of the square element
SquareShapeFunctionsCalculates the shape functions and their derivatives for square element. The edge shape functions and their derivatives are also stored
SSM_T
StandardLagrange1DCalculate the 1D standard Lagrange polynomials and their first and second derivatives for the given Coordinates. The polynomials are constructed using the CollocationCoordinates. This class does not store any data
SymmetricMatrix
SymmetricSparse
TetraCollocationPointsCalculates the collocation points coordinates for the tetra element. The coordinates are also calculated for the line and face elements
TetraNumericalIntegrationCalculates the coordinates and weights for numerical integration of the tetrahedra element. The coordinates are those ones mapped from the hexahedron element to the baricentric coordinates of the tetrahedron
TetraShapeFunctionsCalculates the shape functions and their derivatives for tetra element
TheoreticalSolution_SStruct that stores attributes for Solver class related to the theorical solution
TriangleCollocationPointsCalculates the collocation points coordinates for the triangle element. The coordinates are also calculated for the line element
TriangleNumericalIntegrationCalculates the coordinates and weights for numerical integration of the triangle element. The coordinates are those ones mapped from the square element to the baricentric coordinates of the triangle
TriangleShapeFunctionsCalculates the shape functions and their derivatives for triangle element
TruncatedLagrange1DClass used to evaluate the 1D Truncated Lagrange polynomials and first ans second derivatives for the given CollocationCoordinates. This class does not store any data
TwoIndexTable< Type >
uvw_t
VectorClass Vector
vkrinfo_t
vnbr_t
yy_buffer_state
yy_trans_info
yyalloc
 All Classes Files Functions Variables Typedefs Friends Defines