|
| class | BaseArray |
| | Base class for array container. More...
|
| |
| class | Array |
| |
| class | Array2D |
| |
| class | Array3D |
| |
| class | GroupTopology |
| |
| class | GroupCommunicator |
| |
| class | IdGenerator |
| |
| struct | Hashed2 |
| |
| struct | Hashed4 |
| |
| class | HashTable |
| |
| class | isockstream |
| |
| class | StackPart |
| |
| class | Stack |
| |
| class | MemAllocNode |
| |
| class | MemAlloc |
| |
| class | OptionsParser |
| |
| class | osockstream |
| |
| class | IntegerSet |
| | A set of integers. More...
|
| |
| class | ListOfIntegerSets |
| | List of integer sets. More...
|
| |
| class | socketbuf |
| |
| class | socketstream |
| |
| class | socketserver |
| |
| class | Pair |
| | A pair of objects. More...
|
| |
| class | Triple |
| |
| class | STable3DNode |
| |
| class | STable3D |
| | Symmetric 3D Table. More...
|
| |
| class | Table |
| |
| class | STable |
| |
| class | DSTable |
| |
| class | StopWatch |
| | Timing object. More...
|
| |
| class | BlockMatrix |
| |
| class | BlockOperator |
| | A class to handle Block systems in a matrix-free implementation. More...
|
| |
| class | BlockDiagonalPreconditioner |
| | A class to handle Block diagonal preconditioners in a matrix-free implementation. More...
|
| |
| class | BlockVector |
| |
| class | DenseMatrix |
| | Data type dense matrix. More...
|
| |
| class | DenseMatrixInverse |
| |
| class | DenseMatrixEigensystem |
| |
| class | DenseMatrixSVD |
| |
| class | DenseTensor |
| | Rank 3 tensor (array of matrices) More...
|
| |
| class | HypreParVector |
| | Wrapper for hypre's parallel vector class. More...
|
| |
| class | HypreParMatrix |
| | Wrapper for hypre's ParCSR matrix class. More...
|
| |
| class | HypreSmoother |
| | Parallel smoothers in hypre. More...
|
| |
| class | HypreSolver |
| | Abstract class for hypre's solvers and preconditioners. More...
|
| |
| class | HyprePCG |
| | PCG solver in hypre. More...
|
| |
| class | HypreGMRES |
| | GMRES solver in hypre. More...
|
| |
| class | HypreIdentity |
| | The identity operator as a hypre solver. More...
|
| |
| class | HypreDiagScale |
| | Jacobi preconditioner in hypre. More...
|
| |
| class | HypreParaSails |
| | The ParaSails preconditioner in hypre. More...
|
| |
| class | HypreBoomerAMG |
| | The BoomerAMG solver in hypre. More...
|
| |
| class | HypreAMS |
| | The Auxiliary-space Maxwell Solver in hypre. More...
|
| |
| class | HypreADS |
| | The Auxiliary-space Divergence Solver in hypre. More...
|
| |
| class | Matrix |
| | Abstract data type matrix. More...
|
| |
| class | MatrixInverse |
| | Abstract data type for matrix inverse. More...
|
| |
| class | AbstractSparseMatrix |
| | Abstract data type for sparse matrices. More...
|
| |
| class | ODESolver |
| | Abstract class for solving systems of ODEs: dx/dt = f(x,t) More...
|
| |
| class | ForwardEulerSolver |
| | The classical forward Euler method. More...
|
| |
| class | RK2Solver |
| |
| class | RK3SSPSolver |
| | Third-order, strong stability preserving (SSP) Runge-Kutta method. More...
|
| |
| class | RK4Solver |
| | The classical explicit forth-order Runge-Kutta method, RK4. More...
|
| |
| class | ExplicitRKSolver |
| |
| class | RK6Solver |
| |
| class | RK8Solver |
| |
| class | BackwardEulerSolver |
| | Backward Euler ODE solver. L-stable. More...
|
| |
| class | ImplicitMidpointSolver |
| | Implicit midpoint method. A-stable, not L-stable. More...
|
| |
| class | SDIRK23Solver |
| |
| class | SDIRK34Solver |
| |
| class | SDIRK33Solver |
| |
| class | Operator |
| | Abstract operator. More...
|
| |
| class | TimeDependentOperator |
| | Base abstract class for time dependent operators: (x,t) -> f(x,t) More...
|
| |
| class | Solver |
| | Base class for solvers. More...
|
| |
| class | IdentityOperator |
| | Operator I: x -> x. More...
|
| |
| class | TransposeOperator |
| | The transpose of a given operator. More...
|
| |
| class | RAPOperator |
| | The operator x -> R*A*P*x. More...
|
| |
| class | IterativeSolver |
| | Abstract base class for iterative solver. More...
|
| |
| class | SLISolver |
| | Stationary linear iteration: x <- x + B (b - A x) More...
|
| |
| class | CGSolver |
| | Conjugate gradient method. More...
|
| |
| class | GMRESSolver |
| | GMRES method. More...
|
| |
| class | FGMRESSolver |
| | FGMRES method. More...
|
| |
| class | BiCGSTABSolver |
| | BiCGSTAB method. More...
|
| |
| class | MINRESSolver |
| | MINRES method. More...
|
| |
| class | NewtonSolver |
| |
| class | SLBQPOptimizer |
| |
| class | UMFPackSolver |
| | Direct sparse solver using UMFPACK. More...
|
| |
| class | SparseMatrix |
| | Data type sparse matrix. More...
|
| |
| class | SparseSmoother |
| |
| class | GSSmoother |
| | Data type for Gauss-Seidel smoother of sparse matrix. More...
|
| |
| class | DSmoother |
| | Data type for scaled Jacobi-type smoother of sparse matrix. More...
|
| |
| class | Vector |
| | Vector data type. More...
|
| |
| class | Element |
| | Abstract data type element. More...
|
| |
| class | RefinedElement |
| |
| class | BisectedElement |
| |
| class | QuadrisectedElement |
| |
| class | OctasectedElement |
| |
| class | Hexahedron |
| | Data type hexahedron element. More...
|
| |
| class | Mesh |
| |
| class | NodeExtrudeCoefficient |
| | Class used to exrude the nodes of a mesh. More...
|
| |
| class | MesquiteMesh |
| |
| struct | Refinement |
| |
| class | NCMesh |
| | A class for non-conforming AMR on higher-order hexahedral, quadrilateral or triangular meshes. More...
|
| |
| class | KnotVector |
| |
| class | NURBSPatch |
| |
| class | NURBSExtension |
| |
| class | ParNURBSExtension |
| |
| class | NURBSPatchMap |
| |
| class | ParMesh |
| | Class for parallel meshes. More...
|
| |
| class | Point |
| | Data type point element. More...
|
| |
| class | Quadrilateral |
| | Data type quadrilateral element. More...
|
| |
| class | Segment |
| | Data type line segment element. More...
|
| |
| class | Tetrahedron |
| | Data type tetrahedron element. More...
|
| |
| class | Triangle |
| | Data type triangle element. More...
|
| |
| class | Vertex |
| | Data type for vertex. More...
|
| |
| class | BilinearForm |
| |
| class | MixedBilinearForm |
| |
| class | DiscreteLinearOperator |
| |
| class | BilinearFormIntegrator |
| | Abstract base class BilinearFormIntegrator. More...
|
| |
| class | TransposeIntegrator |
| |
| class | LumpedIntegrator |
| |
| class | InverseIntegrator |
| | Integrator that inverts the matrix assembled by another integrator. More...
|
| |
| class | SumIntegrator |
| | Integrator defining a sum of multiple Integrators. More...
|
| |
| class | DiffusionIntegrator |
| |
| class | MassIntegrator |
| |
| class | BoundaryMassIntegrator |
| |
| class | ConvectionIntegrator |
| | alpha (q . grad u, v) More...
|
| |
| class | GroupConvectionIntegrator |
| | alpha (q . grad u, v) using the "group" FE discretization More...
|
| |
| class | VectorMassIntegrator |
| |
| class | VectorFEDivergenceIntegrator |
| |
| class | VectorFECurlIntegrator |
| | Integrator for (curl u, v) for Nedelec and RT elements. More...
|
| |
| class | DerivativeIntegrator |
| | Class for integrating (Q D_i(u), v); u and v are scalars. More...
|
| |
| class | CurlCurlIntegrator |
| | Integrator for (curl u, curl v) for Nedelec elements. More...
|
| |
| class | VectorCurlCurlIntegrator |
| |
| class | VectorFEMassIntegrator |
| | Integrator for (Q u, v) for VectorFiniteElements. More...
|
| |
| class | VectorDivergenceIntegrator |
| |
| class | DivDivIntegrator |
| | (Q div u, div v) for RT elements More...
|
| |
| class | VectorDiffusionIntegrator |
| |
| class | ElasticityIntegrator |
| |
| class | DGTraceIntegrator |
| |
| class | DGDiffusionIntegrator |
| |
| class | TraceJumpIntegrator |
| |
| class | DiscreteInterpolator |
| |
| class | GradientInterpolator |
| |
| class | IdentityInterpolator |
| |
| class | CurlInterpolator |
| |
| class | DivergenceInterpolator |
| |
| class | Coefficient |
| | Base class Coefficient that may optionally depend on time. More...
|
| |
| class | ConstantCoefficient |
| | Subclass constant coefficient. More...
|
| |
| class | PWConstCoefficient |
| | class for piecewise constant coefficient More...
|
| |
| class | FunctionCoefficient |
| | class for C-function coefficient More...
|
| |
| class | GridFunctionCoefficient |
| | Coefficient defined by a GridFunction. This coefficient is mesh dependent. More...
|
| |
| class | TransformedCoefficient |
| |
| class | DeltaCoefficient |
| | Delta function coefficient. More...
|
| |
| class | RestrictedCoefficient |
| | Coefficient defined on a subset of domain or boundary attributes. More...
|
| |
| class | VectorCoefficient |
| |
| class | VectorConstantCoefficient |
| |
| class | VectorFunctionCoefficient |
| |
| class | VectorArrayCoefficient |
| | Vector coefficient defined by an array of scalar coefficients. More...
|
| |
| class | VectorGridFunctionCoefficient |
| | Vector coefficient defined by a vector GridFunction. More...
|
| |
| class | VectorRestrictedCoefficient |
| | VectorCoefficient defined on a subset of domain or boundary attributes. More...
|
| |
| class | MatrixCoefficient |
| |
| class | MatrixFunctionCoefficient |
| |
| class | MatrixArrayCoefficient |
| |
| class | DataCollection |
| |
| class | VisItFieldInfo |
| | Helper class for VisIt visualization data. More...
|
| |
| class | VisItDataCollection |
| | Data collection with VisIt I/O routines. More...
|
| |
| class | ElementTransformation |
| |
| class | IsoparametricTransformation |
| |
| class | IntegrationPointTransformation |
| |
| class | FaceElementTransformations |
| |
| class | FunctionSpace |
| | Describes the space on each element. More...
|
| |
| class | FiniteElement |
| | Abstract class for Finite Elements. More...
|
| |
| class | NodalFiniteElement |
| |
| class | PositiveFiniteElement |
| |
| class | VectorFiniteElement |
| |
| class | PointFiniteElement |
| |
| class | Linear1DFiniteElement |
| | Class for linear FE on interval. More...
|
| |
| class | Linear2DFiniteElement |
| | Class for linear FE on triangle. More...
|
| |
| class | BiLinear2DFiniteElement |
| | Class for bilinear FE on quadrilateral. More...
|
| |
| class | GaussLinear2DFiniteElement |
| | Class for linear FE on triangle with nodes at the 3 "Gaussian" points. More...
|
| |
| class | GaussBiLinear2DFiniteElement |
| | Class for bilinear FE on quad with nodes at the 4 Gaussian points. More...
|
| |
| class | P1OnQuadFiniteElement |
| |
| class | Quad1DFiniteElement |
| | Class for quadratic FE on interval. More...
|
| |
| class | QuadPos1DFiniteElement |
| |
| class | Quad2DFiniteElement |
| | Class for quadratic FE on triangle. More...
|
| |
| class | GaussQuad2DFiniteElement |
| | Class for quadratic FE on triangle with nodes at the "Gaussian" points. More...
|
| |
| class | BiQuad2DFiniteElement |
| | Class for bi-quadratic FE on quadrilateral. More...
|
| |
| class | BiQuadPos2DFiniteElement |
| |
| class | GaussBiQuad2DFiniteElement |
| | Bi-quadratic element on quad with nodes at the 9 Gaussian points. More...
|
| |
| class | BiCubic2DFiniteElement |
| |
| class | Cubic1DFiniteElement |
| |
| class | Cubic2DFiniteElement |
| |
| class | Cubic3DFiniteElement |
| | Class for cubic FE on tetrahedron. More...
|
| |
| class | P0TriangleFiniteElement |
| | Class for constant FE on triangle. More...
|
| |
| class | P0QuadFiniteElement |
| |
| class | Linear3DFiniteElement |
| | Class for linear FE on tetrahedron. More...
|
| |
| class | Quadratic3DFiniteElement |
| | Class for quadratic FE on tetrahedron. More...
|
| |
| class | TriLinear3DFiniteElement |
| | Class for tri-linear FE on cube. More...
|
| |
| class | CrouzeixRaviartFiniteElement |
| | Crouzeix-Raviart finite element on triangle. More...
|
| |
| class | CrouzeixRaviartQuadFiniteElement |
| | Crouzeix-Raviart finite element on quadrilateral. More...
|
| |
| class | P0SegmentFiniteElement |
| |
| class | RT0TriangleFiniteElement |
| |
| class | RT0QuadFiniteElement |
| |
| class | RT1TriangleFiniteElement |
| |
| class | RT1QuadFiniteElement |
| |
| class | RT2TriangleFiniteElement |
| |
| class | RT2QuadFiniteElement |
| |
| class | P1SegmentFiniteElement |
| | Linear 1D element with nodes 1/3 and 2/3 (trace of RT1) More...
|
| |
| class | P2SegmentFiniteElement |
| | Quadratic 1D element with nodes the Gaussian points in [0,1] (trace of RT2) More...
|
| |
| class | Lagrange1DFiniteElement |
| |
| class | P1TetNonConfFiniteElement |
| |
| class | P0TetFiniteElement |
| |
| class | P0HexFiniteElement |
| |
| class | LagrangeHexFiniteElement |
| | Tensor products of 1D FEs (only degree 2 is functional) More...
|
| |
| class | RefinedLinear1DFiniteElement |
| | Class for refined linear FE on interval. More...
|
| |
| class | RefinedLinear2DFiniteElement |
| | Class for refined linear FE on triangle. More...
|
| |
| class | RefinedLinear3DFiniteElement |
| | Class for refined linear FE on tetrahedron. More...
|
| |
| class | RefinedBiLinear2DFiniteElement |
| | Class for refined bi-linear FE on quadrilateral. More...
|
| |
| class | RefinedTriLinear3DFiniteElement |
| | Class for refined trilinear FE on a hexahedron. More...
|
| |
| class | Nedelec1HexFiniteElement |
| |
| class | Nedelec1TetFiniteElement |
| |
| class | RT0HexFiniteElement |
| |
| class | RT1HexFiniteElement |
| |
| class | RT0TetFiniteElement |
| |
| class | RotTriLinearHexFiniteElement |
| |
| class | Poly_1D |
| |
| class | H1_SegmentElement |
| |
| class | H1_QuadrilateralElement |
| |
| class | H1_HexahedronElement |
| |
| class | H1Pos_SegmentElement |
| |
| class | H1Pos_QuadrilateralElement |
| |
| class | H1Pos_HexahedronElement |
| |
| class | H1_TriangleElement |
| |
| class | H1_TetrahedronElement |
| |
| class | L2_SegmentElement |
| |
| class | L2Pos_SegmentElement |
| |
| class | L2_QuadrilateralElement |
| |
| class | L2Pos_QuadrilateralElement |
| |
| class | L2_HexahedronElement |
| |
| class | L2Pos_HexahedronElement |
| |
| class | L2_TriangleElement |
| |
| class | L2Pos_TriangleElement |
| |
| class | L2_TetrahedronElement |
| |
| class | L2Pos_TetrahedronElement |
| |
| class | RT_QuadrilateralElement |
| |
| class | RT_HexahedronElement |
| |
| class | RT_TriangleElement |
| |
| class | RT_TetrahedronElement |
| |
| class | ND_HexahedronElement |
| |
| class | ND_QuadrilateralElement |
| |
| class | ND_TetrahedronElement |
| |
| class | ND_TriangleElement |
| |
| class | NURBSFiniteElement |
| |
| class | NURBS1DFiniteElement |
| |
| class | NURBS2DFiniteElement |
| |
| class | NURBS3DFiniteElement |
| |
| class | FiniteElementCollection |
| |
| class | H1_FECollection |
| | Arbitrary order H1-conforming (continuous) finite elements. More...
|
| |
| class | H1Pos_FECollection |
| |
| class | L2_FECollection |
| | Arbitrary order "L2-conforming" discontinuous finite elements. More...
|
| |
| class | RT_FECollection |
| | Arbitrary order H(div)-conforming Raviart-Thomas finite elements. More...
|
| |
| class | RT_Trace_FECollection |
| |
| class | ND_FECollection |
| | Arbitrary order H(curl)-conforming Nedelec finite elements. More...
|
| |
| class | NURBSFECollection |
| | Arbitrary order non-uniform rational B-splines (NURBS) finite elements. More...
|
| |
| class | LinearFECollection |
| | Piecewise-(bi)linear continuous finite elements. More...
|
| |
| class | QuadraticFECollection |
| | Piecewise-(bi)quadratic continuous finite elements. More...
|
| |
| class | QuadraticPosFECollection |
| | Version of QuadraticFECollection with positive basis functions. More...
|
| |
| class | CubicFECollection |
| | Piecewise-(bi)cubic continuous finite elements. More...
|
| |
| class | CrouzeixRaviartFECollection |
| | Crouzeix-Raviart nonconforming elements in 2D. More...
|
| |
| class | LinearNonConf3DFECollection |
| | Piecewise-linear nonconforming finite elements in 3D. More...
|
| |
| class | RT0_2DFECollection |
| |
| class | RT1_2DFECollection |
| |
| class | RT2_2DFECollection |
| |
| class | Const2DFECollection |
| |
| class | LinearDiscont2DFECollection |
| |
| class | GaussLinearDiscont2DFECollection |
| | Version of LinearDiscont2DFECollection with dofs in the Gaussian points. More...
|
| |
| class | P1OnQuadFECollection |
| | Linear (P1) finite elements on quadrilaterals. More...
|
| |
| class | QuadraticDiscont2DFECollection |
| |
| class | QuadraticPosDiscont2DFECollection |
| | Version of QuadraticDiscont2DFECollection with positive basis functions. More...
|
| |
| class | GaussQuadraticDiscont2DFECollection |
| | Version of QuadraticDiscont2DFECollection with dofs in the Gaussian points. More...
|
| |
| class | CubicDiscont2DFECollection |
| |
| class | Const3DFECollection |
| |
| class | LinearDiscont3DFECollection |
| |
| class | QuadraticDiscont3DFECollection |
| |
| class | RefinedLinearFECollection |
| | Finite element collection on a macro-element. More...
|
| |
| class | ND1_3DFECollection |
| |
| class | RT0_3DFECollection |
| |
| class | RT1_3DFECollection |
| |
| class | Local_FECollection |
| | Discontinuous collection defined locally by a given finite element. More...
|
| |
| class | Ordering |
| |
| class | RefinementData |
| | Data kept for every type of refinement. More...
|
| |
| class | FiniteElementSpace |
| | Abstract finite element space. More...
|
| |
| class | Geometry |
| |
| class | RefinedGeometry |
| |
| class | GeometryRefiner |
| |
| class | GridFunction |
| | Class for grid function - Vector with associated FE space. More...
|
| |
| class | ExtrudeCoefficient |
| | Class used for extruding scalar GridFunctions. More...
|
| |
| class | IntegrationPoint |
| | Class for integration point with weight. More...
|
| |
| class | IntegrationRule |
| | Class for integration rule. More...
|
| |
| class | IntegrationRules |
| | Container class for integration rules. More...
|
| |
| class | LinearForm |
| | Class for linear form - Vector with associated FE space and LFIntegrators. More...
|
| |
| class | LinearFormIntegrator |
| | Abstract base class LinearFormIntegrator. More...
|
| |
| class | DomainLFIntegrator |
| | Class for domain integration L(v) := (f, v) More...
|
| |
| class | BoundaryLFIntegrator |
| | Class for boundary integration L(v) := (g, v) More...
|
| |
| class | BoundaryNormalLFIntegrator |
| | Class for boundary integration . More...
|
| |
| class | BoundaryTangentialLFIntegrator |
| | Class for boundary integration in 2D. More...
|
| |
| class | VectorDomainLFIntegrator |
| |
| class | VectorBoundaryLFIntegrator |
| |
| class | VectorFEDomainLFIntegrator |
| | for VectorFiniteElements (Nedelec, Raviart-Thomas) More...
|
| |
| class | VectorBoundaryFluxLFIntegrator |
| |
| class | VectorFEBoundaryFluxLFIntegrator |
| |
| class | VectorFEBoundaryTangentLFIntegrator |
| | Class for boundary integration . More...
|
| |
| class | BoundaryFlowIntegrator |
| |
| class | DGDirichletLFIntegrator |
| |
| class | NonlinearForm |
| |
| class | NonlinearFormIntegrator |
| |
| class | HyperelasticModel |
| | Abstract class for hyperelastic models. More...
|
| |
| class | InverseHarmonicModel |
| |
| class | NeoHookeanModel |
| |
| class | HyperelasticNLFIntegrator |
| | Hyperelastic integrator for any given HyperelasticModel. More...
|
| |
| class | ParBilinearForm |
| | Class for parallel bilinear form. More...
|
| |
| class | ParMixedBilinearForm |
| | Class for parallel bilinear form. More...
|
| |
| class | ParDiscreteLinearOperator |
| |
| class | ParFiniteElementSpace |
| | Abstract parallel finite element space. More...
|
| |
| class | ParGridFunction |
| | Class for parallel grid function. More...
|
| |
| class | ParLinearForm |
| | Class for parallel linear form. More...
|
| |
| class | ParNonlinearForm |
| | Parallel non-linear operator on the true dofs. More...
|
| |
|
| template<class T > |
| int | Compare (const void *p, const void *q) |
| |
| template<class T > |
| void | Swap (Array< T > &, Array< T > &) |
| |
| template<class T > |
| void | Swap (Array2D< T > &, Array2D< T > &) |
| |
| template<class T > |
| void | Swap (T &a, T &b) |
| |
| void | mfem_error (const char *msg) |
| |
| void | mfem_warning (const char *msg) |
| |
| int | isValidAsInt (char *s) |
| |
| int | isValidAsDouble (char *s) |
| |
| void | parseArray (char *str, Array< int > &var) |
| |
| void | parseVector (char *str, Vector &var) |
| |
| template<class A , class B > |
| int | ComparePairs (const void *_p, const void *_q) |
| | Compare the first element of the pairs. More...
|
| |
| template<class A , class B > |
| void | SortPairs (Pair< A, B > *pairs, int size) |
| | Sort with respect to the first element. More...
|
| |
| template int | ComparePairs< int, int > (const void *, const void *) |
| |
| template int | ComparePairs< double, int > (const void *, const void *) |
| |
| template int | ComparePairs< int, double > (const void *, const void *) |
| |
| template void | SortPairs< int, int > (Pair< int, int > *, int) |
| |
| template void | SortPairs< double, int > (Pair< double, int > *, int) |
| |
| template void | SortPairs< int, double > (Pair< int, double > *, int) |
| |
| template<class A , class B , class C > |
| int | CompareTriple (const void *_p, const void *_q) |
| |
| template<class A , class B , class C > |
| void | SortTriple (Triple< A, B, C > *triples, int size) |
| |
| void | Sort3 (int &r, int &c, int &f) |
| |
| void | Transpose (const Table &A, Table &At, int _ncols_A=-1) |
| | Transpose a Table. More...
|
| |
| Table * | Transpose (const Table &A) |
| |
| void | Transpose (const Array< int > &A, Table &At, int _ncols_A=-1) |
| | Transpose an Array<int> More...
|
| |
| void | Mult (const Table &A, const Table &B, Table &C) |
| | C = A * B (as boolean matrices) More...
|
| |
| Table * | Mult (const Table &A, const Table &B) |
| |
| void | tic () |
| | Start timing. More...
|
| |
| double | toc () |
| | End timing. More...
|
| |
| BlockMatrix * | Transpose (const BlockMatrix &A) |
| | Transpose a BlockMatrix: result = A'. More...
|
| |
| BlockMatrix * | Mult (const BlockMatrix &A, const BlockMatrix &B) |
| | Multiply BlockMatrix matrices: result = A*B. More...
|
| |
| void | dgetrf_ (int *, int *, double *, int *, int *, int *) |
| |
| void | dgetrs_ (char *, int *, int *, double *, int *, int *, double *, int *, int *) |
| |
| void | dgetri_ (int *N, double *A, int *LDA, int *IPIV, double *WORK, int *LWORK, int *INFO) |
| |
| void | dsyevr_ (char *JOBZ, char *RANGE, char *UPLO, int *N, double *A, int *LDA, double *VL, double *VU, int *IL, int *IU, double *ABSTOL, int *M, double *W, double *Z, int *LDZ, int *ISUPPZ, double *WORK, int *LWORK, int *IWORK, int *LIWORK, int *INFO) |
| |
| void | dsyev_ (char *JOBZ, char *UPLO, int *N, double *A, int *LDA, double *W, double *WORK, int *LWORK, int *INFO) |
| |
| void | dgesvd_ (char *JOBU, char *JOBVT, int *M, int *N, double *A, int *LDA, double *S, double *U, int *LDU, double *VT, int *LDVT, double *WORK, int *LWORK, int *INFO) |
| |
| void | dsyevr_Eigensystem (DenseMatrix &a, Vector &ev, DenseMatrix *evect) |
| |
| void | dsyev_Eigensystem (DenseMatrix &a, Vector &ev, DenseMatrix *evect) |
| |
| void | Eigenvalues2S (const double &d12, double &d1, double &d2) |
| |
| void | Eigensystem2S (const double &d12, double &d1, double &d2, double &c, double &s) |
| |
| void | vec_normalize3_aux (const double &x1, const double &x2, const double &x3, double &n1, double &n2, double &n3) |
| |
| void | vec_normalize3 (const double &x1, const double &x2, const double &x3, double &n1, double &n2, double &n3) |
| |
| bool | KernelVector2G (const int &mode, double &d1, double &d12, double &d21, double &d2) |
| |
| int | KernelVector3G_aux (const int &mode, double &d1, double &d2, double &d3, double &c12, double &c13, double &c23, double &c21, double &c31, double &c32) |
| |
| int | KernelVector3S (const int &mode, const double &d12, const double &d13, const double &d23, double &d1, double &d2, double &d3) |
| |
| int | Reduce3S (const int &mode, double &d1, double &d2, double &d3, double &d12, double &d13, double &d23, double &z1, double &z2, double &z3, double &v1, double &v2, double &v3, double &g) |
| |
| void | GetScalingFactor (const double &d_max, double &mult) |
| |
| void | Add (const DenseMatrix &A, const DenseMatrix &B, double alpha, DenseMatrix &C) |
| | C = A + alpha*B. More...
|
| |
| void | dgemm_ (char *, char *, int *, int *, int *, double *, double *, int *, double *, int *, double *, double *, int *) |
| |
| void | Mult (const DenseMatrix &b, const DenseMatrix &c, DenseMatrix &a) |
| | Matrix matrix multiplication. A = B * C. More...
|
| |
| void | CalcAdjugate (const DenseMatrix &a, DenseMatrix &adja) |
| |
| void | CalcAdjugateTranspose (const DenseMatrix &a, DenseMatrix &adjat) |
| | Calculate the transposed adjugate of a matrix (for NxN matrices, N=1,2,3) More...
|
| |
| void | CalcInverse (const DenseMatrix &a, DenseMatrix &inva) |
| |
| void | CalcInverseTranspose (const DenseMatrix &a, DenseMatrix &inva) |
| | Calculate the inverse transpose of a matrix (for NxN matrices, N=1,2,3) More...
|
| |
| void | CalcOrtho (const DenseMatrix &J, Vector &n) |
| |
| void | MultAAt (const DenseMatrix &a, DenseMatrix &aat) |
| | Calculate the matrix A.At. More...
|
| |
| void | AddMultADAt (const DenseMatrix &A, const Vector &D, DenseMatrix &ADAt) |
| | ADAt += A D A^t, where D is diagonal. More...
|
| |
| void | MultADAt (const DenseMatrix &A, const Vector &D, DenseMatrix &ADAt) |
| | ADAt = A D A^t, where D is diagonal. More...
|
| |
| void | MultABt (const DenseMatrix &A, const DenseMatrix &B, DenseMatrix &ABt) |
| | Multiply a matrix A with the transpose of a matrix B: A*Bt. More...
|
| |
| void | AddMultABt (const DenseMatrix &A, const DenseMatrix &B, DenseMatrix &ABt) |
| | ABt += A * B^t. More...
|
| |
| void | MultAtB (const DenseMatrix &A, const DenseMatrix &B, DenseMatrix &AtB) |
| | Multiply the transpose of a matrix A with a matrix B: At*B. More...
|
| |
| void | AddMult_a_AAt (double a, const DenseMatrix &A, DenseMatrix &AAt) |
| | AAt += a * A * A^t. More...
|
| |
| void | Mult_a_AAt (double a, const DenseMatrix &A, DenseMatrix &AAt) |
| | AAt = a * A * A^t. More...
|
| |
| void | MultVVt (const Vector &v, DenseMatrix &vvt) |
| | Make a matrix from a vector V.Vt. More...
|
| |
| void | MultVWt (const Vector &v, const Vector &w, DenseMatrix &VWt) |
| |
| void | AddMultVWt (const Vector &v, const Vector &w, DenseMatrix &VWt) |
| | VWt += v w^t. More...
|
| |
| void | AddMult_a_VWt (const double a, const Vector &v, const Vector &w, DenseMatrix &VWt) |
| | VWt += a * v w^t. More...
|
| |
| void | AddMult_a_VVt (const double a, const Vector &v, DenseMatrix &VVt) |
| | VVt += a * v v^t. More...
|
| |
| double | InnerProduct (HypreParVector *x, HypreParVector *y) |
| |
| double | InnerProduct (HypreParVector &x, HypreParVector &y) |
| | Returns the inner product of x and y. More...
|
| |
| HypreParMatrix * | ParMult (HypreParMatrix *A, HypreParMatrix *B) |
| | Returns the matrix A * B. More...
|
| |
| HypreParMatrix * | RAP (HypreParMatrix *A, HypreParMatrix *P) |
| | Returns the matrix P^t * A * P. More...
|
| |
| HypreParMatrix * | RAP (HypreParMatrix *Rt, HypreParMatrix *A, HypreParMatrix *P) |
| | Returns the matrix Rt^t * A * P. More...
|
| |
| void | EliminateBC (HypreParMatrix &A, HypreParMatrix &Ae, Array< int > &ess_dof_list, HypreParVector &x, HypreParVector &b) |
| |
| int | ParCSRRelax_Taubin (hypre_ParCSRMatrix *A, hypre_ParVector *f, double lambda, double mu, int N, double max_eig, hypre_ParVector *u, hypre_ParVector *r) |
| |
| int | ParCSRRelax_FIR (hypre_ParCSRMatrix *A, hypre_ParVector *f, double max_eig, int poly_order, double *fir_coeffs, hypre_ParVector *u, hypre_ParVector *x0, hypre_ParVector *x1, hypre_ParVector *x2, hypre_ParVector *x3) |
| |
| HypreParMatrix * | DiscreteGrad (ParFiniteElementSpace *edge_fespace, ParFiniteElementSpace *vert_fespace) |
| | Compute the discrete gradient matrix between the nodal linear and ND1 spaces. More...
|
| |
| HypreParMatrix * | DiscreteCurl (ParFiniteElementSpace *face_fespace, ParFiniteElementSpace *edge_fespace) |
| | Compute the discrete curl matrix between the ND1 and RT0 spaces. More...
|
| |
| void | SLI (const Operator &A, const Vector &b, Vector &x, int print_iter=0, int max_num_iter=1000, double RTOLERANCE=1e-12, double ATOLERANCE=1e-24) |
| | Stationary linear iteration. (tolerances are squared) More...
|
| |
| void | SLI (const Operator &A, Solver &B, const Vector &b, Vector &x, int print_iter=0, int max_num_iter=1000, double RTOLERANCE=1e-12, double ATOLERANCE=1e-24) |
| | Preconditioned stationary linear iteration. (tolerances are squared) More...
|
| |
| void | CG (const Operator &A, const Vector &b, Vector &x, int print_iter=0, int max_num_iter=1000, double RTOLERANCE=1e-12, double ATOLERANCE=1e-24) |
| | Conjugate gradient method. (tolerances are squared) More...
|
| |
| void | PCG (const Operator &A, Solver &B, const Vector &b, Vector &x, int print_iter=0, int max_num_iter=1000, double RTOLERANCE=1e-12, double ATOLERANCE=1e-24) |
| | Preconditioned conjugate gradient method. (tolerances are squared) More...
|
| |
| void | GeneratePlaneRotation (double &dx, double &dy, double &cs, double &sn) |
| |
| void | ApplyPlaneRotation (double &dx, double &dy, double &cs, double &sn) |
| |
| void | Update (Vector &x, int k, DenseMatrix &h, Vector &s, Array< Vector * > &v) |
| |
| int | GMRES (const Operator &A, Vector &x, const Vector &b, Solver &M, int &max_iter, int m, double &tol, double atol, int printit) |
| | GMRES method. (tolerances are squared) More...
|
| |
| void | GMRES (const Operator &A, Solver &B, const Vector &b, Vector &x, int print_iter=0, int max_num_iter=1000, int m=50, double rtol=1e-12, double atol=1e-24) |
| | GMRES method. (tolerances are squared) More...
|
| |
| int | BiCGSTAB (const Operator &A, Vector &x, const Vector &b, Solver &M, int &max_iter, double &tol, double atol, int printit) |
| | BiCGSTAB method. (tolerances are squared) More...
|
| |
| void | BiCGSTAB (const Operator &A, Solver &B, const Vector &b, Vector &x, int print_iter=0, int max_num_iter=1000, double rtol=1e-12, double atol=1e-24) |
| | BiCGSTAB method. (tolerances are squared) More...
|
| |
| void | MINRES (const Operator &A, const Vector &b, Vector &x, int print_it=0, int max_it=1000, double rtol=1e-12, double atol=1e-24) |
| | MINRES method without preconditioner. (tolerances are squared) More...
|
| |
| void | MINRES (const Operator &A, Solver &B, const Vector &b, Vector &x, int print_it=0, int max_it=1000, double rtol=1e-12, double atol=1e-24) |
| | MINRES method with preconditioner. (tolerances are squared) More...
|
| |
| int | aGMRES (const Operator &A, Vector &x, const Vector &b, const Operator &M, int &max_iter, int m_max, int m_min, int m_step, double cf, double &tol, double &atol, int printit) |
| |
| void | SparseMatrixFunction (SparseMatrix &S, double(*f)(double)) |
| | Applies f() to each element of the matrix (after it is finalized). More...
|
| |
| SparseMatrix * | Transpose (const SparseMatrix &A) |
| | Transpose of a sparse matrix. A must be finalized. More...
|
| |
| SparseMatrix * | TransposeAbstractSparseMatrix (const AbstractSparseMatrix &A, int useActualWidth) |
| | Transpose of a sparse matrix. A does not need to be a CSR matrix. More...
|
| |
| SparseMatrix * | Mult (const SparseMatrix &A, const SparseMatrix &B, SparseMatrix *OAB) |
| |
| SparseMatrix * | MultAbstractSparseMatrix (const AbstractSparseMatrix &A, const AbstractSparseMatrix &B) |
| | Matrix product of sparse matrices. A and B do not need to be CSR matrices. More...
|
| |
| SparseMatrix * | RAP (const SparseMatrix &A, const SparseMatrix &R, SparseMatrix *ORAP) |
| |
| SparseMatrix * | RAP (const SparseMatrix &Rt, const SparseMatrix &A, const SparseMatrix &P) |
| | General RAP with given R^T, A and P. More...
|
| |
| SparseMatrix * | Mult_AtDA (const SparseMatrix &A, const Vector &D, SparseMatrix *OAtDA) |
| |
| SparseMatrix * | Add (double a, const SparseMatrix &A, double b, const SparseMatrix &B) |
| | Matrix addition result = a*A + b*B. More...
|
| |
| SparseMatrix * | Add (const SparseMatrix &A, const SparseMatrix &B) |
| | Matrix addition result = A + B. More...
|
| |
| SparseMatrix * | Add (Array< SparseMatrix * > &Ai) |
| | Matrix addition result = sum_i A_i. More...
|
| |
| void | Swap (SparseMatrix &A, SparseMatrix &B) |
| |
| class if | defined (__alignas_is_defined) alignas(double) RowNode |
| |
| void | swap (Vector *v1, Vector *v2) |
| |
| void | add (const Vector &v1, const Vector &v2, Vector &v) |
| |
| void | add (const Vector &v1, double alpha, const Vector &v2, Vector &v) |
| |
| void | add (const double a, const Vector &x, const Vector &y, Vector &z) |
| |
| void | add (const double a, const Vector &x, const double b, const Vector &y, Vector &z) |
| |
| void | subtract (const Vector &x, const Vector &y, Vector &z) |
| |
| void | subtract (const double a, const Vector &x, const Vector &y, Vector &z) |
| |
| int | CheckFinite (const double *v, const int n) |
| |
| double | Distance (const double *x, const double *y, const int n) |
| |
| void | skip_comment_lines (std::istream &is, const char comment_char) |
| |
| void | XYZ_VectorFunction (const Vector &p, Vector &v) |
| |
| void | METIS_PartGraphRecursive (int *, idxtype *, idxtype *, idxtype *, idxtype *, int *, int *, int *, int *, int *, idxtype *) |
| |
| void | METIS_PartGraphKway (int *, idxtype *, idxtype *, idxtype *, idxtype *, int *, int *, int *, int *, int *, idxtype *) |
| |
| void | METIS_PartGraphVKway (int *, idxtype *, idxtype *, idxtype *, idxtype *, int *, int *, int *, int *, int *, idxtype *) |
| |
| int | METIS_PartGraphRecursive (idx_t *nvtxs, idx_t *ncon, idx_t *xadj, idx_t *adjncy, idx_t *vwgt, idx_t *vsize, idx_t *adjwgt, idx_t *nparts, real_t *tpwgts, real_t *ubvec, idx_t *options, idx_t *edgecut, idx_t *part) |
| |
| int | METIS_PartGraphKway (idx_t *nvtxs, idx_t *ncon, idx_t *xadj, idx_t *adjncy, idx_t *vwgt, idx_t *vsize, idx_t *adjwgt, idx_t *nparts, real_t *tpwgts, real_t *ubvec, idx_t *options, idx_t *edgecut, idx_t *part) |
| |
| int | METIS_SetDefaultOptions (idx_t *options) |
| |
| void | FindPartitioningComponents (Table &elem_elem, const Array< int > &partitioning, Array< int > &component, Array< int > &num_comp) |
| |
| void | DetOfLinComb (const DenseMatrix &A, const DenseMatrix &B, Vector &c) |
| |
| int | FindRoots (const Vector &z, Vector &x) |
| |
| void | FindTMax (Vector &c, Vector &x, double &tmax, const double factor, const int Dim) |
| |
| std::ostream & | operator<< (std::ostream &out, const Mesh &mesh) |
| |
| Mesh * | Extrude1D (Mesh *mesh, const int ny, const double sy, const bool closed=false) |
| | Extrude a 1D mesh. More...
|
| |
| int | decode_dof (int dof, double &sign) |
| |
| NURBSPatch * | Interpolate (NURBSPatch &p1, NURBSPatch &p2) |
| |
| NURBSPatch * | Revolve3D (NURBSPatch &patch, double n[], double ang, int times) |
| |
| double | LpNormLoop (double p, Coefficient &coeff, Mesh &mesh, const IntegrationRule *irs[]) |
| |
| double | LpNormLoop (double p, VectorCoefficient &coeff, Mesh &mesh, const IntegrationRule *irs[]) |
| |
| double | ComputeLpNorm (double p, Coefficient &coeff, Mesh &mesh, const IntegrationRule *irs[]) |
| |
| double | ComputeLpNorm (double p, VectorCoefficient &coeff, Mesh &mesh, const IntegrationRule *irs[]) |
| |
| double | ComputeGlobalLpNorm (double p, Coefficient &coeff, ParMesh &pmesh, const IntegrationRule *irs[]) |
| |
| double | ComputeGlobalLpNorm (double p, VectorCoefficient &coeff, ParMesh &pmesh, const IntegrationRule *irs[]) |
| |
| string | to_string (int i) |
| |
| string | to_padded_string (int i, int digits) |
| |
| int | to_int (string str) |
| |
| std::ostream & | operator<< (std::ostream &out, const GridFunction &sol) |
| |
| void | ComputeFlux (BilinearFormIntegrator &blfi, GridFunction &u, GridFunction &flux, int wcoef, int sd) |
| |
| void | ZZErrorEstimator (BilinearFormIntegrator &blfi, GridFunction &u, GridFunction &flux, Vector &ErrorEstimates, int wsd) |
| |
| GridFunction * | Extrude1DGridFunction (Mesh *mesh, Mesh *mesh2d, GridFunction *sol, const int ny) |
| | Extrude a scalar 1D GridFunction, after extruding the mesh with Extrude1D. More...
|
| |
| double | GlobalLpNorm (const double p, double loc_norm, MPI_Comm comm) |
| | Compute a global Lp norm from the local Lp norms computed by each processor. More...
|
| |