►NOFELI | A namespace to group all library classes, functions, .. |
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 |
CBiotSavart | Class to compute the magnetic induction from the current density using the Biot-Savart formula |
CBMatrix | To handle band matrices |
CBrick | To store and treat a brick (parallelepiped) figure |
CCircle | To store and treat a circular figure |
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 |
CDG | Enables preliminary operations and utilities for the Discontinuous Galerkin method |
CDMatrix | To handle dense matrices |
CDomain | To store and treat finite element geometric information |
CDSMatrix | To handle symmetric dense matrices |
CEC2D1T3 | Eddy current problems in 2-D domains using solenoidal approximation |
CEC2D2T3 | Eddy current problems in 2-D domains using transversal approximation |
CEdge | To describe an edge |
CEdgeList | Class to construct a list of edges having some common properties |
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 |
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 |
CElement | To store and treat finite element geometric information |
CElementList | Class to construct a list of elements having some common properties |
CEllipse | To store and treat an ellipsoidal figure |
CEqua | Mother abstract class to describe equation |
CEqua_Acoustics | Abstract class for Wave Finite Element classes |
CEqua_Electromagnetics | Abstract class for Electromagnetics Equation classes |
CEqua_Fluid | Abstract class for Fluid Dynamics Equation classes |
CEqua_Laplace | Abstract class for classes about the Laplace equation |
CEqua_LinearPDE | Abstract class for Finite Element classes for lienar PDEs' |
CEqua_Porous | Abstract class for Porous Media Finite Element classes |
CEqua_Solid | Abstract class for Solid Mechanics Finite Element classes |
CEqua_Therm | Abstract class for Heat transfer Finite Element classes |
CEquation | Abstract class for all equation classes |
CEstimator | To calculate an a posteriori estimator of the solution |
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 |
CFEShape | Parent class from which inherit all finite element shape classes |
CFigure | To store and treat a figure (or shape) information |
CFuncApprox | To set function approximation methods |
CGauss | Calculate data for Gauss integration |
CGeoModel | To set geometry modelling |
CGrid | To manipulate structured grids |
CHelmholtzBT3 | Builds finite element arrays for Helmholtz equations in a bounded media using 3-Node triangles |
CHexa8 | Defines a three-dimensional 8-node hexahedral finite element using Q1-isoparametric interpolation |
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 |
CIntegration | Class for numerical integration methods |
CIOField | Enables working with files in the XML Format |
CIPF | To read project parameters from a file in IPF format |
CIter | Class to drive an iterative process |
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 |
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 |
CLeastSquare | To compute a least square approximation |
CLine2 | To describe a 2-Node planar line finite element |
CLine3 | To describe a 3-Node quadratic planar line finite element |
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 |
CLinearSolver | Class to solve systems of linear equations by direct or iterative methods |
CLocalMatrix | Handles small size matrices like element matrices, with a priori known size |
CLocalVect | Handles small size vectors like element vectors |
CLPSolver | To solve a linear programming problem |
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 |
CMatrix | Virtual class to handle matrices for all storage formats |
CMesh | To store and manipulate finite element meshes |
CMeshAdapt | To adapt mesh in function of given solution |
CMuscl | Parent class for hyperbolic solvers with Muscl scheme |
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 |
CMyNLAS | Abstract class to define by user specified function |
CMyODE | Abstract class to define by user specified (system of) ODE |
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 |
CNode | To describe a node |
CNodeList | Class to construct a list of nodes having some common properties |
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 |
CODESolver | To solve a system of ordinary differential equations |
COptSolver | To solve an optimization problem with bound constraints |
CPartition | To partition a finite element mesh into balanced submeshes |
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) |
CPhaseChange | This class enables defining phase change laws for a given material |
CPoint | Defines a point with arbitrary type coordinates |
CPoint2D | Defines a 2-D point with arbitrary type coordinates |
CPolygon | To store and treat a polygonal figure |
CPrec | To set a preconditioner |
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 |
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 |
CQuad4 | Defines a 4-node quadrilateral finite element using Q1 isoparametric interpolation |
CReconstruction | To perform various reconstruction operations |
CRectangle | To store and treat a rectangular figure |
CSide | To store and treat finite element sides (edges in 2-D or faces in 3-D) |
CSideList | Class to construct a list of sides having some common properties |
CSkMatrix | To handle square matrices in skyline storage format |
CSkSMatrix | To handle symmetric matrices in skyline storage format |
CSpaceTime | Defines a space-time point |
CSphere | To store and treat a sphere |
CSpMatrix | To handle matrices in sparse storage format |
CSteklovPoincare2DBE | Solver of the Steklov Poincare problem in 2-D geometries using piecewie constant boundary elemen |
CTabulation | To read and manipulate tabulated functions |
CTetra4 | Defines a three-dimensional 4-node tetrahedral finite element using P1 interpolation |
CTimer | To handle elapsed time counting |
CTimeStepping | To solve time stepping problems, i.e. systems of linear ordinary differential equations of the form [A2]{y"} + [A1]{y'} + [A0]{y} = {b} |
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 |
CTriang3 | Defines a 3-Node (P1 ) triangle |
CTriang6S | Defines a 6-Node straight triangular finite element using P2 interpolation |
Ctriangle | Defines a triangle. The reference element is the rectangle triangle with two unit edges |
CTriangle | To store and treat a triangle |
CTrMatrix | To handle tridiagonal matrices |
CVect | To handle general purpose vectors |
CWaterPorous2D | To solve water flow equations in porous media (1-D) |