CBiotSavart | Class to compute the magnetic induction from the current density using the Biot-Savart formula |
CDomain | To store and treat finite element geometric information |
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 |
CElement | To store and treat finite element geometric information |
CElementList | Class to construct a list of elements having some common properties |
►CEqua | Mother abstract class to describe equation |
►CEquation< 3, 3, 2, 2 > | |
►CDG | Enables preliminary operations and utilities for the Discontinuous Galerkin method |
CLaplaceDG2DP1 | To build and solve the linear system for the Poisson problem using the DG P1 2-D triangle element |
►CEquation< NEN_, NEN_, NSN_, NSN_ > | |
►CEqua_LinearPDE< 2, 1 > | |
CLinearPDE1D | Solves a generic linear PDE in 1-D using 2-Node line finite elements |
►CEqua_LinearPDE< 3, 2 > | |
CLinearPDE2D | Solves a generic linear PDE in 2-D using 3-Node triangular finite elements |
CEqua_LinearPDE< 4, 3 > | |
CEqua_LinearPDE< NEN_, NSN_ > | Abstract class for Finite Element classes for lienar PDEs' |
►CEquation< NEN_, NEE_, NSN_, NSE_ > | Abstract class for all equation classes |
►CEqua_Acoustics< 2, 2, 1, 1 > | |
CPres1DL2 | Builds finite element arrays for acoustic propagation in 1-D using 2-Node elements |
►CEqua_Acoustics< 3, 3, 2, 2 > | |
CPres2DT3 | Builds finite element arrays for wave propagation in 2-D using 3-Node elements |
►CEqua_Electromagnetics< 3, 6, 2, 4 > | |
CEC2D1T3 | Eddy current problems in 2-D domains using solenoidal approximation |
CEC2D2T3 | Eddy current problems in 2-D domains using transversal approximation |
CHelmholtzBT3 | Builds finite element arrays for Helmholtz equations in a bounded media using 3-Node triangles |
►CEqua_Fluid< 3, 6, 2, 4 > | |
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 |
►CEqua_Fluid< 4, 12, 3, 9 > | |
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_Fluid< 4, 8, 2, 4 > | |
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 |
►CEqua_Laplace< 2, 2, 1, 1 > | |
CLaplace1DL2 | To build element equation for a 1-D elliptic equation using the 2-Node line element (P1 ) |
►CEqua_Laplace< 3, 3, 1, 1 > | |
CLaplace1DL3 | To build element equation for the 1-D elliptic equation using the 3-Node line (P2 ) |
►CEqua_Laplace< 3, 3, 2, 2 > | |
CLaplace2DT3 | To build element equation for the Laplace equation using the 2-D triangle element (P1 ) |
►CEqua_Laplace< 4, 4, 3, 3 > | |
CLaplace3DT4 | To build element equation for the Laplace equation using the 3-D tetrahedral element (P1 ) |
►CEqua_Laplace< 6, 6, 3, 3 > | |
CLaplace2DT6 | To build element equation for the Laplace equation using the 2-D triangle element (P2 ) |
CEqua_Porous< 2, 2, 1, 1 > | |
►CEqua_Porous< 3, 3, 2, 2 > | |
CWaterPorous2D | To solve water flow equations in porous media (1-D) |
►CEqua_Solid< 2, 12, 1, 6 > | |
CBeam3DL2 | To build element equations for 3-D beam equations using 2-node lines |
►CEqua_Solid< 2, 4, 1, 2 > | |
CBar2DL2 | To build element equations for Planar Elastic Bar element with 2 DOF (Degrees of Freedom) per node |
►CEqua_Solid< 3, 6, 2, 4 > | |
CElas2DT3 | To build element equations for 2-D linearized elasticity using 3-node triangles |
►CEqua_Solid< 4, 12, 3, 9 > | |
CElas3DT4 | To build element equations for 3-D linearized elasticity using 4-node tetrahedra |
►CEqua_Solid< 4, 8, 2, 4 > | |
CElas2DQ4 | To build element equations for 2-D linearized elasticity using 4-node quadrilaterals |
►CEqua_Solid< 8, 24, 4, 12 > | |
CElas3DH8 | To build element equations for 3-D linearized elasticity using 8-node hexahedra |
►CEqua_Therm< 2, 2, 1, 1 > | |
CDC1DL2 | Builds finite element arrays for thermal diffusion and convection in 1-D using 2-Node elements |
►CEqua_Therm< 3, 3, 2, 2 > | |
CDC2DT3 | Builds finite element arrays for thermal diffusion and convection in 2-D domains using 3-Node triangles |
CDC3DAT3 | Builds finite element arrays for thermal diffusion and convection in 3-D domains with axisymmetry using 3-Node triangles |
►CEqua_Therm< 4, 4, 3, 3 > | |
CDC3DT4 | Builds finite element arrays for thermal diffusion and convection in 3-D domains using 4-Node tetrahedra |
►CEqua_Therm< 6, 6, 3, 3 > | |
CDC2DT6 | Builds finite element arrays for thermal diffusion and convection in 2-D domains using 6-Node triangles |
CEqua_Acoustics< NEN_, NEE_, NSN_, NSE_ > | Abstract class for Wave Finite Element classes |
CEqua_Electromagnetics< NEN_, NEE_, NSN_, NSE_ > | Abstract class for Electromagnetics Equation classes |
CEqua_Fluid< NEN_, NEE_, NSN_, NSE_ > | Abstract class for Fluid Dynamics Equation classes |
CEqua_Laplace< NEN_, NEE_, NSN_, NSE_ > | Abstract class for classes about the Laplace equation |
CEqua_Porous< NEN_, NEE_, NSN_, NSE_ > | Abstract class for Porous Media Finite Element classes |
CEqua_Solid< NEN_, NEE_, NSN_, NSE_ > | Abstract class for Solid Mechanics Finite Element classes |
CEqua_Therm< NEN_, NEE_, NSN_, NSE_ > | Abstract class for Heat transfer Finite Element classes |
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 |
CSteklovPoincare2DBE | Solver of the Steklov Poincare problem in 2-D geometries using piecewie constant boundary elemen |
CEstimator | To calculate an a posteriori estimator of the solution |
►CFEShape | Parent class from which inherit all finite element shape classes |
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 |
►Ctriangle | Defines a triangle. The reference element is the rectangle triangle with two unit edges |
CTriang3 | Defines a 3-Node (P1 ) triangle |
CTriang6S | Defines a 6-Node straight triangular finite element using P2 interpolation |
►CFigure | To store and treat a figure (or shape) information |
CBrick | To store and treat a brick (parallelepiped) figure |
CCircle | To store and treat a circular figure |
CEllipse | To store and treat an ellipsoidal figure |
CPolygon | To store and treat a polygonal figure |
CRectangle | To store and treat a rectangular figure |
CSphere | To store and treat a sphere |
CTriangle | To store and treat a triangle |
CFuncApprox | To set function approximation methods |
CGauss | Calculate data for Gauss integration |
CGeoModel | To set geometry modelling |
CGrid | To manipulate structured grids |
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< T_ > | Class to drive an iterative process |
CIter< real_t > | |
CLeastSquare | To compute a least square approximation |
CLinearSolver | Class to solve systems of linear equations by direct or iterative methods |
CLocalMatrix< T_, NR_, NC_ > | Handles small size matrices like element matrices, with a priori known size |
CLocalMatrix< real_t, 2, 2 > | |
CLocalVect< T_, N_ > | Handles small size vectors like element vectors |
CLocalVect< OFELI::Point< real_t >, 3 > | |
CLocalVect< real_t, 3 > | |
CLocalVect< size_t, 2 > | |
CLocalVect< size_t, 3 > | |
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< T_ > | Virtual class to handle matrices for all storage formats |
CBMatrix< T_ > | To handle band matrices |
CDMatrix< T_ > | To handle dense matrices |
CDSMatrix< T_ > | To handle symmetric dense matrices |
CSkMatrix< T_ > | To handle square matrices in skyline storage format |
CSkSMatrix< T_ > | To handle symmetric matrices in skyline storage format |
CSpMatrix< T_ > | To handle matrices in sparse storage format |
CTrMatrix< T_ > | To handle tridiagonal matrices |
►CMatrix< real_t > | |
CBMatrix< real_t > | |
CDMatrix< real_t > | |
CDSMatrix< real_t > | |
CSpMatrix< real_t > | |
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 |
CICPG1D | Class to solve the Inviscid compressible fluid flows (Euler equations) for perfect gas in 1-D |
CLCL1D | Class to solve the linear conservation law (Hyperbolic equation) in 1-D by a MUSCL Finite Volume scheme |
►CMuscl2DT | Class for 2-D hyperbolic solvers with Muscl scheme |
CICPG2DT | Class to solve the Inviscid compressible fluid flows (Euler equations) for perfect gas in 2-D |
CLCL2DT | Class to solve the linear hyperbolic equation in 2-D by a MUSCL Finite Volume scheme on triangles |
►CMuscl3DT | Class for 3-D hyperbolic solvers with Muscl scheme using tetrahedra |
CICPG3DT | Class to solve the Inviscid compressible fluid flows (Euler equations) for perfect gas in 3-D |
CLCL3DT | Class to solve the linear conservation law equation in 3-D by a MUSCL Finite Volume scheme on 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 |
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 |
CPhaseChange | This class enables defining phase change laws for a given material |
CPoint< T_ > | Defines a point with arbitrary type coordinates |
CPoint2D< T_ > | Defines a 2-D point with arbitrary type coordinates |
CPoint< int > | |
CPoint< real_t > | |
CPoint< size_t > | |
CPrec< T_ > | To set a preconditioner |
CPrec< real_t > | |
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 |
CReconstruction | To perform various reconstruction operations |
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 |
CSpaceTime | Defines a space-time point |
CTabulation | To read and manipulate tabulated functions |
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} |
CVect< T_ > | To handle general purpose vectors |
CVect< complex_t > | |
CVect< int > | |
CVect< OFELI::Point< real_t > > | |
CVect< real_t > | |