acList | |
acNodeList | |
acNodeQueue | |
acNodeStack | |
acNodeTree | |
acQueue | |
acStack | |
acTree | |
Array< Type > | |
atom | |
BoundaryConditions | Class that stores and manages the homogeneuos and non-homogeneous Dirichlet boundary conditions applied on the geometric and finite element entities of the model |
BoundaryData | Class BoundaryData |
BSpline | Class BSpline |
BuiltInArray< Type > | |
BuiltInTable< Type1, Type2 > | |
center_of_mass | |
ckrinfo_t | |
Class | |
cnbr_t | |
collocationPoints | This class is a container class that returns the collocation point coordinates according to the element shape and topological entity |
collocationPoints1D | CollocationPoints1D is a container class. Its aim is to call the apropriates quadrature classes to calculate the coordinates of the 1D collocation points |
collocationPointsAttributes_S | Struct that stores attributes for collocationPoints class |
ctrl_t | |
DamagedMooneyRivlinMaterial | Implements the isotropic quasi-incompressible Mooney-Rivlin material with isotropic damage |
DamagedNeoHookeanMaterial | Implements the isotropic compressible Neo-Hookean material with isotropic damage |
DebInfo | |
DirichletBC | Class that stores the Dirichlet boundary conditions applied to th model |
DiscreteModel | Control 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 |
DOFs | Class to manage the labels and cardinality of dofs of the finite element model |
ElementElementSolver | Class for the elementwise local FE solver |
ElementElementTable | Class thatbuild a table that store for each the element its neighbour elements |
ElementTopologicalIndices | Class that stores the numbers for each element topological entity based on the polynomial order |
Equations | Class for equation numbering |
EtapaInfo | |
FEGroups | Stores 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 |
FiniteElement | Store the main finite element attributes and implement the element operators |
FiniteElementAttributes_S | Struct that stores attributes for the FiniteElement class |
FiniteElementGroup | Set of finite elements with similar features such as geometric properties, shape, interpolation, material and problem type |
GaussJacobiCollocationPoints1D | Calculate 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 |
GaussJacobiQuadrature1D | Calculates the quadrature points and weights using the Gauss-Jacobi, Gauss-Radau-Jacobi and Gauss-Lobato-Jacobi quadratures. This class does not store any data |
GeometricProperties | Class used to storage geometric properties for the group of finite elements or, if necessary, for each element present in a group |
GeometryMesh | This 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_option | The structure that stores the information about the command-line options |
gk_seq_t | |
gk_str_t | |
gk_StringMap_t | |
gk_Tokens_t | |
GlobalSolver | Class for the global FE solver |
GMEntity | This class stores the topological data relating geometry and mesh (e.g. nodes on lines, nodes on surfaces, elements on surfaces) |
GradientMeasure | Class used to compute the strain measures |
graph_t | |
HeatConductionMaterial | Specialization of the Materials abstract class for isotorpic heat conduction materials |
Hermite1D | Class for 1D Hermite polynomialsCalculates 1D Hermite polynomials and first and second order derivatives on the given coordinates@ |
HexaCollocationPoints | Calculates the collocation points coordinates for the hexa element. The coordinates are also calculated for the line ans square elements |
HexaNumericalIntegration | Calculates the coordinates and weights for numerical integration of the hexahedron element |
HexaShapeFunctions | Calculates the shape functions and their derivatives for the hexa element. The edge and face shape functions and their derivatives are also stored |
HighOrder | This 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 |
HookeMaterial | Specialization of the Materials abstract class for isotropic elastic material (Hooke's law) |
imaxdiv_t | |
isparams_t | |
Jacobi1D | Class 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 |
LagrangeJacobi1D | Calculate the 1D Lagrange polynomials and the first derivative using Jacobi polynomials |
LineCollocationPoints | Calculates the collocation points coordinates for the line element |
LineNumericalIntegration | Returns the numerical integration coordinates and weights for a line |
LineShapeFunctions | Calculates the shape functions and their derivatives for line elements |
LoadIntensity | This 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 |
LoadSet | Class to manage each load set in the discrete model |
LoadSets | Class that manages the load sets applied to the discrete model |
Lobatto1D | Class for 1D Lobatto polynomialsCalculates the Lobatto polynomials and their first and second derivatives |
LocalVariablesSize | |
Mapping | |
Material | Base class for the representation of material models |
Matrix | |
Mesh | This 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 | |
MeshTopology | Class that creates and manages all the information related to the mesh topology |
Model | Control 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 |
MooneyRivlinMaterial | Implements the isotropic Mooney-Rivlin material |
NeoHookeanMaterial | Implements the isotropic compressible Neo-Hookean material |
NewtonCotesCollocationPoints1D | Calculate the collocation points using the Newton-Cotes quadrature. This class does not store any data |
NewtonCotesQuadrature1D | Class to evaluate the quadrature points and weights using the Newton Cotes quadrature. This class does not store any data |
Node | |
NodeElementTable | Table that stores the elements that shares each node. Builds the nodal patch table |
NodeEquationTable | Table that store for each node, its neighbours dofs |
NodeNodeTable | Builds a table that store for each node its neighbour nodes |
Nodes | Nodal coordinates of the discrete model |
nrinfo_t | |
NumericalIntegration | This 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_S | Struct that stores attributes for NumericalIntegration class |
NURBSBoundaryEntityInfo | Class NURBSBoundaryEntityInfo |
NURBSLine | Class NURBSLine |
NURBSLineBoundaryEntity | Class NURBSLineBoundaryEntity |
NURBSSurface | Class NURBSSurface |
NURBSSurfaceBoundaryEntity | Class NURBSSurfaceBoundaryEntity |
OgdenMaterial | Implementation of the isotropic Ogden material |
OneIndexTable< Type > | |
Parametric2DPoints | Class Parametric2DPoints |
Parametric3DCurves | Class Parametric3DCurves |
Parametric3DPoints | Class Parametric3DPoints |
ParametricLines | Class ParametricLines |
ParametricSurfaces | Class ParametricSurfaces |
params_t | |
PartitionData | Stores informations about the partition |
pdbf | |
PointerArray< Type > | |
Polynomials1D | Polynomials1D 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 |
Quadrature1D | Quadrature1D 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 | |
ShapeFunctions | It is a container class for line, square, triangle, hexa and tetra shape functions |
ShapeFunctionsAttributes_S | Struct that stores attributes for the ShapeFunctions class |
SINFOOBJ | |
Solver | Generic solver algorithms that store the instance of the Model class and the common variables for all solver types, |
SolverParam_S | Struct that stores attributes for the Solver class |
SOPENDB | |
SquareCollocationPoints | Calculates the collocation points coordinates for the square element. The coordinates are also calculated for the line element |
SquareNumericalIntegration | Calculates the coordinates and weights for numerical integration of the square element |
SquareShapeFunctions | Calculates the shape functions and their derivatives for square element. The edge shape functions and their derivatives are also stored |
SSM_T | |
StandardLagrange1D | Calculate 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 | |
TetraCollocationPoints | Calculates the collocation points coordinates for the tetra element. The coordinates are also calculated for the line and face elements |
TetraNumericalIntegration | Calculates 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 |
TetraShapeFunctions | Calculates the shape functions and their derivatives for tetra element |
TheoreticalSolution_S | Struct that stores attributes for Solver class related to the theorical solution |
TriangleCollocationPoints | Calculates the collocation points coordinates for the triangle element. The coordinates are also calculated for the line element |
TriangleNumericalIntegration | Calculates 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 |
TriangleShapeFunctions | Calculates the shape functions and their derivatives for triangle element |
TruncatedLagrange1D | Class 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 | |
Vector | Class Vector |
vkrinfo_t | |
vnbr_t | |
yy_buffer_state | |
yy_trans_info | |
yyalloc | |