Class Hierarchy
This inheritance list is sorted roughly, but not completely, alphabetically:
[detail level 1234]
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 > | |
►CEquation< NEN_, NEE_, NSN_, NSE_ > | Abstract class for all equation 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 |
▼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 |
CFunct | A simple class to parse real valued functions |
CGauss | Calculate data for Gauss integration |
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 > | |
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 |
►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 |
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 |
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< OFELI::Point< real_t > > | |
CVect< real_t > |