 mfem | |
  BaseArray | Base class for array container |
  Array | |
  Array2D | |
  Array3D | |
  GroupTopology | |
  GroupCommunicator | |
   OpData | |
  IdGenerator | |
  Hashed2 | |
  Hashed4 | |
  HashTable | |
   Iterator | Iterator over items contained in the HashTable |
  isockstream | |
  StackPart | |
  Stack | |
  MemAllocNode | |
  MemAlloc | |
  OptionsParser | |
  osockstream | |
  IntegerSet | A set of integers |
  ListOfIntegerSets | List of integer sets |
  socketbuf | |
  socketstream | |
  socketserver | |
  Pair | A pair of objects |
  Triple | |
  STable3DNode | |
  STable3D | Symmetric 3D Table |
  Table | |
  STable | |
  DSTable | |
   RowIterator | |
  StopWatch | Timing object |
  BlockMatrix | |
  BlockOperator | A class to handle Block systems in a matrix-free implementation |
  BlockDiagonalPreconditioner | A class to handle Block diagonal preconditioners in a matrix-free implementation |
  BlockVector | |
  DenseMatrix | Data type dense matrix |
  DenseMatrixInverse | |
  DenseMatrixEigensystem | |
  DenseMatrixSVD | |
  DenseTensor | Rank 3 tensor (array of matrices) |
  HypreParVector | Wrapper for hypre's parallel vector class |
  HypreParMatrix | Wrapper for hypre's ParCSR matrix class |
  HypreSmoother | Parallel smoothers in hypre |
  HypreSolver | Abstract class for hypre's solvers and preconditioners |
  HyprePCG | PCG solver in hypre |
  HypreGMRES | GMRES solver in hypre |
  HypreIdentity | The identity operator as a hypre solver |
  HypreDiagScale | Jacobi preconditioner in hypre |
  HypreParaSails | The ParaSails preconditioner in hypre |
  HypreBoomerAMG | The BoomerAMG solver in hypre |
  HypreAMS | The Auxiliary-space Maxwell Solver in hypre |
  HypreADS | The Auxiliary-space Divergence Solver in hypre |
  Matrix | Abstract data type matrix |
  MatrixInverse | Abstract data type for matrix inverse |
  AbstractSparseMatrix | Abstract data type for sparse matrices |
  ODESolver | Abstract class for solving systems of ODEs: dx/dt = f(x,t) |
  ForwardEulerSolver | The classical forward Euler method |
  RK2Solver | |
  RK3SSPSolver | Third-order, strong stability preserving (SSP) Runge-Kutta method |
  RK4Solver | The classical explicit forth-order Runge-Kutta method, RK4 |
  ExplicitRKSolver | |
  RK6Solver | |
  RK8Solver | |
  BackwardEulerSolver | Backward Euler ODE solver. L-stable |
  ImplicitMidpointSolver | Implicit midpoint method. A-stable, not L-stable |
  SDIRK23Solver | |
  SDIRK34Solver | |
  SDIRK33Solver | |
  Operator | Abstract operator |
  TimeDependentOperator | Base abstract class for time dependent operators: (x,t) -> f(x,t) |
  Solver | Base class for solvers |
  IdentityOperator | Operator I: x -> x |
  TransposeOperator | The transpose of a given operator |
  RAPOperator | The operator x -> R*A*P*x |
  IterativeSolver | Abstract base class for iterative solver |
  SLISolver | Stationary linear iteration: x <- x + B (b - A x) |
  CGSolver | Conjugate gradient method |
  GMRESSolver | GMRES method |
  FGMRESSolver | FGMRES method |
  BiCGSTABSolver | BiCGSTAB method |
  MINRESSolver | MINRES method |
  NewtonSolver | |
  SLBQPOptimizer | |
  UMFPackSolver | Direct sparse solver using UMFPACK |
  SparseMatrix | Data type sparse matrix |
  SparseSmoother | |
  GSSmoother | Data type for Gauss-Seidel smoother of sparse matrix |
  DSmoother | Data type for scaled Jacobi-type smoother of sparse matrix |
  Vector | Vector data type |
  Element | Abstract data type element |
  RefinedElement | |
  BisectedElement | |
  QuadrisectedElement | |
  OctasectedElement | |
  Hexahedron | Data type hexahedron element |
  Mesh | |
   FaceInfo | |
  NodeExtrudeCoefficient | Class used to exrude the nodes of a mesh |
  MesquiteMesh | |
  Refinement | |
  NCMesh | A class for non-conforming AMR on higher-order hexahedral, quadrilateral or triangular meshes |
   Dependency | |
   DofData | |
   Edge | |
   Element | |
   Face | |
   FineTransform | |
   Node | |
   Point | |
   PointMatrix | |
   RefCount | |
   RefStackItem | |
   Vertex | |
  KnotVector | |
  NURBSPatch | |
  NURBSExtension | |
  ParNURBSExtension | |
  NURBSPatchMap | |
  ParMesh | Class for parallel meshes |
  Point | Data type point element |
  Quadrilateral | Data type quadrilateral element |
  Segment | Data type line segment element |
  Tetrahedron | Data type tetrahedron element |
  Triangle | Data type triangle element |
  Vertex | Data type for vertex |
  BilinearForm | |
  MixedBilinearForm | |
  DiscreteLinearOperator | |
  BilinearFormIntegrator | Abstract base class BilinearFormIntegrator |
  TransposeIntegrator | |
  LumpedIntegrator | |
  InverseIntegrator | Integrator that inverts the matrix assembled by another integrator |
  SumIntegrator | Integrator defining a sum of multiple Integrators |
  DiffusionIntegrator | |
  MassIntegrator | |
  BoundaryMassIntegrator | |
  ConvectionIntegrator | Alpha (q . grad u, v) |
  GroupConvectionIntegrator | Alpha (q . grad u, v) using the "group" FE discretization |
  VectorMassIntegrator | |
  VectorFEDivergenceIntegrator | |
  VectorFECurlIntegrator | Integrator for (curl u, v) for Nedelec and RT elements |
  DerivativeIntegrator | Class for integrating (Q D_i(u), v); u and v are scalars |
  CurlCurlIntegrator | Integrator for (curl u, curl v) for Nedelec elements |
  VectorCurlCurlIntegrator | |
  VectorFEMassIntegrator | Integrator for (Q u, v) for VectorFiniteElements |
  VectorDivergenceIntegrator | |
  DivDivIntegrator | (Q div u, div v) for RT elements |
  VectorDiffusionIntegrator | |
  ElasticityIntegrator | |
  DGTraceIntegrator | |
  DGDiffusionIntegrator | |
  TraceJumpIntegrator | |
  DiscreteInterpolator | |
  GradientInterpolator | |
  IdentityInterpolator | |
  CurlInterpolator | |
  DivergenceInterpolator | |
  Coefficient | Base class Coefficient that may optionally depend on time |
  ConstantCoefficient | Subclass constant coefficient |
  PWConstCoefficient | Class for piecewise constant coefficient |
  FunctionCoefficient | Class for C-function coefficient |
  GridFunctionCoefficient | Coefficient defined by a GridFunction. This coefficient is mesh dependent |
  TransformedCoefficient | |
  DeltaCoefficient | Delta function coefficient |
  RestrictedCoefficient | Coefficient defined on a subset of domain or boundary attributes |
  VectorCoefficient | |
  VectorConstantCoefficient | |
  VectorFunctionCoefficient | |
  VectorArrayCoefficient | Vector coefficient defined by an array of scalar coefficients |
  VectorGridFunctionCoefficient | Vector coefficient defined by a vector GridFunction |
  VectorRestrictedCoefficient | VectorCoefficient defined on a subset of domain or boundary attributes |
  MatrixCoefficient | |
  MatrixFunctionCoefficient | |
  MatrixArrayCoefficient | |
  DataCollection | |
  VisItFieldInfo | Helper class for VisIt visualization data |
  VisItDataCollection | Data collection with VisIt I/O routines |
  ElementTransformation | |
  IsoparametricTransformation | |
  IntegrationPointTransformation | |
  FaceElementTransformations | |
  FunctionSpace | Describes the space on each element |
  FiniteElement | Abstract class for Finite Elements |
  NodalFiniteElement | |
  PositiveFiniteElement | |
  VectorFiniteElement | |
  PointFiniteElement | |
  Linear1DFiniteElement | Class for linear FE on interval |
  Linear2DFiniteElement | Class for linear FE on triangle |
  BiLinear2DFiniteElement | Class for bilinear FE on quadrilateral |
  GaussLinear2DFiniteElement | Class for linear FE on triangle with nodes at the 3 "Gaussian" points |
  GaussBiLinear2DFiniteElement | Class for bilinear FE on quad with nodes at the 4 Gaussian points |
  P1OnQuadFiniteElement | |
  Quad1DFiniteElement | Class for quadratic FE on interval |
  QuadPos1DFiniteElement | |
  Quad2DFiniteElement | Class for quadratic FE on triangle |
  GaussQuad2DFiniteElement | Class for quadratic FE on triangle with nodes at the "Gaussian" points |
  BiQuad2DFiniteElement | Class for bi-quadratic FE on quadrilateral |
  BiQuadPos2DFiniteElement | |
  GaussBiQuad2DFiniteElement | Bi-quadratic element on quad with nodes at the 9 Gaussian points |
  BiCubic2DFiniteElement | |
  Cubic1DFiniteElement | |
  Cubic2DFiniteElement | |
  Cubic3DFiniteElement | Class for cubic FE on tetrahedron |
  P0TriangleFiniteElement | Class for constant FE on triangle |
  P0QuadFiniteElement | |
  Linear3DFiniteElement | Class for linear FE on tetrahedron |
  Quadratic3DFiniteElement | Class for quadratic FE on tetrahedron |
  TriLinear3DFiniteElement | Class for tri-linear FE on cube |
  CrouzeixRaviartFiniteElement | Crouzeix-Raviart finite element on triangle |
  CrouzeixRaviartQuadFiniteElement | Crouzeix-Raviart finite element on quadrilateral |
  P0SegmentFiniteElement | |
  RT0TriangleFiniteElement | |
  RT0QuadFiniteElement | |
  RT1TriangleFiniteElement | |
  RT1QuadFiniteElement | |
  RT2TriangleFiniteElement | |
  RT2QuadFiniteElement | |
  P1SegmentFiniteElement | Linear 1D element with nodes 1/3 and 2/3 (trace of RT1) |
  P2SegmentFiniteElement | Quadratic 1D element with nodes the Gaussian points in [0,1] (trace of RT2) |
  Lagrange1DFiniteElement | |
  P1TetNonConfFiniteElement | |
  P0TetFiniteElement | |
  P0HexFiniteElement | |
  LagrangeHexFiniteElement | Tensor products of 1D FEs (only degree 2 is functional) |
  RefinedLinear1DFiniteElement | Class for refined linear FE on interval |
  RefinedLinear2DFiniteElement | Class for refined linear FE on triangle |
  RefinedLinear3DFiniteElement | Class for refined linear FE on tetrahedron |
  RefinedBiLinear2DFiniteElement | Class for refined bi-linear FE on quadrilateral |
  RefinedTriLinear3DFiniteElement | Class for refined trilinear FE on a hexahedron |
  Nedelec1HexFiniteElement | |
  Nedelec1TetFiniteElement | |
  RT0HexFiniteElement | |
  RT1HexFiniteElement | |
  RT0TetFiniteElement | |
  RotTriLinearHexFiniteElement | |
  Poly_1D | |
   Basis | |
  H1_SegmentElement | |
  H1_QuadrilateralElement | |
  H1_HexahedronElement | |
  H1Pos_SegmentElement | |
  H1Pos_QuadrilateralElement | |
  H1Pos_HexahedronElement | |
  H1_TriangleElement | |
  H1_TetrahedronElement | |
  L2_SegmentElement | |
  L2Pos_SegmentElement | |
  L2_QuadrilateralElement | |
  L2Pos_QuadrilateralElement | |
  L2_HexahedronElement | |
  L2Pos_HexahedronElement | |
  L2_TriangleElement | |
  L2Pos_TriangleElement | |
  L2_TetrahedronElement | |
  L2Pos_TetrahedronElement | |
  RT_QuadrilateralElement | |
  RT_HexahedronElement | |
  RT_TriangleElement | |
  RT_TetrahedronElement | |
  ND_HexahedronElement | |
  ND_QuadrilateralElement | |
  ND_TetrahedronElement | |
  ND_TriangleElement | |
  NURBSFiniteElement | |
  NURBS1DFiniteElement | |
  NURBS2DFiniteElement | |
  NURBS3DFiniteElement | |
  FiniteElementCollection | |
  H1_FECollection | Arbitrary order H1-conforming (continuous) finite elements |
  H1Pos_FECollection | |
  L2_FECollection | Arbitrary order "L2-conforming" discontinuous finite elements |
  RT_FECollection | Arbitrary order H(div)-conforming Raviart-Thomas finite elements |
  RT_Trace_FECollection | |
  ND_FECollection | Arbitrary order H(curl)-conforming Nedelec finite elements |
  NURBSFECollection | Arbitrary order non-uniform rational B-splines (NURBS) finite elements |
  LinearFECollection | Piecewise-(bi)linear continuous finite elements |
  QuadraticFECollection | Piecewise-(bi)quadratic continuous finite elements |
  QuadraticPosFECollection | Version of QuadraticFECollection with positive basis functions |
  CubicFECollection | Piecewise-(bi)cubic continuous finite elements |
  CrouzeixRaviartFECollection | Crouzeix-Raviart nonconforming elements in 2D |
  LinearNonConf3DFECollection | Piecewise-linear nonconforming finite elements in 3D |
  RT0_2DFECollection | |
  RT1_2DFECollection | |
  RT2_2DFECollection | |
  Const2DFECollection | |
  LinearDiscont2DFECollection | |
  GaussLinearDiscont2DFECollection | Version of LinearDiscont2DFECollection with dofs in the Gaussian points |
  P1OnQuadFECollection | Linear (P1) finite elements on quadrilaterals |
  QuadraticDiscont2DFECollection | |
  QuadraticPosDiscont2DFECollection | Version of QuadraticDiscont2DFECollection with positive basis functions |
  GaussQuadraticDiscont2DFECollection | Version of QuadraticDiscont2DFECollection with dofs in the Gaussian points |
  CubicDiscont2DFECollection | |
  Const3DFECollection | |
  LinearDiscont3DFECollection | |
  QuadraticDiscont3DFECollection | |
  RefinedLinearFECollection | Finite element collection on a macro-element |
  ND1_3DFECollection | |
  RT0_3DFECollection | |
  RT1_3DFECollection | |
  Local_FECollection | Discontinuous collection defined locally by a given finite element |
  Ordering | |
  RefinementData | Data kept for every type of refinement |
  FiniteElementSpace | Abstract finite element space |
  Geometry | |
  RefinedGeometry | |
  GeometryRefiner | |
  GridFunction | Class for grid function - Vector with associated FE space |
  ExtrudeCoefficient | Class used for extruding scalar GridFunctions |
  IntegrationPoint | Class for integration point with weight |
  IntegrationRule | Class for integration rule |
  IntegrationRules | Container class for integration rules |
  LinearForm | Class for linear form - Vector with associated FE space and LFIntegrators |
  LinearFormIntegrator | Abstract base class LinearFormIntegrator |
  DomainLFIntegrator | Class for domain integration L(v) := (f, v) |
  BoundaryLFIntegrator | Class for boundary integration L(v) := (g, v) |
  BoundaryNormalLFIntegrator | Class for boundary integration |
  BoundaryTangentialLFIntegrator | Class for boundary integration in 2D |
  VectorDomainLFIntegrator | |
  VectorBoundaryLFIntegrator | |
  VectorFEDomainLFIntegrator | for VectorFiniteElements (Nedelec, Raviart-Thomas) |
  VectorBoundaryFluxLFIntegrator | |
  VectorFEBoundaryFluxLFIntegrator | |
  VectorFEBoundaryTangentLFIntegrator | Class for boundary integration |
  BoundaryFlowIntegrator | |
  DGDirichletLFIntegrator | |
  NonlinearForm | |
  NonlinearFormIntegrator | |
  HyperelasticModel | Abstract class for hyperelastic models |
  InverseHarmonicModel | |
  NeoHookeanModel | |
  HyperelasticNLFIntegrator | Hyperelastic integrator for any given HyperelasticModel |
  ParBilinearForm | Class for parallel bilinear form |
  ParMixedBilinearForm | Class for parallel bilinear form |
  ParDiscreteLinearOperator | |
  ParFiniteElementSpace | Abstract parallel finite element space |
  ParGridFunction | Class for parallel grid function |
  ParLinearForm | Class for parallel linear form |
  ParNonlinearForm | Parallel non-linear operator on the true dofs |