►NOFELI | A namespace to group all library classes, functions, .. |
CEqua_Acoustics | Abstract class for Wave Finite Element classes |
CPres1DL2 | Builds finite element arrays for acoustic propagation in 1-D using 2-Node elements |
CPres2DT3 | Builds finite element arrays for wave propagation in 2-D using 3-Node elements |
CLocalVect | Handles small size vectors like element vectors |
CICPG1D | Class to solve the Inviscid compressible fluid flows (Euler equations) for perfect gas in 1-D |
CICPG2DT | Class to solve the Inviscid compressible fluid flows (Euler equations) for perfect gas in 2-D |
CICPG3DT | Class to solve the Inviscid compressible fluid flows (Euler equations) for perfect gas in 3-D |
CLCL1D | Class to solve the linear conservation law (Hyperbolic equation) in 1-D by a MUSCL Finite Volume scheme |
CLCL2DT | Class to solve the linear hyperbolic equation in 2-D by a MUSCL Finite Volume scheme on triangles |
CLCL3DT | Class to solve the linear conservation law equation in 3-D by a MUSCL Finite Volume scheme on tetrahedra |
CMuscl | Parent class for hyperbolic solvers with Muscl scheme |
CVect | To handle general purpose vectors |
CMuscl1D | Class for 1-D hyperbolic solvers with Muscl scheme |
CMuscl2DT | Class for 2-D hyperbolic solvers with Muscl scheme |
CMuscl3DT | Class for 3-D hyperbolic solvers with Muscl scheme using tetrahedra |
CDG | Enables preliminary operations and utilities for the Discontinous Galerkin method |
CBiotSavart | Class to compute the magnetic induction from the current density using the Biot-Savart formula |
CEC2D1T3 | Eddy current problems in 2-D domains using solenoidal approximation |
CEC2D2T3 | Eddy current problems in 2-D domains using transversal approximation |
CEqua_Electromagnetics | Abstract class for Electromagnetics Equation classes |
CHelmholtzBT3 | Builds finite element arrays for Helmholtz equations in a bounded media using 3-Node triangles |
CEqua | Mother abstract class to describe equation |
CEquation | Abstract class for all equation classes |
CEqua_Fluid | Abstract class for Fluid Dynamics Equation classes |
CNSP2DQ41 | Builds finite element arrays for incompressible Navier-Stokes equations in 2-D domains using Q1/P0 element and a penaly formulation for the incompressibility condition |
CTINS2DT3S | Builds finite element arrays for transient incompressible fluid flow using Navier-Stokes equations in 2-D domains. Numerical approximation uses stabilized 3-node triangle finite elements for velocity and pressure. 2nd-order projection scheme is used for time integration |
CTINS3DT4S | Builds finite element arrays for transient incompressible fluid flow using Navier-Stokes equations in 3-D domains. Numerical approximation uses stabilized 4-node tatrahedral finite elements for velocity and pressure. 2nd-order projection scheme is used for time integration |
CEqua_LinearPDE | Abstract class for Finite Element classes for lienar PDEs' |
CLinearPDE1D | Solves a generic linear PDE in 1-D using 2-Node line finite elements |
CLinearPDE2D | Solves a generic linear PDE in 2-D using 3-Node triangular finite elements |
CFastMarching | Class for the fast marching algorithm on uniform grids |
CFastMarching1DG | Class for the fast marching algorithm on 1-D uniform grids |
CFastMarching2DG | Class for the fast marching algorithm on 2-D uniform grids |
CFastMarching3DG | Class for the fast marching algorithm on 3-D uniform grids |
CEqua_Laplace | Abstract class for classes about the Laplace equation |
CLaplace1DL2 | To build element equation for a 1-D elliptic equation using the 2-Node line element (P1 ) |
CLaplace1DL3 | To build element equation for the 1-D elliptic equation using the 3-Node line (P2 ) |
CLaplace2DT3 | To build element equation for the Laplace equation using the 2-D triangle element (P1 ) |
CLaplace2DT6 | To build element equation for the Laplace equation using the 2-D triangle element (P2 ) |
CLaplace3DT4 | To build element equation for the Laplace equation using the 3-D tetrahedral element (P1 ) |
CLaplaceDG2DP1 | To build and solve the linear system for the Poisson problem using the DG P1 2-D triangle element |
CSteklovPoincare2DBE | Solver of the Steklov Poincare problem in 2-D geometries using piecewie constant boundary elemen |
CEqua_Porous | Abstract class for Porous Media Finite Element classes |
CWaterPorous2D | To solve water flow equations in porous media (1-D) |
CBar2DL2 | To build element equations for Planar Elastic Bar element with 2 DOF (Degrees of Freedom) per node |
CBeam3DL2 | To build element equations for 3-D beam equations using 2-node lines |
CElas2DQ4 | To build element equations for 2-D linearized elasticity using 4-node quadrilaterals |
CElas2DT3 | To build element equations for 2-D linearized elasticity using 3-node triangles |
CElas3DH8 | To build element equations for 3-D linearized elasticity using 8-node hexahedra |
CElas3DT4 | To build element equations for 3-D linearized elasticity using 4-node tetrahedra |
CEqua_Solid | Abstract class for Solid Mechanics Finite Element classes |
CDC1DL2 | Builds finite element arrays for thermal diffusion and convection in 1-D using 2-Node elements |
CDC2DT3 | Builds finite element arrays for thermal diffusion and convection in 2-D domains using 3-Node triangles |
CDC2DT6 | Builds finite element arrays for thermal diffusion and convection in 2-D domains using 6-Node triangles |
CDC3DAT3 | Builds finite element arrays for thermal diffusion and convection in 3-D domains with axisymmetry using 3-Node triangles |
CDC3DT4 | Builds finite element arrays for thermal diffusion and convection in 3-D domains using 4-Node tetrahedra |
CEqua_Therm | Abstract class for Heat transfer Finite Element classes |
CPhaseChange | This class enables defining phase change laws for a given material |
CFunct | A simple class to parse real valued functions |
CIOField | Enables working with files in the XML Format |
CIPF | To read project parameters from a file in IPF format |
CPrescription | To prescribe various types of data by an algebraic expression. Data may consist in boundary conditions, forces, tractions, fluxes, initial condition. All these data types can be defined through an enumerated variable |
CTabulation | To read and manipulate tabulated functions |
CBMatrix | To handle band matrices |
CDMatrix | To handle dense matrices |
CDSMatrix | To handle symmetric dense matrices |
CSkMatrix | To handle square matrices in skyline storage format |
CSkSMatrix | To handle symmetric matrices in skyline storage format |
CSpMatrix | To handle matrices in sparse storage format |
CLocalMatrix | Handles small size matrices like element matrices, with a priori known size |
CMatrix | Virtual class to handle matrices for all storage formats |
CPoint | Defines a point with arbitrary type coordinates |
CPoint2D | Defines a 2-D point with arbitrary type coordinates |
CSpaceTime | Defines a space-time point |
CTrMatrix | To handle tridiagonal matrices |
CDomain | To store and treat finite element geometric information |
CEdge | To describe an edge |
CElement | To store and treat finite element geometric information |
CFigure | To store and treat a figure (or shape) information |
CRectangle | To store and treat a rectangular figure |
CBrick | To store and treat a brick (parallelepiped) figure |
CCircle | To store and treat a circular figure |
CSphere | To store and treat a sphere |
CEllipse | To store and treat an ellipsoidal figure |
CTriangle | To store and treat a triangle |
CPolygon | To store and treat a polygonal figure |
CGrid | To manipulate structured grids |
CMaterial | To treat material data. This class enables reading material data in material data files. It also returns these informations by means of its members |
CMesh | To store and manipulate finite element meshes |
CMeshAdapt | To adapt mesh in function of given solution |
CNodeList | Class to construct a list of nodes having some common properties |
CElementList | Class to construct a list of elements having some common properties |
CSideList | Class to construct a list of sides having some common properties |
CEdgeList | Class to construct a list of edges having some common properties |
CNode | To describe a node |
CPartition | To partition a finite element mesh into balanced submeshes |
CSide | To store and treat finite element sides (edges in 2-D or faces in 3-D) |
CEstimator | To calculate an a posteriori estimator of the solution |
CReconstruction | To perform various reconstruction operations |
CFEShape | Parent class from which inherit all finite element shape classes |
Ctriangle | Defines a triangle. The reference element is the rectangle triangle with two unit edges |
CHexa8 | Defines a three-dimensional 8-node hexahedral finite element using Q1-isoparametric interpolation |
CLine2 | To describe a 2-Node planar line finite element |
CLine3 | To describe a 3-Node quadratic planar line finite element |
CPenta6 | Defines a 6-node pentahedral finite element using P1 interpolation in local coordinates (s.x,s.y) and Q1 isoparametric interpolation in local coordinates (s.x,s.z) and (s.y,s.z) |
CQuad4 | Defines a 4-node quadrilateral finite element using Q1 isoparametric interpolation |
CTetra4 | Defines a three-dimensional 4-node tetrahedral finite element using P1 interpolation |
CTriang3 | Defines a 3-Node (P1 ) triangle |
CTriang6S | Defines a 6-Node straight triangular finite element using P2 interpolation |
CPrec | To set a preconditioner |
CEigenProblemSolver | Class to find eigenvalues and corresponding eigenvectors of a given matrix in a generalized eigenproblem, i.e. Find scalars l and non-null vectors v such that [K]{v} = l[M]{v} where [K] and [M] are symmetric matrices. The eigenproblem can be originated from a PDE. For this, we will refer to the matrices K and M as Stiffness and Mass matrices respectively |
CFuncApprox | To set function approximation methods |
CGeoModel | To set geometry modelling |
CIntegration | Class for numerical integration methods |
CIter | Class to drive an iterative process |
CLeastSquare | To compute a least square approximation |
CLinearSolver | Class to solve systems of linear equations by direct or iterative methods |
CLPSolver | To solve a linear programming problem |
CMyNLAS | Abstract class to define by user specified function |
CMyOpt | Abstract class to define by user specified optimization function |
CNLASSolver | To solve a system of nonlinear algebraic equations of the form f(u) = 0 |
CODESolver | To solve a system of ordinary differential equations |
COptSolver | To solve an optimization problem with bound constraints |
CTimeStepping | To solve time stepping problems, i.e. systems of linear ordinary differential equations of the form [A2]{y"} + [A1]{y'} + [A0]{y} = {b} |
CGauss | Calculate data for Gauss integration |
CTimer | To handle elapsed time counting |