|
class | SkMatrix |
| To handle square matrices in skyline storage format. More...
|
|
class | SkSMatrix |
| To handle symmetric matrices in skyline storage format. More...
|
|
class | SpMatrix |
| To handle matrices in sparse storage format. More...
|
|
class | AbsEqua |
| Mother abstract class to describe equation. More...
|
|
class | LocalVect |
| Handles small size vectors like element vectors. More...
|
|
class | ICPG1D |
| Class to solve the Inviscid compressible fluid flows (Euler equations) for perfect gas in 1-D. More...
|
|
class | ICPG2DT |
| Class to solve the Inviscid compressible fluid flows (Euler equations) for perfect gas in 2-D. More...
|
|
class | ICPG3DT |
| Class to solve the Inviscid compressible fluid flows (Euler equations) for perfect gas in 3-D. More...
|
|
class | LCL1D |
| Class to solve the linear conservation law (Hyperbolic equation) in 1-D by a MUSCL Finite Volume scheme. More...
|
|
class | LCL2DT |
| Class to solve the linear hyperbolic equation in 2-D by a MUSCL Finite Volume scheme on triangles. More...
|
|
class | LCL3DT |
| Class to solve the linear conservation law equation in 3-D by a MUSCL Finite Volume scheme on tetrahedra. More...
|
|
class | Muscl |
| Parent class for hyperbolic solvers with Muscl scheme. More...
|
|
class | Vect |
| To handle general purpose vectors. More...
|
|
class | Muscl1D |
| Class for 1-D hyperbolic solvers with Muscl scheme. More...
|
|
class | Muscl2DT |
| Class for 2-D hyperbolic solvers with Muscl scheme. More...
|
|
class | Muscl3DT |
| Class for 3-D hyperbolic solvers with Muscl scheme using tetrahedra. More...
|
|
class | BiotSavart |
| Class to compute the magnetic induction from the current density using the Biot-Savart formula. More...
|
|
class | EC2D1T3 |
| Eddy current problems in 2-D domains using solenoidal approximation. More...
|
|
class | Equa_Electromagnetics |
| Abstract class for Electromagnetics Equation classes. More...
|
|
class | HelmholtzBT3 |
| Builds finite element arrays for Helmholtz equations in a bounded media using 3-Node triangles. More...
|
|
class | Equation |
| Abstract class for all equation classes. More...
|
|
class | Equa_Fluid |
| Abstract class for Fluid Dynamics Equation classes. More...
|
|
class | NSP2DQ41 |
| 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. More...
|
|
class | TINS2DT3B |
| Builds finite element arrays for thermal diffusion and convection in 2-D domains using 3-Node triangles. More...
|
|
class | FastMarching2D |
| To run a Fast Marching Method on 2-D structured uniform grids. More...
|
|
class | FMM2D |
| class for the fast marching 2-D algorithm More...
|
|
class | FMM3D |
| class for the 3-D fast marching algorithm More...
|
|
class | FMMSolver |
| The Fast Marching Method solver. More...
|
|
class | Equa_Laplace |
| Abstract class for classes about the Laplace equation. More...
|
|
class | Laplace1DL2 |
| To build element equation for a 1-D elliptic equation using the 2-Node line element (P1 ). More...
|
|
class | Laplace1DL3 |
| To build element equation for the 1-D elliptic equation using the 3-Node line (P2 ). More...
|
|
class | Laplace2DFVT |
| To build and solve the Laplace equation using a standard Finite Volume method. More...
|
|
class | Laplace2DMHRT0 |
| To build element equation for the 2-D elliptic equation using the Mixed Hybrid finite element at lowest degree (Raviart-Thomas RT0 ). More...
|
|
class | Laplace2DT3 |
| To build element equation for the Laplace equation using the 2-D triangle element (P1 ). More...
|
|
class | SteklovPoincare2DBE |
| Solver of the Steklov Poincare problem in 2-D geometries using piecewie constant boundary elemen. More...
|
|
class | Bar2DL2 |
| To build element equations for Planar Elastic Bar element with 2 DOF (Degrees of Freedom) per node. More...
|
|
class | Beam3DL2 |
| To build element equations for 3-D beam equations using 2-node lines. More...
|
|
class | Elas2DQ4 |
| To build element equations for 2-D linearized elasticity using 4-node quadrilaterals. More...
|
|
class | Elas2DT3 |
| To build element equations for 2-D linearized elasticity using 3-node triangles. More...
|
|
class | Elas3DH8 |
| To build element equations for 3-D linearized elasticity using 8-node hexahedra. More...
|
|
class | Elas3DT4 |
| To build element equations for 3-D linearized elasticity using 4-node tetrahedra. More...
|
|
class | Equa_Solid |
| Abstract class for Solid Mechanics Finite Element classes. More...
|
|
class | DC1DL2 |
| Builds finite element arrays for thermal diffusion and convection in 1-D using 2-Node elements. More...
|
|
class | DC2DT3 |
| Builds finite element arrays for thermal diffusion and convection in 2-D domains using 3-Node triangles. More...
|
|
class | DC2DT6 |
| Builds finite element arrays for thermal diffusion and convection in 2-D domains using 6-Node triangles. More...
|
|
class | DC3DAT3 |
| Builds finite element arrays for thermal diffusion and convection in 3-D domains with axisymmetry using 3-Node triangles. More...
|
|
class | DC3DT4 |
| Builds finite element arrays for thermal diffusion and convection in 3-D domains using 4-Node tetrahedra. More...
|
|
class | Equa_Therm |
| Abstract class for Heat transfer Finite Element classes. More...
|
|
class | PhaseChange |
| This class enables defining phase change laws for a given material. More...
|
|
class | Funct |
| A simple class to parse real valued functions. More...
|
|
class | IOField |
| Enables working with files in the XML Format. More...
|
|
class | IPF |
| To read project parameters from a file in IPF format. More...
|
|
class | Prescription |
| 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. More...
|
|
class | Tabulation |
| To read and manipulate tabulated functions. More...
|
|
class | UserData |
| Abstract class to define by user various problem data. More...
|
|
class | BMatrix |
| To handle band matrices. More...
|
|
class | DMatrix |
| To handle dense matrices. More...
|
|
class | DSMatrix |
| To handle symmetric dense matrices. More...
|
|
class | LocalMatrix |
| Handles small size matrices like element matrices, with a priori known size. More...
|
|
class | Matrix |
| Virtual class to handle matrices for all storage formats. More...
|
|
class | Point |
| Defines a point with arbitrary type coordinates. More...
|
|
class | Point2D |
| Defines a 2-D point with arbitrary type coordinates. More...
|
|
class | Prec |
| To set a preconditioner. More...
|
|
class | TrMatrix |
| To handle tridiagonal matrices. More...
|
|
class | Domain |
| To store and treat finite element geometric information. More...
|
|
class | Edge |
| To describe an edge. More...
|
|
class | Element |
| To store and treat finite element geometric information. More...
|
|
class | Figure |
| To store and treat a figure (or shape) information. More...
|
|
class | Rectangle |
| To store and treat a rectangular figure. More...
|
|
class | Brick |
| To store and treat a brick (parallelepiped) figure. More...
|
|
class | Circle |
| To store and treat a circular figure. More...
|
|
class | Sphere |
| To store and treat a sphere. More...
|
|
class | Ellipse |
| To store and treat an ellipsoidal figure. More...
|
|
class | Triangle |
| To store and treat a triangle. More...
|
|
class | Polygon |
| To store and treat a polygonal figure. More...
|
|
class | Grid |
| To manipulate structured grids. More...
|
|
class | Material |
| To treat material data. This class enables reading material data in material data files. It also returns these informations by means of its members. More...
|
|
class | Mesh |
| To store and manipulate finite element meshes. More...
|
|
class | MeshAdapt |
| To adapt mesh in function of given solution. More...
|
|
class | NodeList |
| Class to construct a list of nodes having some common properties. More...
|
|
class | ElementList |
| Class to construct a list of elements having some common properties. More...
|
|
class | SideList |
| Class to construct a list of sides having some common properties. More...
|
|
class | EdgeList |
| Class to construct a list of edges having some common properties. More...
|
|
class | Node |
| To describe a node. More...
|
|
class | Partition |
| To partition a finite element mesh into balanced submeshes. More...
|
|
class | Side |
| To store and treat finite element sides (edges in 2-D or faces in 3-D) More...
|
|
class | Estimator |
| To calculate an a posteriori estimator of the solution. More...
|
|
class | Reconstruction |
| To perform various reconstruction operations. More...
|
|
class | FEShape |
| Parent class from which inherit all finite element shape classes. More...
|
|
class | triangle |
| Defines a triangle. The reference element is the rectangle triangle with two unit edges. More...
|
|
class | Hexa8 |
| Defines a three-dimensional 8-node hexahedral finite element using Q1-isoparametric interpolation. More...
|
|
class | Line2 |
| To describe a 2-Node planar line finite element. More...
|
|
class | Line2H |
| To describe a 2-Node Hermite planar line finite element. More...
|
|
class | Line3 |
| To describe a 3-Node quadratic planar line finite element. More...
|
|
class | Penta6 |
| 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) . More...
|
|
class | Quad4 |
| Defines a 4-node quadrilateral finite element using Q1 isoparametric interpolation. More...
|
|
class | Tetra4 |
| Defines a three-dimensional 4-node tetrahedral finite element using P1 interpolation. More...
|
|
class | Triang3 |
| Defines a 3-Node (P1 ) triangle. More...
|
|
class | Triang6S |
| Defines a 6-Node straight triangular finite element using P2 interpolation. More...
|
|
class | Eigen |
| Class to find the smallest eigenvalues and corresponding eigenvectors in a generalized eigenproblem using the Bathe subspace iteration method. More...
|
|
class | Iter |
| Class to drive an iterative process. More...
|
|
class | Precond |
| An abstract class from which derive all preconditioning classes. More...
|
|
class | Gauss |
| Calculate data for Gauss integration. More...
|
|
class | Timer |
| To handle elapsed time counting. More...
|
|
|
ostream & | operator<< (ostream &s, const Muscl3DT &m) |
| Output mesh data as calculated in class Muscl3DT.
|
|
T_ * | A () |
| Return element matrix. More...
|
|
T_ * | b () |
| Return element right-hand side. More...
|
|
T_ * | Prev () |
| Return element previous vector. More...
|
|
ostream & | operator<< (ostream &s, const std::complex< double > &x) |
| Output a complex number.
|
|
ostream & | operator<< (ostream &s, const std::string &c) |
| Output a string.
|
|
template<class T_ > |
ostream & | operator<< (ostream &s, const vector< T_ > &v) |
| Output a vector instance.
|
|
template<class T_ > |
ostream & | operator<< (ostream &s, const std::pair< T_, T_ > &a) |
| Output a pair instance.
|
|
void | saveField (Vect< real_t > &v, string output_file, int opt) |
| Save a vector to an output file in a given file format. More...
|
|
void | saveField (Vect< real_t > &v, const Grid &g, string output_file, int opt) |
| Save a vector to an output file in a given file format, for a structured grid data. More...
|
|
void | saveGnuplot (string input_file, string output_file, string mesh_file) |
| Save a vector to an input Gnuplot file. More...
|
|
void | saveTecplot (string input_file, string output_file, string mesh_file) |
| Save a vector to an output file to an input Tecplot file. More...
|
|
void | saveVTK (string input_file, string output_file, string mesh_file) |
| Save a vector to an output VTK file. More...
|
|
void | saveGmsh (string input_file, string output_file, string mesh_file) |
| Save a vector to an output Gmsh file. More...
|
|
ostream & | operator<< (ostream &s, const Tabulation &t) |
| Output Tabulated function data.
|
|
template<class T_ , size_t N_, class E_ > |
void | element_assembly (const E_ &e, const LocalVect< T_, N_ > &be, Vect< T_ > &b) |
| Assemble local vector into global vector. More...
|
|
template<class T_ , size_t N_, class E_ > |
void | element_assembly (const E_ &e, const LocalMatrix< T_, N_, N_ > &ae, Vect< T_ > &b) |
| Assemble diagonal local vector into global vector. More...
|
|
template<class T_ , size_t N_, class E_ > |
void | element_assembly (const E_ &e, const LocalMatrix< T_, N_, N_ > &ae, Matrix< T_ > *A) |
| Assemble local matrix into global matrix. More...
|
|
template<class T_ , size_t N_, class E_ > |
void | element_assembly (const E_ &e, const LocalMatrix< T_, N_, N_ > &ae, SkMatrix< T_ > &A) |
| Assemble local matrix into global skyline matrix. More...
|
|
template<class T_ , size_t N_, class E_ > |
void | element_assembly (const E_ &e, const LocalMatrix< T_, N_, N_ > &ae, SkSMatrix< T_ > &A) |
| Assemble local matrix into global symmetric skyline matrix. More...
|
|
template<class T_ , size_t N_, class E_ > |
void | element_assembly (const E_ &e, const LocalMatrix< T_, N_, N_ > &ae, SpMatrix< T_ > &A) |
| Assemble local matrix into global sparse matrix. More...
|
|
template<class T_ , size_t N_> |
void | side_assembly (const Element &e, const LocalMatrix< T_, N_, N_ > &ae, SpMatrix< T_ > &A) |
| Side assembly of local matrix into global matrix (as instance of class SpMatrix). More...
|
|
template<class T_ , size_t N_> |
void | side_assembly (const Element &e, const LocalMatrix< T_, N_, N_ > &ae, SkSMatrix< T_ > &A) |
| Side assembly of local matrix into global matrix (as instance of class SkSMatrix). More...
|
|
template<class T_ , size_t N_> |
void | side_assembly (const Element &e, const LocalMatrix< T_, N_, N_ > &ae, SkMatrix< T_ > &A) |
| Side assembly of local matrix into global matrix (as instance of class SkMatrix). More...
|
|
template<class T_ , size_t N_> |
void | side_assembly (const Element &e, const LocalVect< T_, N_ > &be, Vect< T_ > &b) |
| Side assembly of local vector into global vector. More...
|
|
template<class T_ > |
BMatrix< T_ > | operator* (T_ a, const BMatrix< T_ > &A) |
| Operator * (Premultiplication of matrix by constant) More...
|
|
template<class T_ > |
ostream & | operator<< (ostream &s, const BMatrix< T_ > &a) |
| Output matrix in output stream.
|
|
template<class T_ > |
ostream & | operator<< (ostream &s, const DMatrix< T_ > &a) |
| Output matrix in output stream.
|
|
template<class T_ > |
ostream & | operator<< (ostream &s, const DSMatrix< T_ > &a) |
| Output matrix in output stream.
|
|
template<class T_ , size_t NR_, size_t NC_> |
LocalMatrix< T_, NR_, NC_ > | operator* (T_ a, const LocalMatrix< T_, NR_, NC_ > &x) |
| Operator * (Multiply matrix x by scalar a ) More...
|
|
template<class T_ , size_t NR_, size_t NC_> |
LocalMatrix< T_, NR_, NC_ > | operator/ (T_ a, const LocalMatrix< T_, NR_, NC_ > &x) |
| Operator / (Divide matrix x by scalar a ) More...
|
|
template<class T_ , size_t NR_, size_t NC_> |
LocalMatrix< T_, NR_, NC_ > | operator+ (const LocalMatrix< T_, NR_, NC_ > &x, const LocalMatrix< T_, NR_, NC_ > &y) |
| Operator + (Add matrix x to y) More...
|
|
template<class T_ , size_t NR_, size_t NC_> |
LocalMatrix< T_, NR_, NC_ > | operator- (const LocalMatrix< T_, NR_, NC_ > &x, const LocalMatrix< T_, NR_, NC_ > &y) |
| Operator - (Subtract matrix y from x) More...
|
|
template<class T_ , size_t NR_, size_t NC_> |
ostream & | operator<< (ostream &s, const LocalMatrix< T_, NR_, NC_ > &a) |
| Output vector in output stream.
|
|
template<class T_ , size_t N_> |
LocalVect< T_, N_ > | operator+ (const LocalVect< T_, N_ > &x, const LocalVect< T_, N_ > &y) |
| Operator + (Add two vectors) More...
|
|
template<class T_ , size_t N_> |
LocalVect< T_, N_ > | operator- (const LocalVect< T_, N_ > &x, const LocalVect< T_, N_ > &y) |
| Operator - (Subtract two vectors) More...
|
|
template<class T_ , size_t N_> |
LocalVect< T_, N_ > | operator* (T_ a, const LocalVect< T_, N_ > &x) |
| Operator * (Premultiplication of vector by constant) More...
|
|
template<class T_ , size_t N_> |
LocalVect< T_, N_ > | operator/ (T_ a, const LocalVect< T_, N_ > &x) |
| Operator / (Division of vector by constant) More...
|
|
template<class T_ , size_t N_> |
double | Dot (const LocalVect< T_, N_ > &a, const LocalVect< T_, N_ > &b) |
| Calculate dot product of 2 vectors (instances of class LocalVect) More...
|
|
template<class T_ , size_t N_> |
void | Scale (T_ a, const LocalVect< T_, N_ > &x, LocalVect< T_, N_ > &y) |
| Multiply vector x by constant a and store result in y .
|
|
template<class T_ , size_t N_> |
void | Scale (T_ a, LocalVect< T_, N_ > &x) |
| Multiply vector x by constant a and store result in x .
|
|
template<class T_ , size_t N_> |
void | Axpy (T_ a, const LocalVect< T_, N_ > &x, LocalVect< T_, N_ > &y) |
| Add a*x to vector y .
|
|
template<class T_ , size_t N_> |
void | Copy (const LocalVect< T_, N_ > &x, LocalVect< T_, N_ > &y) |
| Copy vector x into vector y.
|
|
template<class T_ , size_t N_> |
ostream & | operator<< (ostream &s, const LocalVect< T_, N_ > &v) |
| Output vector in output stream.
|
|
template<class T_ > |
bool | operator== (const Point< T_ > &a, const Point< T_ > &b) |
| Operator == More...
|
|
template<class T_ > |
Point< T_ > | operator+ (const Point< T_ > &a, const Point< T_ > &b) |
| Operator + More...
|
|
template<class T_ > |
Point< T_ > | operator+ (const Point< T_ > &a, const T_ &x) |
| Operator + More...
|
|
template<class T_ > |
Point< T_ > | operator- (const Point< T_ > &a) |
| Unary Operator - More...
|
|
template<class T_ > |
Point< T_ > | operator- (const Point< T_ > &a, const Point< T_ > &b) |
| Operator - More...
|
|
template<class T_ > |
Point< T_ > | operator- (const Point< T_ > &a, const T_ &x) |
| Operator - More...
|
|
template<class T_ > |
Point< T_ > | operator* (const T_ &a, const Point< T_ > &b) |
| Operator * More...
|
|
template<class T_ > |
Point< T_ > | operator* (const int &a, const Point< T_ > &b) |
| Operator *. More...
|
|
template<class T_ > |
Point< T_ > | operator* (const Point< T_ > &b, const T_ &a) |
| Operator / More...
|
|
template<class T_ > |
Point< T_ > | operator* (const Point< T_ > &b, const int &a) |
| Operator * More...
|
|
template<class T_ > |
T_ | operator* (const Point< T_ > &a, const Point< T_ > &b) |
| Operator * More...
|
|
template<class T_ > |
Point< T_ > | operator/ (const Point< T_ > &b, const T_ &a) |
| Operator / More...
|
|
Point< double > | CrossProduct (const Point< double > &lp, const Point< double > &rp) |
| Return Cross product of two vectors lp and rp
|
|
bool | areClose (const Point< double > &a, const Point< double > &b, double toler=OFELI_TOLERANCE) |
| Return true if both instances of class Point<double> are distant with less then toler
|
|
double | SqrDistance (const Point< double > &a, const Point< double > &b) |
| Return squared euclidean distance between points a and b
|
|
double | Distance (const Point< double > &a, const Point< double > &b) |
| Return euclidean distance between points a and b
|
|
template<class T_ > |
std::ostream & | operator<< (std::ostream &s, const Point< T_ > &a) |
| Output point coordinates.
|
|
template<class T_ > |
bool | operator== (const Point2D< T_ > &a, const Point2D< T_ > &b) |
| Operator ==. More...
|
|
template<class T_ > |
Point2D< T_ > | operator+ (const Point2D< T_ > &a, const Point2D< T_ > &b) |
| Operator +. More...
|
|
template<class T_ > |
Point2D< T_ > | operator+ (const Point2D< T_ > &a, const T_ &x) |
| Operator +. More...
|
|
template<class T_ > |
Point2D< T_ > | operator- (const Point2D< T_ > &a) |
| Unary Operator - More...
|
|
template<class T_ > |
Point2D< T_ > | operator- (const Point2D< T_ > &a, const Point2D< T_ > &b) |
| Operator - More...
|
|
template<class T_ > |
Point2D< T_ > | operator- (const Point2D< T_ > &a, const T_ &x) |
| Operator - More...
|
|
template<class T_ > |
Point2D< T_ > | operator* (const T_ &a, const Point2D< T_ > &b) |
| Operator *. More...
|
|
template<class T_ > |
Point2D< T_ > | operator* (const int &a, const Point2D< T_ > &b) |
|
template<class T_ > |
Point2D< T_ > | operator* (const Point2D< T_ > &b, const T_ &a) |
| Operator / More...
|
|
template<class T_ > |
Point2D< T_ > | operator* (const Point2D< T_ > &b, const int &a) |
| Operator * More...
|
|
template<class T_ > |
T_ | operator* (const Point2D< T_ > &b, const Point2D< T_ > &a) |
| Operator *. More...
|
|
template<class T_ > |
Point2D< T_ > | operator/ (const Point2D< T_ > &b, const T_ &a) |
| Operator / More...
|
|
bool | areClose (const Point2D< real_t > &a, const Point2D< real_t > &b, real_t toler=OFELI_TOLERANCE) |
| Return true if both instances of class Point2D<real_t> are distant with less then toler [Default: OFELI_EPSMCH ].
|
|
real_t | SqrDistance (const Point2D< real_t > &a, const Point2D< real_t > &b) |
| Return squared euclidean distance between points a and b
|
|
real_t | Distance (const Point2D< real_t > &a, const Point2D< real_t > &b) |
| Return euclidean distance between points a and b
|
|
template<class T_ > |
std::ostream & | operator<< (std::ostream &s, const Point2D< T_ > &a) |
| Output point coordinates.
|
|
template<class T_ > |
ostream & | operator<< (ostream &s, const SkMatrix< T_ > &a) |
| Output matrix in output stream.
|
|
template<class T_ > |
ostream & | operator<< (ostream &s, const SkSMatrix< T_ > &a) |
| Output matrix in output stream.
|
|
template<class T_ > |
TrMatrix< T_ > | operator* (T_ a, const TrMatrix< T_ > &A) |
| Operator * (Premultiplication of matrix by constant) More...
|
|
template<class T_ > |
ostream & | operator<< (ostream &s, const TrMatrix< T_ > &a) |
| Output matrix in output stream.
|
|
string | itos (int i) |
| Function to convert an integer to a string.
|
|
string | dtos (real_t d) |
| Function to convert a real to a string.
|
|
ostream & | operator<< (ostream &s, const Edge &ed) |
| Output edge data.
|
|
ostream & | operator<< (ostream &s, const Element &el) |
| Output element data.
|
|
Figure | operator&& (const Figure &f1, const Figure &f2) |
| Function to define a Figure instance as the intersection of two Figure instances. More...
|
|
Figure | operator- (const Figure &f1, const Figure &f2) |
| Function to define a Figure instance as the set subtraction of two Figure instances. More...
|
|
void | getMesh (string file, ExternalFileFormat form, Mesh &mesh, size_t nb_dof=1) |
| Construct an instance of class Mesh from a mesh file stored in an external file format. More...
|
|
void | getBamg (string file, Mesh &mesh, size_t nb_dof=1) |
| Construct an instance of class Mesh from a mesh file stored in Bamg format. More...
|
|
void | getEasymesh (string file, Mesh &mesh, size_t nb_dof=1) |
| Construct an instance of class Mesh from a mesh file stored in Easymesh format. More...
|
|
void | getGambit (string file, Mesh &mesh, size_t nb_dof=1) |
| Construct an instance of class Mesh from a mesh file stored in Gambit neutral format. More...
|
|
void | getGmsh (string file, Mesh &mesh, size_t nb_dof=1) |
| Construct an instance of class Mesh from a mesh file stored in Gmsh format. More...
|
|
void | getMatlab (string file, Mesh &mesh, size_t nb_dof=1) |
| Construct an instance of class Mesh from a Matlab mesh data. More...
|
|
void | getNetgen (string file, Mesh &mesh, size_t nb_dof=1) |
| Construct an instance of class Mesh from a mesh file stored in Netgen format. More...
|
|
void | getTetgen (string file, Mesh &mesh, size_t nb_dof=1) |
| Construct an instance of class Mesh from a mesh file stored in Tetgen format. More...
|
|
void | getTriangle (string file, Mesh &mesh, size_t nb_dof=1) |
| Construct an instance of class Mesh from a mesh file stored in Triangle format. More...
|
|
ostream & | operator<< (ostream &s, const Grid &g) |
| Output grid data.
|
|
ostream & | operator<< (ostream &s, const Material &m) |
| Output material data.
|
|
ostream & | operator<< (ostream &s, const Mesh &ms) |
| Output mesh data.
|
|
ostream & | operator<< (ostream &s, const MeshAdapt &a) |
| Output MeshAdapt class data.
|
|
ostream & | operator<< (ostream &s, const NodeList &nl) |
| Output NodeList instance.
|
|
ostream & | operator<< (ostream &s, const ElementList &el) |
| Output ElementList instance.
|
|
ostream & | operator<< (ostream &s, const SideList &sl) |
| Output SideList instance.
|
|
ostream & | operator<< (ostream &s, const EdgeList &el) |
| Output EdgeList instance.
|
|
void | DeformMesh (Mesh &mesh, const Vect< real_t > &u, real_t a=1) |
| Calculate deformed mesh using a displacement field. More...
|
|
void | MeshToMesh (Mesh &m1, Mesh &m2, const Vect< real_t > &u1, Vect< real_t > &u2, size_t nx, size_t ny=0, size_t nz=0, size_t dof=1) |
| Function to redefine a vector defined on a mesh to a new mesh. More...
|
|
void | MeshToMesh (Mesh &m1, Mesh &m2, const Vect< real_t > &u1, Vect< real_t > &u2, const Point< real_t > &xmin, const Point< real_t > &xmax, size_t nx, size_t ny, size_t nz, size_t dof=1) |
| Function to redefine a vector defined on a mesh to a new mesh. More...
|
|
real_t | getMaxSize (const Mesh &m) |
| Return maximal size of element edges for given mesh. More...
|
|
real_t | getMinSize (const Mesh &m) |
| Return minimal size of element edges for given mesh. More...
|
|
real_t | getMinElementMeasure (const Mesh &m) |
| Return minimal measure (length, area or volume) of elements of given mesh. More...
|
|
real_t | getMinSideMeasure (const Mesh &m) |
| Return minimal measure (length or area) of sides of given mesh. More...
|
|
real_t | getMaxSideMeasure (const Mesh &m) |
| Return maximal measure (length or area) of sides of given mesh. More...
|
|
real_t | getMeanElementMeasure (const Mesh &m) |
| Return average measure (length, area or volume) of elements of given mesh. More...
|
|
real_t | getMeanSideMeasure (const Mesh &m) |
| Return average measure (length or area) of sides of given mesh. More...
|
|
void | setNodeCodes (Mesh &m, const string &exp, int code, size_t dof=1) |
| Assign a given code to all nodes satisfying a boolean expression using node coordinates. More...
|
|
void | setBoundaryNodeCodes (Mesh &m, const string &exp, int code, size_t dof=1) |
| Assign a given code to all nodes on boundary that satisfy a boolean expression using node coordinates. More...
|
|
void | setSideCodes (Mesh &m, const string &exp, int code, size_t dof=1) |
| Assign a given code to all sides satisfying a boolean expression using node coordinates. More...
|
|
void | setBoundarySideCodes (Mesh &m, const string &exp, int code, size_t dof=1) |
| Assign a given code to all sides on boundary that satisfy a boolean expression using node coordinates. More...
|
|
void | setElementCodes (Mesh &m, const string &exp, int code) |
| Assign a given code to all elements satisfying a boolean expression using node coordinates. More...
|
|
int | NodeInElement (const Node *nd, const Element *el) |
| Say if a given node belongs to a given element. More...
|
|
int | NodeInSide (const Node *nd, const Side *sd) |
| Say if a given node belongs to a given side. More...
|
|
int | SideInElement (const Side *sd, const Element *el) |
| Say if a given side belongs to a given element. More...
|
|
ostream & | operator<< (ostream &s, const Node &nd) |
| Output node data.
|
|
void | saveMesh (const string &file, const Mesh &mesh, ExternalFileFormat form) |
| This function saves mesh data a file for a given external format. More...
|
|
void | saveGmsh (const string &gp_file, const Mesh &mesh) |
| This function outputs a Mesh instance in a file in Gmsh format. More...
|
|
void | saveGnuplot (const string &file, const Mesh &mesh) |
| This function outputs a Mesh instance in a file in Gmsh format. More...
|
|
void | saveMatlab (const string &file, const Mesh &mesh) |
| This function outputs a Mesh instance in a file in Matlab format. More...
|
|
void | saveTecplot (const string &file, const Mesh &mesh) |
| This function outputs a Mesh instance in a file in Tecplot format. More...
|
|
void | saveVTK (const string &file, const Mesh &mesh) |
| This function outputs a Mesh instance in a file in VTK format. More...
|
|
void | saveBamg (const string &file, Mesh &mesh) |
| This function outputs a Mesh instance in a file in Bamg format. More...
|
|
ostream & | operator<< (ostream &s, const Side &sd) |
| Output side data.
|
|
ostream & | operator<< (ostream &s, const Estimator &r) |
| Output estimator vector in output stream.
|
|
template<class T_ , class M_ , class P_ > |
int | BiCG (const M_ &A, const P_ &P, const Vect< T_ > &b, Vect< T_ > &x, int max_it, double &toler, int verbose) |
| Biconjugate gradient solver function. More...
|
|
template<class T_ , class M_ , class P_ > |
int | BiCGStab (const M_ &A, const P_ &P, const Vect< T_ > &b, Vect< T_ > &x, int max_it, double &toler, int verbose) |
| Biconjugate gradient stabilized solver function. More...
|
|
void | BSpline (size_t n, size_t t, Vect< Point< real_t > > &control, Vect< Point< real_t > > &output, size_t num_output) |
| Function to perform a B-spline interpolation. More...
|
|
template<class T_ , class M_ , class P_ > |
int | CG (const M_ &A, const P_ &P, const Vect< T_ > &b, Vect< T_ > &x, int max_it, double &toler, int verbose) |
| Conjugate gradient solver function. More...
|
|
template<class T_ , class M_ , class P_ > |
int | CGS (const M_ &A, const P_ &P, const Vect< T_ > &b, Vect< T_ > &x, int max_it, real_t &toler, int verbose) |
| Conjugate Gradient Squared solver function. More...
|
|
template<class T_ , class M_ , class P_ > |
int | GMRes (const M_ &A, const P_ &P, const Vect< T_ > &b, Vect< T_ > &x, size_t m, int max_it, double &toler, int verbose) |
| GMRes solver function. More...
|
|
template<class T_ , class M_ > |
int | GS (const M_ &A, const Vect< T_ > &b, Vect< T_ > &x, real_t omega, int max_it, real_t &toler, int verbose) |
| Gauss-Seidel solver function. More...
|
|
template<class T_ , class M_ > |
int | Jacobi (const M_ &A, const Vect< T_ > &b, Vect< T_ > &x, real_t omega, int max_it, real_t toler, int verbose) |
| Jacobi solver function. More...
|
|
void | BCAsConstraint (const Mesh &m, const Vect< real_t > &bc, Vect< real_t > &up, Vect< real_t > &low) |
| To impose Dirichlet boundary conditions in an optimization problem. If such conditions are to present, this function has to be invoked by giving on input bc(i) as the value to impose for the i -th optimization variable. More...
|
|
template<class OPT_ > |
int | OptimSA (OPT_ &theOpt, Vect< real_t > &x, real_t &rt, real_t &eps, int &ns, int &nt, int &neps, int &maxevl, Vect< real_t > &lb, Vect< real_t > &ub, Vect< real_t > &c, int &msg_lvl, int &seed1, int &seed2, real_t &t, Vect< real_t > &vm, Vect< real_t > &xopt, real_t &fopt, int &nacc, int &nfcnev, int &nobds) |
| Simulated annealing optimization solver. More...
|
|
template<class OPT_ > |
int | OptimTN (OPT_ &theOpt, Vect< real_t > &x, Vect< real_t > &low, Vect< real_t > &up, Vect< int > &pivot, int max_it, real_t toler, int msg_lvl) |
| Truncated Newton optimization solver. More...
|
|
template<class M_ , class P1_ , class P2_ > |
int | QMR (const M_ &A, const P1_ &P1, const P2_ &P2, const Vect< real_t > &b, Vect< real_t > &x, int max_it, real_t &toler, int verbose) |
| QMR solver function. More...
|
|
template<class T_ , class M_ > |
int | Richardson (const M_ &A, const Vect< T_ > &b, Vect< T_ > &x, real_t omega, int max_it, real_t toler, int verbose) |
| Richardson solver function. More...
|
|
template<class T_ , class MAT_A_ , class MAT_D_ , class MAT_U_ > |
void | Schur (MAT_A_ &A, MAT_U_ &U, MAT_U_ &L, MAT_D_ &D, Vect< T_ > &b, Vect< T_ > &c) |
| Solve a linear system of equations with a 2x2-block matrix. More...
|
|
template<class T_ , class MAT_A_ , class MAT_D_ , class MAT_U_ > |
void | Schur (Vect< MAT_A_ > &A, Vect< MAT_U_ > &U, Vect< MAT_U_ > &L, MAT_D_ &D, const Vect< Vect< T_ > > &b, const Vect< T_ > &c, Vect< Vect< T_ > > &x, Vect< T_ > &y) |
| Solve a linear arrow block system by block factorization. More...
|
|
template<class T_ , class M_ > |
int | SSOR (const M_ &A, const Vect< T_ > &b, Vect< T_ > &x, int max_it, double toler, int verbose) |
| SSOR solver function. More...
|
|
void | banner (const string &prog=" ") |
| Outputs a banner as header of any developed program. More...
|
|
template<class T_ > |
void | QuickSort (std::vector< T_ > &a, int begin, int end) |
| Function to sort a vector. More...
|
|
template<class T_ > |
void | qksort (std::vector< T_ > &a, int begin, int end) |
| Function to sort a vector. More...
|
|
template<class T_ , class C_ > |
void | qksort (std::vector< T_ > &a, int begin, int end, C_ compare) |
| Function to sort a vector according to a key function. More...
|
|
int | Sgn (real_t a) |
| Return sign of a : -1 or 1 .
|
|
real_t | Abs2 (complex_t a) |
| Return square of modulus of complex number a
|
|
real_t | Abs2 (real_t a) |
| Return square of real number a
|
|
real_t | Abs (real_t a) |
| Return absolute value of a
|
|
real_t | Abs (complex_t a) |
| Return modulus of complex number a
|
|
real_t | Abs (const Point< real_t > &p) |
| Return Norm of vector a
|
|
real_t | Conjg (real_t a) |
| Return complex conjugate of real number a
|
|
complex_t | Conjg (complex_t a) |
| Return complex conjugate of complex number a
|
|
real_t | Max (real_t a, real_t b, real_t c) |
| Return maximum value of real numbers a , b and c
|
|
int | Max (int a, int b, int c) |
| Return maximum value of integer numbers a , b and c
|
|
real_t | Min (real_t a, real_t b, real_t c) |
| Return minimum value of real numbers a , b and c
|
|
int | Min (int a, int b, int c) |
| Return minimum value of integer numbers a , b and c
|
|
real_t | Max (real_t a, real_t b, real_t c, real_t d) |
| Return maximum value of integer numbers a , b , c and d
|
|
int | Max (int a, int b, int c, int d) |
| Return maximum value of integer numbers a , b , c and d
|
|
real_t | Min (real_t a, real_t b, real_t c, real_t d) |
| Return minimum value of real numbers a , b , c and d
|
|
int | Min (int a, int b, int c, int d) |
| Return minimum value of integer numbers a , b , c and d
|
|
real_t | Arg (complex_t x) |
| Return argument of complex number x
|
|
complex_t | Log (complex_t x) |
| Return principal determination of logarithm of complex number x
|
|
template<class T_ > |
T_ | Sqr (T_ x) |
| Return square of value x
|
|
template<class T_ > |
void | Scale (T_ a, const vector< T_ > &x, vector< T_ > &y) |
| Mutiply vector x by a and save result in vector y More...
|
|
template<class T_ > |
void | Scale (T_ a, vector< T_ > &x) |
| Mutiply vector x by a More...
|
|
template<class T_ > |
void | Xpy (size_t n, T_ *x, T_ *y) |
| Add array x to y
|
|
template<class T_ > |
void | Xpy (const vector< T_ > &x, vector< T_ > &y) |
| Add vector x to y More...
|
|
template<class T_ > |
void | Axpy (size_t n, T_ a, T_ *x, T_ *y) |
| Multiply array x by a and add result to y More...
|
|
template<class T_ > |
void | Axpy (T_ a, const vector< T_ > &x, vector< T_ > &y) |
| Multiply vector x by a and add result to y More...
|
|
template<class T_ > |
void | Copy (size_t n, T_ *x, T_ *y) |
| Copy array x to y n is the arrays size.
|
|
real_t | Error2 (const vector< real_t > &x, const vector< real_t > &y) |
| Return absolute L2 error between vectors x and y
|
|
real_t | RError2 (const vector< real_t > &x, const vector< real_t > &y) |
| Return absolute L2 error between vectors x and y
|
|
real_t | ErrorMax (const vector< real_t > &x, const vector< real_t > &y) |
| Return absolute Max. error between vectors x and y
|
|
real_t | RErrorMax (const vector< real_t > &x, const vector< real_t > &y) |
| Return relative Max. error between vectors x and y
|
|
template<class T_ > |
T_ | Dot (size_t n, T_ *x, T_ *y) |
| Return dot product of arrays x and y More...
|
|
template<class T_ > |
T_ | Dot (const vector< T_ > &x, const vector< T_ > &y) |
| Return dot product of vectors x and y . More...
|
|
real_t | Dot (const vector< real_t > &x, const vector< real_t > &y) |
| Return dot product of vectors x and y More...
|
|
template<class T_ > |
T_ | Dot (const Point< T_ > &x, const Point< T_ > &y) |
| Return dot product of x and y
|
|
template<class T_ > |
void | Clear (vector< T_ > &v) |
| Assign 0 to all entries of a vector. More...
|
|
real_t | Nrm2 (size_t n, real_t *x) |
| Return 2-norm of array x More...
|
|
real_t | Nrm2 (const vector< real_t > &x) |
| Return 2-norm of vector x
|
|
template<class T_ > |
real_t | Nrm2 (const Point< T_ > &a) |
| Return 2-norm of a
|
|
bool | Equal (real_t x, real_t y, real_t toler=OFELI_EPSMCH) |
| Function to return true if numbers x and y are close up to a given tolerance toler More...
|
|
char | itoc (int i) |
| Function to convert an integer to a character.
|
|
template<class T_ > |
T_ | stringTo (const std::string &s) |
| Function to convert a string to a template type parameter.
|
|
void | RTrim (char *s) |
| Function to remove blanks at the end of a string.
|
|
void | LTrim (char *s) |
| Function to remove blanks at the beginning of a string.
|
|
void | Trim (char *s) |
| Function to remove blanks at the beginning and end of a string.
|
|
template<class T_ > |
void | Swap (T_ &a, T_ &b) |
| Swap elements a and b.
|
|