Namespaces | Classes | Typedefs | Enumerations | Functions | Variables
oomph Namespace Reference

Namespaces

 AxisymmetricLinearElasticityTractionElementHelper
 
 AxisymmetricNavierStokesTractionElementHelper
 
 AxisymmetricPoroelasticityTractionElementHelper
 
 Biharmonic_schur_complement_Hypre_defaults
 
 BinaryTreeNames
 Namespace for BinaryTree directions.
 
 BlackBoxFDNewtonSolver
 Namespace for black-box FD Newton solver.
 
 BrickFromTetMeshHelper
 Helper namespace for generation of brick from tet mesh.
 
 BrokenCopy
 
 CommandLineArgs
 Namespace for command line arguments.
 
 CRDoubleMatrixHelpers
 Namespace for helper functions for CRDoubleMatrices.
 
 CumulativeTimings
 Namespace for global (cumulative) timings.
 
 DarcyFaceElementHelper
 
 DoubleVectorHelpers
 Namespace for helper functions for DoubleVectors.
 
 ElementGeometry
 
 FSI_functions
 Namespace for "global" FSI functions.
 
 Global_output_stream
 
 Global_string_for_annotation
 
 Global_timings
 
 Global_unsigned
 
 Hankel_functions_for_helmholtz_problem
 
 Helper_namespace_for_mesh_smoothing
 Helper namespace.
 
 Hypre_default_settings
 Default settings for various uses of the HYPRE solver.
 
 HypreHelpers
 Helper functions for use with the Hypre library.
 
 Lagrange_Enforced_Flow_Preconditioner_Subsidiary_Operator_Helper
 Namespace for subsidiary preconditioner creation helper functions.
 
 LeakCheckNames
 
 Legendre_functions_helper
 Helper namespace for functions required for Helmholtz computations.
 
 LinearAlgebraDistributionHelpers
 Namespace for helper functions for LinearAlgebraDistributions.
 
 LinearElasticityTractionElementHelper
 
 LinearisedAxisymPoroelasticBJS_FSIHelper
 
 LinearisedFSIAxisymmetricNStNoSlipBCHelper
 
 Locate_zeta_helpers
 Helper namespace for tolerances and iterations within the Newton method used in the locate_zeta function in FiniteElements.
 
 MathematicalConstants
 
 MemoryUsage
 
 MeshAsGeomObject_Helper
 
 MeshChecker
 
 METIS
 Namespace for METIS graph partitioning routines.
 
 Missing_masters_functions
 
 Multi_domain_functions
 
 MultiDomainBoussinesqHelper
 Namespace for default parameters in multi-domain Boussinesq.
 
 NodeOrdering
 
 ObsoleteCode
 Namespace for flagging up obsolete parts of the code.
 
 OcTreeNames
 
 OneDimHermite
 One Dimensional Hermite shape functions.
 
 OneDimLagrange
 
 Orthpoly
 
 ParaviewHelper
 Namespace for paraview-style output helper functions.
 
 PauseFlags
 Namespace for pause() command.
 
 PMLTimeHarmonicLinearElasticityTractionElementHelper
 
 PoroelasticityFaceElementHelper
 
 PreconditionerCreationFunctions
 
 PressureAdvectionDiffusionValidation
 
 Pseudo_Elastic_Preconditioner_Subsidiary_Operator_Helper
 Functions to create instances of optimal subsidiary operators for the PseudoElasticPreconditioner.
 
 PseudoSolidHelper
 Helper namespace for pseudo-elastic elements.
 
 QElement1BulkCoordinateDerivatives
 
 QElement1FaceToBulkCoordinates
 
 QElement2BulkCoordinateDerivatives
 
 QElement2FaceToBulkCoordinates
 
 QElement3BulkCoordinateDerivatives
 
 QElement3FaceToBulkCoordinates
 
 QuadTreeNames
 Namespace for QuadTree directions.
 
 RRR
 
 SecondInvariantHelper
 
 SolidHelpers
 Namespace for solid mechanics helper functions.
 
 SolidTractionElementHelper
 
 StringConversion
 
 TecplotNames
 Namespace for tecplot stuff.
 
 TElement1BulkCoordinateDerivatives
 
 TElement1FaceToBulkCoordinates
 
 TElement2BulkCoordinateDerivatives
 
 TElement2FaceToBulkCoordinates
 
 TElement3FaceToBulkCoordinates
 
 TerminateHelper
 
 TimeHarmonicFourierDecomposedLinearElasticityTractionElementHelper
 
 TimeHarmonicLinearElasticityTractionElementHelper
 
 TimingHelpers
 Helper for recording execution time.
 
 ToleranceForFourierDecomposedHelmholtzOuterBoundary
 Namespace for checking radius of nodes on (assumed to be circular) DtN boundary.
 
 ToleranceForHelmholtzOuterBoundary
 Namespace for checking radius of nodes on (assumed to be circular) DtN boundary.
 
 ToleranceForVertexMismatchInPolygons
 Namespace that allows the specification of a tolerance between vertices at the ends of polylines that are supposed to be at the same position.
 
 TriangleBoundaryHelper
 
 TriangleHelper
 Helper namespace for triangle meshes.
 
 TrilinosEpetraHelpers
 Helper namespace for use with the Trilinos Epetra package. Contains functions to generate two Epetra containers (Epetra_Vector and Epetra_CrsMatrix) and provides access to the trilinos matrix-matrix and matrix-vector product routines.
 
 TwoDimensionalPMLHelper
 Namespace with functions that allow the construction of PML layers on axis aligned boundaries.
 
 TypeNames
 
 VectorHelpers
 Namespace for helper functions for Vector<double>
 

Classes

class  AbsCmp
 
class  AddedMainNumberingLookup
 
class  AdvectionDiffusionBoussinesqElement
 
class  AdvectionDiffusionEquations
 A class for all elements that solve the Advection Diffusion equations using isoparametric elements.

\[ \frac{\partial^2 u}{\partial x_i^2} = Pe w_i(x_k) \frac{\partial u}{\partial x_i} + f(x_j) \]

This contains the generic maths. Shape functions, geometric mapping etc. must get implemented in derived class. More...

 
class  AdvectionDiffusionFluxElement
 A class for elements that allow the imposition of an applied flux on the boundaries of Advection Diffusion elements. The element geometry is obtained from the FaceGeometry<ELEMENT> policy class. More...
 
class  AdvectionDiffusionReactionEquations
 A class for all elements that solve the Advection Diffusion Reaction equations using isoparametric elements.

\[ \tau_{i} \frac{\partial C_{i}}{\partial t} + w_{j} \frac{\partial C_{i}}{\partial x_{j}} = D_{i}\frac{\partial^2 C_{i}}{\partial x_j^2} = - R_{i}(C_{i}) + f_{i} \]

This contains the generic maths. Shape functions, geometric mapping etc. must get implemented in derived class. More...

 
class  AlgebraicChannelWithLeafletMesh
 
class  AlgebraicCollapsibleChannelMesh
 Collapsible channel mesh with algebraic node update. More...
 
class  AlgebraicCylinderWithFlagMesh
 Algebraic version of CylinderWithFlagMesh. More...
 
class  AlgebraicElement
 
class  AlgebraicElementBase
 
class  AlgebraicFishMesh
 Fish shaped mesh with algebraic node update function for nodes. More...
 
class  AlgebraicFSIDrivenCavityMesh
 
class  AlgebraicMesh
 
class  AlgebraicNode
 
class  AlgebraicRefineableFishMesh
 Refineable fish shaped mesh with algebraic node update function. More...
 
class  AlgebraicRefineableQuarterCircleSectorMesh
 
class  AlgebraicRefineableQuarterTubeMesh
 AlgebraicMesh version of RefineableQuarterTubeMesh. More...
 
class  ANASAZI
 Class for the Anasazi eigensolver. More...
 
class  AnnularDomain
 Annular domain. More...
 
class  AnnularFromCartesianPMLElement
 
class  AnnularFromLocalCoordinatePMLElement
 
class  AnnularPMLElementBase
 
class  ARPACK
 Class for the ARPACK eigensolver. More...
 
class  AssemblyHandler
 A class that is used to define the functions used to assemble the elemental contributions to the residuals vector and Jacobian matrix that define the problem being solved. The main use of this class is to assemble and solve the augmented systems used in bifurcation detection and tracking. The default implementation merely calls the underlying elemental functions with no augmentation. More...
 
class  AugmentedBlockFoldLinearSolver
 
class  AugmentedBlockPitchForkLinearSolver
 
class  AxisAlignedPMLElement
 
class  AxisymAdvectionDiffusionEquations
 A class for all elements that solve the Advection Diffusion equations in a cylindrical polar coordinate system using isoparametric elements.

\[ Pe \mathbf{w}\cdot(\mathbf{x}) \nabla u = \nabla \cdot \left( \nabla u \right) + f(\mathbf{x}) \]

This contains the generic maths. Shape functions, geometric mapping etc. must get implemented in derived class. More...

 
class  AxisymAdvectionDiffusionFluxElement
 A class for elements that allow the imposition of an applied Robin boundary condition on the boundaries of Steady Axisymmnetric Advection Diffusion Flux elements.

\[ -\Delta u \cdot \mathbf{n} + \alpha(r,z) u = \beta(r,z) \]

The element geometry is obtained from the FaceGeometry<ELEMENT> policy class. More...

 
class  AxisymDiagHermitePVDElement
 
class  AxisymFoepplvonKarmanElement
 
class  AxisymFoepplvonKarmanEquations
 
class  AxisymmetricDerivatives
 
class  AxisymmetricLinearElasticityEquations
 
class  AxisymmetricLinearElasticityEquationsBase
 
class  AxisymmetricLinearElasticityTractionElement
 
class  AxisymmetricNavierStokesEquations
 
class  AxisymmetricNavierStokesTractionElement
 
class  AxisymmetricPoroelasticityEquations
 Class implementing the generic maths of the axisym poroelasticity equations: axisym linear elasticity coupled with axisym Darcy equations (using Raviart-Thomas elements with both edge and internal degrees of freedom) including inertia in both. More...
 
class  AxisymmetricPoroelasticityTractionElement
 
class  AxisymmetricPVDEquations
 
class  AxisymmetricPVDEquationsWithPressure
 
class  AxisymmetricQCrouzeixRaviartElement
 
class  AxisymmetricQTaylorHoodElement
 
class  AxisymmetricSolidTractionElement
 
class  AxisymmetricTCrouzeixRaviartElement
 
class  AxisymmetricTTaylorHoodElement
 
class  AxisymmetricVolumeConstraintBoundingElement
 
class  AxisymQPVDElement
 
class  AxisymQPVDElementWithPressure
 
class  BackupMeshForProjection
 
class  BackwardStepQuadMesh
 Backward step mesh. More...
 
class  BDF
 Templated class for BDF-type time-steppers with fixed or variable timestep. 1st time derivative recovered directly from the previous function values. Template parameter represents the number of previous timesteps stored, so that BDF<1> is the classical first order backward Euler scheme. Need to reset weights after every change in timestep. More...
 
class  BellElement
 
class  BellElementBase
 
class  BellElementShape
 
class  BellElementShape< 2 >
 
class  BermudezPMLMapping
 
class  BiCGStab
 The conjugate gradient method. More...
 
class  BiharmonicElement
 biharmonic element class More...
 
class  BiharmonicEquations
 Biharmonic Equation Class - contains the equations. More...
 
class  BiharmonicFluidBoundaryElement
 Point equation element used to impose the traction free edge (i.e. du/dn = 0) on the boundary when dt/ds_n != 0. The following equation is implemented : du/ds_n = dt/ds_n * ds_t/dt * du/dt. The bulk biharmonic elements on the boundary must be hijackable and the du/ds_n and d2u/ds_nds_t boundary DOFs hijacked when these elements are applied. At any node where dt/ds_n = 0 we can impose du/ds_n = 0 and d2u/ds_nds_t = 0 using pinning - see BiharmonicFluidProblem::impose_traction_free_edge() More...
 
class  BiharmonicFluidProblem
 Biharmonic Fluid Problem Class - describes stokes flow in 2D. Developed for the topologically rectangular Hermite Element Mesh. Contains functions allowing the following boundary conditions to be applied (on a given edge): More...
 
class  BiharmonicFluxElement
 Biharmonic Flux Element. More...
 
class  BiharmonicPreconditioner
 Biharmonic Preconditioner - for two dimensional problems. More...
 
class  BiharmonicProblem
 Biharmonic Plate Problem Class - for problems where the load can be assumed to be acting normal to the surface of the plate and the deflections are small relative to the thickness of the plate. Developed for the topologically rectangular Hermite Element Mesh. Contains functions allowing the following boundary conditions to be applied (on a given edge): More...
 
class  BinArrayParameters
 Helper object for dealing with the parameters used for the BinArray objects. More...
 
class  BinaryTree
 
class  BinaryTreeForest
 
class  BinaryTreeRoot
 
class  BlockAntiDiagonalPreconditioner
 Block "anti-diagonal" preconditioner, i.e. same as block diagonal but along the other diagonal of the matrix (top-right to bottom-left). More...
 
class  BlockDiagonalPreconditioner
 Block diagonal preconditioner. By default SuperLU is used to solve the subsidiary systems, but other preconditioners can be used by setting them using passing a pointer to a function of type SubsidiaryPreconditionerFctPt to the method subsidiary_preconditioner_function_pt(). More...
 
class  BlockHopfLinearSolver
 
class  BlockPitchForkLinearSolver
 
class  BlockPreconditioner
 
class  BlockSelector
 Data structure to store information about a certain "block" or sub-matrix from the overall matrix in the block preconditioning framework. More...
 
class  BlockTriangularPreconditioner
 General purpose block triangular preconditioner By default this is Upper triangular. By default SuperLUPreconditioner (or SuperLUDistPreconditioner) is used to solve the subsidiary systems, but other preconditioners can be used by setting them using passing a pointer to a function of type SubsidiaryPreconditionerFctPt to the method subsidiary_preconditioner_function_pt(). More...
 
class  BoundaryNode
 A template Class for BoundaryNodes; that is Nodes that MAY live on the boundary of a Mesh. The class is formed by a simple composition of the template parameter NODE_TYPE, which must be a Node class and the BoundaryNodeBase class. Final overloading of functions is always in favour of the BoundaryNodeBase implementation; i.e. these nodes can live on boundaries. More...
 
class  BoundaryNodeBase
 A class that contains the information required by Nodes that are located on Mesh boundaries. A BoundaryNode of a particular type is obtained by combining a given Node with this class. By differentiating between Nodes and BoundaryNodes we avoid a lot of un-necessary storage in the bulk Nodes. More...
 
class  BoundingElementType
 This policy class is used to associate specific bounding elements with specific FluidInterface elements. It must be filled in for every class that uses the SpineUpdateFluidInterface<...> or ElasticUpdateFluidInterface<....> generic template classes. Examples for our default Line, Axisymmetric and Surface types are included below. More...
 
class  BoundingElementType< ElasticUpdateFluidInterfaceElement< FluidInterfaceElement, AxisymmetricDerivatives, ELEMENT > >
 
class  BoundingElementType< ElasticUpdateFluidInterfaceElement< FluidInterfaceElement, LineDerivatives, ELEMENT > >
 Define the BoundingElement type associated with the 1D surface element. More...
 
class  BoundingElementType< ElasticUpdateFluidInterfaceElement< FluidInterfaceElement, SurfaceDerivatives, ELEMENT > >
 
class  BoundingElementType< ElasticUpdateFluidInterfaceElement< SurfactantTransportInterfaceElement, AxisymmetricDerivatives, ELEMENT > >
 
class  BoundingElementType< SpineUpdateFluidInterfaceElement< FluidInterfaceElement, AxisymmetricDerivatives, ELEMENT > >
 
class  BoundingElementType< SpineUpdateFluidInterfaceElement< FluidInterfaceElement, LineDerivatives, ELEMENT > >
 
class  BoundingElementType< SpineUpdateFluidInterfaceElement< FluidInterfaceElement, SurfaceDerivatives, ELEMENT > >
 
class  BoundingElementType< SpineUpdateFluidInterfaceElement< SurfactantTransportInterfaceElement, AxisymmetricDerivatives, ELEMENT > >
 
class  BoundingElementType< SpineUpdateFluidInterfaceElement< SurfactantTransportInterfaceElement, LineDerivatives, ELEMENT > >
 
class  BoundingElementType< SpineUpdateFluidInterfaceElement< SurfactantTransportInterfaceElement, SurfaceDerivatives, ELEMENT > >
 
class  BrethertonSpineMesh
 
class  BrickElementBase
 Base class for all brick elements. More...
 
class  BrickFromTetMesh
 
class  BrickMeshBase
 Base class for brick meshes (meshes made of 3D brick elements). More...
 
class  BuoyantQCrouzeixRaviartElement
 
class  C1BermudezPMLMapping
 
class  C1CurvedElement
 
class  C1CurvedElement< 2, NNODE_1D >
 C1CurvedElement elements, specialised to two spatial dimensions. More...
 
class  C1CurvedElementBase
 
class  C1CurvedElementShape
 
class  C1CurvedElementShape< 2, NNODE_1D >
 
class  CassonTanMilRegWithBlendingConstitutiveEquation
 
class  CCComplexMatrix
 A class for compressed column matrices that store doubles. More...
 
class  CCDoubleMatrix
 A class for compressed column matrices that store doubles. More...
 
class  CCMatrix
 A class for compressed column matrices: a sparse matrix format The class is passed as the MATRIX_TYPE paramater so that the base class can use the specific access functions in the round-bracket operator. More...
 
class  CG
 The conjugate gradient method. More...
 
class  CGALSamplePointContainerParameters
 Helper object for dealing with the parameters used for the CGALSamplePointContainer objects. More...
 
class  ChannelSpineMesh
 
class  ChannelWithLeafletDomain
 
class  ChannelWithLeafletMesh
 Channel with leaflet mesh. More...
 
class  Circle
 Circle in 2D space.

\[ x = X_c + R \cos(\zeta) \]

\[ y = Y_c + R \sin(\zeta) \]

. More...

 
class  CircularCylindricalShellMesh
 
class  ClampedHermiteShellBoundaryConditionElement
 
class  ClampedSlidingHermiteBeamBoundaryConditionElement
 
struct  classcomp
 
class  CollapsibleChannelDomain
 Collapsible channel domain. More...
 
class  CollapsibleChannelMesh
 Basic collapsible channel mesh. The mesh is derived from the SimpleRectangularQuadMesh so it's node and element numbering scheme is the same as in that mesh. Only the boundaries are numbered differently to allow the easy identification of the "collapsible" segment. Boundary coordinates are set up for all nodes located on boundary 3 (the collapsible segment). The curvilinear ("collapsible") segment is defined by a GeomObject. More...
 
class  CompareBoundaryCoordinate
 A class to do comparison of the elements by lexicographic ordering, based on the boundary coordinates at the element's first node. More...
 
class  ComplexDampedJacobi
 
class  ComplexGMRES
 The GMRES method rewritten for complex matrices. More...
 
class  ComplexMatrixBase
 Abstract base class for matrices of complex doubles – adds abstract interfaces for solving, LU decomposition and multiplication by vectors. More...
 
class  CompressedMatrixCoefficient
 Class for a compressed-matrix coefficent (for either CC or CR matrices). Contains the (row or column) index and value of a coefficient in a compressed row or column. Currently only used in ILU(0) for CCDoubleMatrices to allow the coefficients in each compressed column [row] to be sorted by their row [column] index. More...
 
class  Conformal2DPMLElement
 
class  ConstitutiveLaw
 
class  ContinuationStorageScheme
 GeneralisedTimestepper used to store the arclength derivatives and pervious solutions required in continuation problems. The data is stored as auxilliary data in the (fake) TimeStepper so that spatial adaptivity will be handled automatically through our standard mechanisms. The adopted storage scheme is that the continuation derivatives will be stored at the first auxilliary value and the previous value will be the second auixilliary value. More...
 
class  CopiedData
 Custom Data class that is used when making a shallow copy of a data object. The class contains a copy of an entire other Data object. More...
 
class  CRComplexMatrix
 A class for compressed row matrices. More...
 
class  CRDoubleMatrix
 A class for compressed row matrices. This is a distributable object. More...
 
class  CRMatrix
 A class for compressed row matrices, a sparse storage format Once again the recursive template trick is used to inform that base class that is should use the access functions provided in the CRMatrix class. More...
 
class  CurvedTGauss
 
class  CurvedTGauss< 2, 2 >
 
class  CylinderWithFlagDomain
 Domain for cylinder with flag as in Turek benchmark. More...
 
class  CylinderWithFlagMesh
 
class  DampedJacobi
 
class  DarcyEquations
 Class implementing the generic maths of the Darcy equations using Raviart-Thomas elements with both edge and internal degrees of freedom. More...
 
class  DarcyFaceElement
 
class  Data
 A class that represents a collection of data; each Data object may contain many different individual values, as would be natural in non-scalar problems. Data provides storage for auxiliary `history' values that are used by TimeStepper objects to calculate the time derivatives of the stored data and also stores a pointer to the appropriate TimeStepper object. In addition, an associated (global) equation number is stored for each value. More...
 
class  DenseComplexMatrix
 Class of matrices containing double complex, and stored as a DenseMatrix<complex<double> >, but with solving functionality inherited from the abstract ComplexMatrix class. More...
 
class  DenseDoubleMatrix
 Class of matrices containing doubles, and stored as a DenseMatrix<double>, but with solving functionality inherited from the abstract DoubleMatrix class. More...
 
class  DenseLU
 Dense LU decomposition-based solve of full assembled linear system. VERY inefficient but useful to illustrate the principle. Only suitable for use with Serial matrices and vectors. This solver will only work with non-distributed matrices and vectors (note: DenseDoubleMatrix is not distributable) More...
 
class  DenseMatrix
 Class for dense matrices, storing all the values of the matrix as a pointer to a pointer with assorted output functions inherited from Matrix<T>. The curious recursive template pattern is used here to pass the specific class to the base class so that round bracket access can be inlined. More...
 
class  DeviatoricIsotropicElasticityTensor
 
class  DGElement
 A Base class for DGElements. More...
 
class  DGEulerFaceElement
 FaceElement for Discontinuous Galerkin Problems. More...
 
class  DGEulerFaceReflectionElement
 FaceElement for Discontinuous Galerkin Problems with reflection boundary conditions. More...
 
class  DGFaceElement
 Base class for Discontinuous Galerkin Faces. These are responsible for calculating the normal fluxes that provide the communication between the discontinuous elements. More...
 
class  DGMesh
 
class  DGScalarAdvectionElement
 General DGScalarAdvectionClass. Establish the template parameters. More...
 
class  DGScalarAdvectionElement< 1, NNODE_1D >
 
class  DGScalarAdvectionElement< 2, NNODE_1D >
 Specialisation for 2D DG Elements. More...
 
class  DGScalarAdvectionFaceElement
 FaceElement for Discontinuous Galerkin Problems. More...
 
class  DGSpectralEulerElement
 General DGEulerClass. Establish the template parameters. More...
 
class  DGSpectralEulerElement< 1, NNODE_1D >
 
class  DGSpectralEulerElement< 2, NNODE_1D >
 Specialisation for 2D DG Elements. More...
 
class  DGSpectralScalarAdvectionElement
 General DGScalarAdvectionClass. Establish the template parameters. More...
 
class  DGSpectralScalarAdvectionElement< 1, NNODE_1D >
 
class  DGSpectralScalarAdvectionElement< 2, NNODE_1D >
 Specialisation for 2D DG Elements. More...
 
class  DiagHermiteShellElement
 
class  DiagonalComplexMatrix
 
class  DiagQHermiteElement
 
class  DiskLikeGeomObjectWithBoundaries
 
class  DisplacementBasedFoepplvonKarmanEquations
 
class  DisplacementControlElement
 Displacement control element: In the "normal" formulation of solid mechanics problems, the external load is given and the displacement throughout the solid body is computed. For highly nonlinear problems it is sometimes helpful to re-formulate the problem by prescribing the position of a selected control point and treating the (scalar) load level required to achieve this deformation as an unknown. As an example consider the buckling of pressure-loaded, thin-walled elastic shells. The load-displacement characteristics of such structures tend to be highly nonlinear and bifurcations from the structure's pre-buckling state often occur via sub-critical bifurcations. If we have some a-priori knowledge of the expected deformation (for example, during the non-axisymmetric buckling of a circular cylindrical shell certain material points will be displaced radially inwards), it is advantageous to prescribe the radial displacement of a carefully selected control point and treat the external pressure as an unknown. More...
 
class  DistributableLinearAlgebraObject
 Base class for any linear algebra object that is distributable. Just contains storage for the LinearAlgebraDistribution object and access functions. More...
 
class  DistributionPredicate
 Class to allow sorting of column indices in conversion to epetra matrix. More...
 
class  DocInfo
 Information for documentation of results: Directory and file number to enable output in the form RESLT/filename11.dat, say. Documentation can be switched on and off. More...
 
class  DocLinearSolverInfo
 Collection of data structures for storing information about linear solves. Currently only contains storage for the iteration counts and the linear solver time. More...
 
class  Domain
 Base class for Domains with curvilinear and/or time-dependent boundaries. Domain boundaries are typically represented by GeomObject s and the Domain itself is decomposed into a number of MacroElement s as shown in this 2D example: More...
 
class  DoubleMatrixBase
 Abstract base class for matrices of doubles – adds abstract interfaces for solving, LU decomposition and multiplication by vectors. More...
 
class  DoubleMultiVector
 A multi vector in the mathematical sense, initially developed for linear algebra type applications. If MPI then this multi vector can be distributed - its distribution is described by the LinearAlgebraDistribution object at Distribution_pt. Data is stored in a C-style pointer vector (double*) More...
 
class  DoubleMultiVectorOperator
 
class  DoubleVector
 A vector in the mathematical sense, initially developed for linear algebra type applications. If MPI then this vector can be distributed - its distribution is described by the LinearAlgebraDistribution object at Distribution_pt. Data is stored in a C-style pointer vector (double*) More...
 
class  DoubleVectorHaloScheme
 
class  DoubleVectorWithHaloEntries
 
class  DShape
 
class  DummyAlgebraicMesh
 Dummy algebraic mesh – used for default assignements. More...
 
class  DummyBlockPreconditioner
 
class  DummyBrickElement
 
class  DummyErrorEstimator
 
class  DummyFaceElement
 
class  DummyMesh
 Dummy mesh that can be created and deleted in SolidICProblem. More...
 
class  EBDF3
 
class  Edge
 Edge class. More...
 
class  EigenProblemHandler
 A class that is used to define the functions used to assemble the elemental contributions to the mass matrix and jacobian (stiffness) matrix that define a generalised eigenproblem. More...
 
class  EigenSolver
 
class  EighthSphereDomain
 Eighth sphere as domain. Domain is parametrised by four macro elements. More...
 
class  EighthSphereMesh
 
class  ElasticAxisymmetricFluidInterfaceElement
 Specialise the Elastic update case to axisymmetric equations. More...
 
class  ElasticAxisymmetricSurfactantTransportInterfaceElement
 Specialise to the Axisymmetric geometry. More...
 
class  ElasticAxisymmetricVolumeConstraintBoundingElement
 
class  ElasticityTensor
 
class  ElasticLineFluidInterfaceBoundingElement
 Pseudo-elasticity version of the LineFluidInterfaceBoundingElement. More...
 
class  ElasticLineFluidInterfaceElement
 Specialise the elastic update template class to concrete 1D case. More...
 
class  ElasticLineVolumeConstraintBoundingElement
 
class  ElasticPointFluidInterfaceBoundingElement
 Pseudo-elasticity version of the PointFluidInterfaceBoundingElement. More...
 
class  ElasticQuarterPipeMesh
 
class  ElasticRectangularQuadMesh
 
class  ElasticRefineableQuarterPipeMesh
 Refineable elastic quarter pipe mesh class. More...
 
class  ElasticRefineableRectangularQuadMesh
 
class  ElasticSurfaceFluidInterfaceElement
 Specialise Elastic update case to the concrete 2D case. More...
 
class  ElasticSurfaceVolumeConstraintBoundingElement
 
class  ElasticUpdateFluidInterfaceElement
 Generic Elastic node update interface template class that can be combined with a given surface equations class and surface derivative class to provide a concrete implementation of any surface element that uses elastic node updates. More...
 
class  ElementWithDragFunction
 
class  ElementWithExternalElement
 
class  ElementWithMovingNodes
 A policy class that serves to establish the common interfaces for elements that contain moving nodes. This class provides storage for the geometric data that affect the update of all the nodes of the element, i.e. USUALLY all data that are using during a call to the Element's node_update() function. In some cases (e.g. FluidInterfaceEdge elements), node_update() is overloaded to perform an update of the bulk element, in which case the additional bulk geometric data become external data of the element and the function GeneralisedElement::update_in_external_fd(i) is overloaded to also perform the bulk node update. The storage is populated during the assignment of the equation numbers via the complete_setup_of_dependencies() function and then local equations numbers are assigned to these data, accessible via geometric_data_local_eqn(n,i). Finally, a function is provided that calculates the terms in the jacobian matrix by due to these geometric data by finite differences. More...
 
class  ElementWithSpecificMovingNodes
 
class  ElementWithZ2ErrorEstimator
 Base class for finite elements that can compute the quantities that are required for the Z2 error estimator. More...
 
class  Ellipse
 Steady ellipse with half axes A and B as geometric object:

\[ x = A \cos(\zeta) \]

\[ y = B \sin(\zeta) \]

. More...

 
class  EllipticalTube
 Elliptical tube with half axes a and b. More...
 
class  EquivalentQElement
 
class  EquivalentQElement< ProjectablePMLFourierDecomposedHelmholtzElement< TPMLFourierDecomposedHelmholtzElement< NNODE_1D, PML_ELEMENT > > >
 
class  EquivalentQElement< ProjectablePMLHelmholtzElement< TPMLHelmholtzElement< 2, NNODE_1D, PML_ELEMENT > > >
 
class  EquivalentQElement< ProjectablePMLTimeHarmonicLinearElasticityElement< TPMLTimeHarmonicLinearElasticityElement< 2, NNODE_1D, PML_ELEMENT > > >
 
class  EquivalentQElement< QPMLFourierDecomposedHelmholtzElement< NNODE_1D, PML_ELEMENT > >
 
class  EquivalentQElement< QPMLHelmholtzElement< 2, NNODE_1D, PML_ELEMENT > >
 
class  EquivalentQElement< QPMLTimeHarmonicLinearElasticityElement< 2, NNODE_1D, PML_ELEMENT > >
 
class  EquivalentQElement< RefineableQPMLHelmholtzElement< 2, NNODE_1D, PML_ELEMENT > >
 
class  EquivalentQElement< TPMLFourierDecomposedHelmholtzElement< NNODE_1D, PML_ELEMENT > >
 
class  EquivalentQElement< TPMLHelmholtzElement< 2, NNODE_1D, PML_ELEMENT > >
 
class  EquivalentQElement< TPMLTimeHarmonicLinearElasticityElement< 2, NNODE_1D, PML_ELEMENT > >
 
class  ErrorEstimator
 Base class for spatial error estimators. More...
 
class  Euler
 
class  EulerEquations
 Base class for Euler equations. More...
 
class  ExactBlockPreconditioner
 
class  ExactSubBiharmonicPreconditioner
 Sub Biharmonic Preconditioner - an exact preconditioner for the 3x3 top left hand corner sub block matrix. Used as part of the BiharmonicPreconditioner<MATRIX> . By default this uses the BBD (block-bordered-diagonal/arrow-shaped) preconditioner; can also switch to full BD version (in which case all the 3x3 blocks are retained) More...
 
class  ExplicitTimeStepHandler
 A class that is used to define the functions used to assemble and invert the mass matrix when taking an explicit timestep. The idea is simply to replace the jacobian matrix with the mass matrix and then our standard linear solvers will solve the required system. More...
 
class  ExplicitTimeSteppableObject
 
class  ExplicitTimeStepper
 A Base class for explicit timesteppers. More...
 
class  FaceElement
 
class  FaceElementAsGeomObject
 
class  FaceGeometry
 
class  FaceGeometry< AlgebraicElement< ELEMENT > >
 Explicit definition of the face geometry of algebraic elements: the same as the face geometry of the underlying element. More...
 
class  FaceGeometry< AxisymDiagHermitePVDElement >
 Explicit definition of the face geometry for the. More...
 
class  FaceGeometry< AxisymmetricQCrouzeixRaviartElement >
 Face geometry of the Axisymmetric Crouzeix_Raviart elements. More...
 
class  FaceGeometry< AxisymmetricQTaylorHoodElement >
 Face geometry of the Axisymmetric Taylor_Hood elements. More...
 
class  FaceGeometry< AxisymmetricTCrouzeixRaviartElement >
 Face geometry of the 2D Crouzeix_Raviart elements. More...
 
class  FaceGeometry< AxisymmetricTTaylorHoodElement >
 Face geometry of the Axisymmetric Taylor_Hood elements. More...
 
class  FaceGeometry< AxisymQPVDElement >
 
class  FaceGeometry< AxisymQPVDElementWithPressure >
 
class  FaceGeometry< BiharmonicElement< 1 > >
 
class  FaceGeometry< BiharmonicElement< DIM > >
 face geometry for biharmonic elements - template parameter indicates dimension of problem (i.e. bulk element), not the face elements More...
 
class  FaceGeometry< BuoyantQCrouzeixRaviartElement< DIM > >
 Face geometry of the 2D Buoyant Crouzeix_Raviart elements. More...
 
class  FaceGeometry< C1CurvedElement< 2, NNODE_1D > >
 
class  FaceGeometry< DGScalarAdvectionElement< 1, NNODE_1D > >
 Face geometry of the 1D DG elements. More...
 
class  FaceGeometry< DGScalarAdvectionElement< 2, NNODE_1D > >
 Face geometry of the DG elements. More...
 
class  FaceGeometry< DGSpectralEulerElement< 1, NNODE_1D > >
 Face geometry of the 1D DG elements. More...
 
class  FaceGeometry< DGSpectralEulerElement< 2, NNODE_1D > >
 Face geometry of the DG elements. More...
 
class  FaceGeometry< DGSpectralScalarAdvectionElement< 1, NNODE_1D > >
 Face geometry of the 1D DG elements. More...
 
class  FaceGeometry< DGSpectralScalarAdvectionElement< 2, NNODE_1D > >
 Face geometry of the DG elements. More...
 
class  FaceGeometry< EquivalentQElement< TPMLHelmholtzElement< DIM, NNODE_1D, PML_ELEMENT > > >
 
class  FaceGeometry< EquivalentQElement< TPMLTimeHarmonicLinearElasticityElement< DIM, NNODE_1D, PML_ELEMENT > > >
 
class  FaceGeometry< FaceGeometry< AxisymmetricQCrouzeixRaviartElement > >
 
class  FaceGeometry< FaceGeometry< AxisymmetricQTaylorHoodElement > >
 Face geometry of the face geometry of the Axisymmetric Taylor_Hood elements. More...
 
class  FaceGeometry< FaceGeometry< AxisymmetricTCrouzeixRaviartElement > >
 Face geometry of the FaceGeometry of the 2D CrouzeixRaviart elements. More...
 
class  FaceGeometry< FaceGeometry< AxisymmetricTTaylorHoodElement > >
 Face geometry of the FaceGeometry of the Axisymmetric TaylorHood elements. More...
 
class  FaceGeometry< FaceGeometry< BuoyantQCrouzeixRaviartElement< 2 > > >
 Face geometry of the Face geometry of 2D Buoyant Crouzeix_Raviart elements. More...
 
class  FaceGeometry< FaceGeometry< GeneralisedNewtonianAxisymmetricQCrouzeixRaviartElement > >
 
class  FaceGeometry< FaceGeometry< GeneralisedNewtonianAxisymmetricQTaylorHoodElement > >
 
class  FaceGeometry< FaceGeometry< GeneralisedNewtonianAxisymmetricTCrouzeixRaviartElement > >
 Face geometry of the FaceGeometry of the 2D CrouzeixRaviart elements. More...
 
class  FaceGeometry< FaceGeometry< GeneralisedNewtonianAxisymmetricTTaylorHoodElement > >
 Face geometry of the FaceGeometry of the. More...
 
class  FaceGeometry< FaceGeometry< GeneralisedNewtonianProjectableAxisymmetricCrouzeixRaviartElement< ELEMENT > > >
 
class  FaceGeometry< FaceGeometry< GeneralisedNewtonianProjectableAxisymmetricTaylorHoodElement< ELEMENT > > >
 
class  FaceGeometry< FaceGeometry< GeneralisedNewtonianQCrouzeixRaviartElement< 2 > > >
 Face geometry of the FaceGeometry of the 2D Crouzeix_Raviart elements. More...
 
class  FaceGeometry< FaceGeometry< GeneralisedNewtonianQCrouzeixRaviartElement< 3 > > >
 Face geometry of the FaceGeometry of the 3D Crouzeix_Raviart elements. More...
 
class  FaceGeometry< FaceGeometry< GeneralisedNewtonianQTaylorHoodElement< 2 > > >
 Face geometry of the FaceGeometry of the 2D Taylor Hoodelements. More...
 
class  FaceGeometry< FaceGeometry< GeneralisedNewtonianQTaylorHoodElement< 3 > > >
 Face geometry of the FaceGeometry of the 3D Taylor_Hood elements. More...
 
class  FaceGeometry< FaceGeometry< GeneralisedNewtonianTCrouzeixRaviartElement< 2 > > >
 Face geometry of the FaceGeometry of the 2D CrouzeixRaviart elements. More...
 
class  FaceGeometry< FaceGeometry< GeneralisedNewtonianTCrouzeixRaviartElement< 3 > > >
 Face geometry of the FaceGeometry of the 3D Crouzeix_Raviart elements. More...
 
class  FaceGeometry< FaceGeometry< GeneralisedNewtonianTTaylorHoodElement< 2 > > >
 Face geometry of the FaceGeometry of the 2D TaylorHood elements. More...
 
class  FaceGeometry< FaceGeometry< GeneralisedNewtonianTTaylorHoodElement< 3 > > >
 Face geometry of the FaceGeometry of the 3D Crouzeix_Raviart elements. More...
 
class  FaceGeometry< FaceGeometry< Hijacked< ELEMENT > > >
 Explicit definition of the face geometry of hijacked elements: the same as the face geometry of the underlying element. More...
 
class  FaceGeometry< FaceGeometry< LinearisedAxisymmetricQCrouzeixRaviartElement > >
 Face geometry of face geometry of the linearised axisymmetric Crouzeix Raviart elements. More...
 
class  FaceGeometry< FaceGeometry< LinearisedAxisymmetricQTaylorHoodElement > >
 Face geometry of the face geometry of the linearised axisymmetric Taylor Hood elements. More...
 
class  FaceGeometry< FaceGeometry< LinearisedQCrouzeixRaviartElement > >
 Face geometry of face geometry of the linearised axisymmetric Crouzeix Raviart elements. More...
 
class  FaceGeometry< FaceGeometry< LinearisedQTaylorHoodElement > >
 Face geometry of the face geometry of the linearised axisymmetric Taylor Hood elements. More...
 
class  FaceGeometry< FaceGeometry< NavierStokesBoussinesqElement< NST_ELEMENT, AD_ELEMENT > > >
 Explicit definition of the face geometry of these elements. More...
 
class  FaceGeometry< FaceGeometry< ProjectableAxisymLinearElasticityElement< ELEMENT > > >
 
class  FaceGeometry< FaceGeometry< ProjectableAxisymmetricCrouzeixRaviartElement< ELEMENT > > >
 
class  FaceGeometry< FaceGeometry< ProjectableAxisymmetricTaylorHoodElement< ELEMENT > > >
 
class  FaceGeometry< FaceGeometry< ProjectableCrouzeixRaviartElement< ELEMENT > > >
 
class  FaceGeometry< FaceGeometry< ProjectableDisplacementBasedFoepplvonKarmanElement< ELEMENT > > >
 
class  FaceGeometry< FaceGeometry< ProjectableFoepplvonKarmanElement< ELEMENT > > >
 
class  FaceGeometry< FaceGeometry< ProjectableFourierDecomposedHelmholtzElement< ELEMENT > > >
 
class  FaceGeometry< FaceGeometry< ProjectableGeneralisedNewtonianCrouzeixRaviartElement< ELEMENT > > >
 
class  FaceGeometry< FaceGeometry< ProjectableGeneralisedNewtonianTaylorHoodElement< ELEMENT > > >
 
class  FaceGeometry< FaceGeometry< ProjectableHelmholtzElement< ELEMENT > > >
 
class  FaceGeometry< FaceGeometry< ProjectableLinearElasticityElement< ELEMENT > > >
 
class  FaceGeometry< FaceGeometry< ProjectablePMLFourierDecomposedHelmholtzElement< ELEMENT > > >
 
class  FaceGeometry< FaceGeometry< ProjectablePMLTimeHarmonicLinearElasticityElement< ELEMENT > > >
 
class  FaceGeometry< FaceGeometry< ProjectablePoissonElement< ELEMENT > > >
 
class  FaceGeometry< FaceGeometry< ProjectablePVDElement< ELEMENT > > >
 
class  FaceGeometry< FaceGeometry< ProjectablePVDElementWithContinuousPressure< ELEMENT > > >
 
class  FaceGeometry< FaceGeometry< ProjectableTaylorHoodElement< ELEMENT > > >
 
class  FaceGeometry< FaceGeometry< ProjectableTimeHarmonicFourierDecomposedLinearElasticityElement< ELEMENT > > >
 
class  FaceGeometry< FaceGeometry< ProjectableTimeHarmonicLinearElasticityElement< ELEMENT > > >
 
class  FaceGeometry< FaceGeometry< ProjectableUnsteadyHeatElement< ELEMENT > > >
 
class  FaceGeometry< FaceGeometry< PseudoSolidNodeUpdateElement< BASIC, SOLID > > >
 Explicit definition of the face geometry of these elements. More...
 
class  FaceGeometry< FaceGeometry< QCrouzeixRaviartElement< 2 > > >
 Face geometry of the FaceGeometry of the 2D Crouzeix_Raviart elements. More...
 
class  FaceGeometry< FaceGeometry< QCrouzeixRaviartElement< 3 > > >
 Face geometry of the FaceGeometry of the 3D Crouzeix_Raviart elements. More...
 
class  FaceGeometry< FaceGeometry< QPVDElement< 2, NNODE_1D > > >
 FaceGeometry of the FaceGeometry of the 2D QPVDElement. More...
 
class  FaceGeometry< FaceGeometry< QPVDElement< 3, NNODE_1D > > >
 FaceGeometry of FaceGeometry of a 3D QPVDElement element. More...
 
class  FaceGeometry< FaceGeometry< QPVDElementWithContinuousPressure< 2 > > >
 
class  FaceGeometry< FaceGeometry< QPVDElementWithContinuousPressure< 3 > > >
 
class  FaceGeometry< FaceGeometry< QPVDElementWithPressure< 2 > > >
 FaceGeometry of FaceGeometry of 2D QPVDElementWithPressure. More...
 
class  FaceGeometry< FaceGeometry< QPVDElementWithPressure< 3 > > >
 FaceGeometry of FaceGeometry of 3D QPVDElementWithPressure. More...
 
class  FaceGeometry< FaceGeometry< QSphericalCrouzeixRaviartElement > >
 
class  FaceGeometry< FaceGeometry< QSphericalTaylorHoodElement > >
 Face geometry of the FaceGeometry of the 2D Taylor Hoodelements. More...
 
class  FaceGeometry< FaceGeometry< QTaylorHoodElement< 2 > > >
 Face geometry of the FaceGeometry of the 2D Taylor Hoodelements. More...
 
class  FaceGeometry< FaceGeometry< QTaylorHoodElement< 3 > > >
 Face geometry of the FaceGeometry of the 3D Taylor_Hood elements. More...
 
class  FaceGeometry< FaceGeometry< RefineableAxisymmetricQCrouzeixRaviartElement > >
 Face geometry of the RefineableQuadQCrouzeixRaviartElements. More...
 
class  FaceGeometry< FaceGeometry< RefineableAxisymmetricQTaylorHoodElement > >
 Face geometry of the RefineableQuadQTaylorHoodElements. More...
 
class  FaceGeometry< FaceGeometry< RefineableGeneralisedNewtonianAxisymmetricQCrouzeixRaviartElement > >
 Face geometry of the RefineableQuadQCrouzeixRaviartElements. More...
 
class  FaceGeometry< FaceGeometry< RefineableGeneralisedNewtonianAxisymmetricQTaylorHoodElement > >
 Face geometry of the RefineableQuadQTaylorHoodElements. More...
 
class  FaceGeometry< FaceGeometry< RefineableGeneralisedNewtonianQCrouzeixRaviartElement< DIM > > >
 Face geometry of the face geometry of the RefineableQCrouzeixRaviartElements is the same as the Face geometry of the Face geometry of QCrouzeixRaviartElements. More...
 
class  FaceGeometry< FaceGeometry< RefineableGeneralisedNewtonianQTaylorHoodElement< DIM > > >
 Face geometry of the face geometry of the RefineableQTaylorHoodElements is the same as the Face geometry of the Face geometry of QTaylorHoodElements. More...
 
class  FaceGeometry< FaceGeometry< RefineableLinearisedAxisymmetricQCrouzeixRaviartElement > >
 Face geometry of face geometric of the refineable linearised axisym Crouzeix-Raviart elements. More...
 
class  FaceGeometry< FaceGeometry< RefineableLinearisedAxisymmetricQTaylorHoodElement > >
 Face geometry of face geometric of the refineable linearised axisym Taylor-Hood elements. More...
 
class  FaceGeometry< FaceGeometry< RefineableLinearisedQCrouzeixRaviartElement > >
 Face geometry of face geometric of the refineable linearised axisym Crouzeix-Raviart elements. More...
 
class  FaceGeometry< FaceGeometry< RefineableLinearisedQTaylorHoodElement > >
 Face geometry of face geometric of the refineable linearised axisym Taylor-Hood elements. More...
 
class  FaceGeometry< FaceGeometry< RefineablePseudoSolidNodeUpdateElement< BASIC, SOLID > > >
 Explicit definition of the face geometry of these elements. More...
 
class  FaceGeometry< FaceGeometry< RefineableQCrouzeixRaviartElement< DIM > > >
 Face geometry of the face geometry of the RefineableQCrouzeixRaviartElements is the same as the Face geometry of the Face geometry of QCrouzeixRaviartElements. More...
 
class  FaceGeometry< FaceGeometry< RefineableQLinearElasticityElement< 2, NNODE_1D > > >
 
class  FaceGeometry< FaceGeometry< RefineableQLinearElasticityElement< 3, NNODE_1D > > >
 
class  FaceGeometry< FaceGeometry< RefineableQPVDElement< 2, NNODE_1D > > >
 FaceGeometry of the FaceGeometry of the 2D RefineableQPVDElement. More...
 
class  FaceGeometry< FaceGeometry< RefineableQPVDElement< 3, NNODE_1D > > >
 FaceGeometry of the FaceGeometry of the 3D RefineableQPVDElement. More...
 
class  FaceGeometry< FaceGeometry< RefineableQPVDElementWithContinuousPressure< 2 > > >
 
class  FaceGeometry< FaceGeometry< RefineableQPVDElementWithContinuousPressure< 3 > > >
 
class  FaceGeometry< FaceGeometry< RefineableQPVDElementWithPressure< 2 > > >
 FaceGeometry of the FaceGeometry of the 2D RefineableQPVDElementWithPressure. More...
 
class  FaceGeometry< FaceGeometry< RefineableQPVDElementWithPressure< 3 > > >
 FaceGeometry of the FaceGeometry of the 3D RefineableQPVDElementWithPressure. More...
 
class  FaceGeometry< FaceGeometry< RefineableQSphericalCrouzeixRaviartElement > >
 Face geometry of the RefineableQuadQCrouzeixRaviartElements. More...
 
class  FaceGeometry< FaceGeometry< RefineableQSphericalTaylorHoodElement > >
 Face geometry of the RefineableQuadQTaylorHoodElements. More...
 
class  FaceGeometry< FaceGeometry< RefineableQTaylorHoodElement< DIM > > >
 Face geometry of the face geometry of the RefineableQTaylorHoodElements is the same as the Face geometry of the Face geometry of QTaylorHoodElements. More...
 
class  FaceGeometry< FaceGeometry< RefineableQTimeHarmonicLinearElasticityElement< 2, NNODE_1D > > >
 
class  FaceGeometry< FaceGeometry< RefineableQTimeHarmonicLinearElasticityElement< 3, NNODE_1D > > >
 
class  FaceGeometry< FaceGeometry< SpineElement< ELEMENT > > >
 Explicit definition of the face geometry for spine elements: The same as the face geometry of the underlying element. More...
 
class  FaceGeometry< FaceGeometry< TCrouzeixRaviartElement< 2 > > >
 Face geometry of the FaceGeometry of the 2D CrouzeixRaviart elements. More...
 
class  FaceGeometry< FaceGeometry< TCrouzeixRaviartElement< 3 > > >
 Face geometry of the FaceGeometry of the 3D Crouzeix_Raviart elements. More...
 
class  FaceGeometry< FaceGeometry< TPVDBubbleEnrichedElement< 2, NNODE_1D > > >
 FaceGeometry of the FaceGeometry of the 2D TPVDBubbleEnrichedElement. More...
 
class  FaceGeometry< FaceGeometry< TPVDBubbleEnrichedElement< 3, NNODE_1D > > >
 FaceGeometry of FaceGeometry of a 3D TPVDElement element. More...
 
class  FaceGeometry< FaceGeometry< TPVDElement< 2, NNODE_1D > > >
 FaceGeometry of the FaceGeometry of the 2D TPVDElement. More...
 
class  FaceGeometry< FaceGeometry< TPVDElement< 3, NNODE_1D > > >
 FaceGeometry of FaceGeometry of a 3D TPVDElement element. More...
 
class  FaceGeometry< FaceGeometry< TTaylorHoodElement< 2 > > >
 Face geometry of the FaceGeometry of the 2D TaylorHood elements. More...
 
class  FaceGeometry< FaceGeometry< TTaylorHoodElement< 3 > > >
 Face geometry of the FaceGeometry of the 3D Crouzeix_Raviart elements. More...
 
class  FaceGeometry< GeneralisedNewtonianAxisymmetricQCrouzeixRaviartElement >
 
class  FaceGeometry< GeneralisedNewtonianAxisymmetricQTaylorHoodElement >
 Face geometry of the GeneralisedNewtonianAxisymmetric Taylor_Hood elements. More...
 
class  FaceGeometry< GeneralisedNewtonianAxisymmetricTCrouzeixRaviartElement >
 Face geometry of the 2D Crouzeix_Raviart elements. More...
 
class  FaceGeometry< GeneralisedNewtonianAxisymmetricTTaylorHoodElement >
 Face geometry of the GeneralisedNewtonianAxisymmetric Taylor_Hood elements. More...
 
class  FaceGeometry< GeneralisedNewtonianProjectableAxisymmetricCrouzeixRaviartElement< ELEMENT > >
 
class  FaceGeometry< GeneralisedNewtonianProjectableAxisymmetricTaylorHoodElement< ELEMENT > >
 
class  FaceGeometry< GeneralisedNewtonianQCrouzeixRaviartElement< 2 > >
 Face geometry of the 2D Crouzeix_Raviart elements. More...
 
class  FaceGeometry< GeneralisedNewtonianQCrouzeixRaviartElement< 3 > >
 Face geometry of the 3D Crouzeix_Raviart elements. More...
 
class  FaceGeometry< GeneralisedNewtonianQTaylorHoodElement< 2 > >
 Face geometry of the 2D Taylor_Hood elements. More...
 
class  FaceGeometry< GeneralisedNewtonianQTaylorHoodElement< 3 > >
 Face geometry of the 3D Taylor_Hood elements. More...
 
class  FaceGeometry< GeneralisedNewtonianTCrouzeixRaviartElement< 2 > >
 Face geometry of the 2D Crouzeix_Raviart elements. More...
 
class  FaceGeometry< GeneralisedNewtonianTCrouzeixRaviartElement< 3 > >
 Face geometry of the 3D Crouzeix_Raviart elements. More...
 
class  FaceGeometry< GeneralisedNewtonianTTaylorHoodElement< 2 > >
 Face geometry of the 2D Taylor_Hood elements. More...
 
class  FaceGeometry< GeneralisedNewtonianTTaylorHoodElement< 3 > >
 Face geometry of the 3D Taylor_Hood elements. More...
 
class  FaceGeometry< HermiteBeamElement >
 Face geometry for the HermiteBeam elements: Solid point element. More...
 
class  FaceGeometry< HermiteShellElement >
 Face geometry for the HermiteShell elements: 1D SolidQHermiteElement. More...
 
class  FaceGeometry< Hijacked< ELEMENT > >
 Explicit definition of the face geometry of hijacked elements: the same as the face geometry of the underlying element. More...
 
class  FaceGeometry< Hijacked< FaceGeometry< ELEMENT > > >
 Explicit definition of the face geometry of hijacked elements: the same as the face geometry of the underlying element. More...
 
class  FaceGeometry< LinearisedAxisymmetricQCrouzeixRaviartElement >
 Face geometry of the linearised axisym Crouzeix-Raviart elements. More...
 
class  FaceGeometry< LinearisedAxisymmetricQTaylorHoodElement >
 Face geometry of the linearised axisymmetric Taylor Hood elements. More...
 
class  FaceGeometry< LinearisedQCrouzeixRaviartElement >
 Face geometry of the linearised axisym Crouzeix-Raviart elements. More...
 
class  FaceGeometry< LinearisedQTaylorHoodElement >
 Face geometry of the linearised axisymmetric Taylor Hood elements. More...
 
class  FaceGeometry< MacroElementNodeUpdateElement< ELEMENT > >
 
class  FaceGeometry< NavierStokesBoussinesqElement< NST_ELEMENT, AD_ELEMENT > >
 Explicit definition of the face geometry of these elements. More...
 
class  FaceGeometry< PolarCrouzeixRaviartElement >
 Face geometry of the 2D Crouzeix_Raviart elements. More...
 
class  FaceGeometry< PolarTaylorHoodElement >
 Face geometry of the 2D Taylor_Hood elements. More...
 
class  FaceGeometry< ProjectableAxisymLinearElasticityElement< ELEMENT > >
 
class  FaceGeometry< ProjectableAxisymmetricCrouzeixRaviartElement< ELEMENT > >
 
class  FaceGeometry< ProjectableAxisymmetricPoroelasticityElement< ELEMENT > >
 
class  FaceGeometry< ProjectableAxisymmetricTaylorHoodElement< ELEMENT > >
 
class  FaceGeometry< ProjectableCrouzeixRaviartElement< ELEMENT > >
 
class  FaceGeometry< ProjectableDarcyElement< ELEMENT > >
 
class  FaceGeometry< ProjectableDisplacementBasedFoepplvonKarmanElement< ELEMENT > >
 
class  FaceGeometry< ProjectableElement< ELEMENT > >
 
class  FaceGeometry< ProjectableFoepplvonKarmanElement< ELEMENT > >
 
class  FaceGeometry< ProjectableFourierDecomposedHelmholtzElement< ELEMENT > >
 
class  FaceGeometry< ProjectableGeneralisedNewtonianCrouzeixRaviartElement< ELEMENT > >
 
class  FaceGeometry< ProjectableGeneralisedNewtonianTaylorHoodElement< ELEMENT > >
 
class  FaceGeometry< ProjectableHelmholtzElement< ELEMENT > >
 
class  FaceGeometry< ProjectableLinearElasticityElement< ELEMENT > >
 
class  FaceGeometry< ProjectablePMLFourierDecomposedHelmholtzElement< ELEMENT > >
 
class  FaceGeometry< ProjectablePMLHelmholtzElement< ELEMENT > >
 
class  FaceGeometry< ProjectablePMLTimeHarmonicLinearElasticityElement< ELEMENT > >
 
class  FaceGeometry< ProjectablePoissonElement< ELEMENT > >
 
class  FaceGeometry< ProjectablePVDElement< ELEMENT > >
 
class  FaceGeometry< ProjectablePVDElementWithContinuousPressure< ELEMENT > >
 
class  FaceGeometry< ProjectableTaylorHoodElement< ELEMENT > >
 
class  FaceGeometry< ProjectableTimeHarmonicFourierDecomposedLinearElasticityElement< ELEMENT > >
 
class  FaceGeometry< ProjectableTimeHarmonicLinearElasticityElement< ELEMENT > >
 
class  FaceGeometry< ProjectableUnsteadyHeatElement< ELEMENT > >
 
class  FaceGeometry< PseudoSolidNodeUpdateElement< BASIC, SOLID > >
 Explicit definition of the face geometry of these elements. More...
 
class  FaceGeometry< QAdvectionDiffusionElement< 1, NNODE_1D > >
 Face geometry for the 1D QAdvectionDiffusion elements: Point elements. More...
 
class  FaceGeometry< QAdvectionDiffusionElement< DIM, NNODE_1D > >
 Face geometry for the QAdvectionDiffusionElement elements: The spatial dimension of the face elements is one lower than that of the bulk element but they have the same number of points along their 1D edges. More...
 
class  FaceGeometry< QAdvectionDiffusionReactionElement< NREAGENT, 1, NNODE_1D > >
 Face geometry for the 1D QAdvectionDiffusionReaction elements: Point elements. More...
 
class  FaceGeometry< QAdvectionDiffusionReactionElement< NREAGENT, DIM, NNODE_1D > >
 Face geometry for the QAdvectionDiffusionReactionElement elements: The spatial dimension of the face elements is one lower than that of the bulk element but they have the same number of points along their 1D edges. More...
 
class  FaceGeometry< QAxisymAdvectionDiffusionElement< NNODE_1D > >
 
class  FaceGeometry< QAxisymmetricLinearElasticityElement< NNODE_1D > >
 
class  FaceGeometry< QCrouzeixRaviartElement< 2 > >
 Face geometry of the 2D Crouzeix_Raviart elements. More...
 
class  FaceGeometry< QCrouzeixRaviartElement< 3 > >
 Face geometry of the 3D Crouzeix_Raviart elements. More...
 
class  FaceGeometry< QFoepplvonKarmanElement< NNODE_1D > >
 
class  FaceGeometry< QFourierDecomposedHelmholtzElement< NNODE_1D > >
 
class  FaceGeometry< QGeneralisedAdvectionDiffusionElement< 1, NNODE_1D > >
 Face geometry for the 1D QGeneralisedAdvectionDiffusion elements: Point elements. More...
 
class  FaceGeometry< QGeneralisedAdvectionDiffusionElement< DIM, NNODE_1D > >
 Face geometry for the QGeneralisedAdvectionDiffusionElement elements: The spatial dimension of the face elements is one lower than that of the bulk element but they have the same number of points along their 1D edges. More...
 
class  FaceGeometry< QHelmholtzElement< 1, NNODE_1D > >
 Face geometry for the 1D QHelmholtzElement elements: Point elements. More...
 
class  FaceGeometry< QHelmholtzElement< DIM, NNODE_1D > >
 
class  FaceGeometry< QLinearElasticityElement< 2, 2 > >
 FaceGeometry of a linear 2D QLinearElasticityElement element. More...
 
class  FaceGeometry< QLinearElasticityElement< 2, 3 > >
 FaceGeometry of a quadratic 2D QLinearElasticityElement element. More...
 
class  FaceGeometry< QLinearElasticityElement< 2, 4 > >
 FaceGeometry of a cubic 2D QLinearElasticityElement element. More...
 
class  FaceGeometry< QLinearElasticityElement< 3, 2 > >
 FaceGeometry of a linear 3D QLinearElasticityElement element. More...
 
class  FaceGeometry< QLinearElasticityElement< 3, 3 > >
 FaceGeometry of a quadratic 3D QLinearElasticityElement element. More...
 
class  FaceGeometry< QLinearElasticityElement< 3, 4 > >
 FaceGeometry of a cubic 3D QLinearElasticityElement element. More...
 
class  FaceGeometry< QLinearWaveElement< 1, NNODE_1D > >
 Face geometry for the 1D QLinearWaveElement elements: Point elements. More...
 
class  FaceGeometry< QLinearWaveElement< DIM, NNODE_1D > >
 
class  FaceGeometry< QPMLFourierDecomposedHelmholtzElement< NNODE_1D, PML_ELEMENT > >
 
class  FaceGeometry< QPMLHelmholtzElement< 1, NNODE_1D, PML_ELEMENT > >
 
class  FaceGeometry< QPMLHelmholtzElement< DIM, NNODE_1D, PML_ELEMENT > >
 
class  FaceGeometry< QPMLTimeHarmonicLinearElasticityElement< 2, 2, PML_ELEMENT > >
 
class  FaceGeometry< QPMLTimeHarmonicLinearElasticityElement< 2, 3, PML_ELEMENT > >
 
class  FaceGeometry< QPMLTimeHarmonicLinearElasticityElement< 2, 4, PML_ELEMENT > >
 
class  FaceGeometry< QPMLTimeHarmonicLinearElasticityElement< 3, 2, PML_ELEMENT > >
 
class  FaceGeometry< QPMLTimeHarmonicLinearElasticityElement< 3, 3, PML_ELEMENT > >
 
class  FaceGeometry< QPMLTimeHarmonicLinearElasticityElement< 3, 4, PML_ELEMENT > >
 
class  FaceGeometry< QPoissonElement< 1, NNODE_1D > >
 Face geometry for the 1D QPoissonElement elements: Point elements. More...
 
class  FaceGeometry< QPoissonElement< DIM, NNODE_1D > >
 
class  FaceGeometry< QPVDElement< 2, NNODE_1D > >
 FaceGeometry of a 2D QPVDElement element. More...
 
class  FaceGeometry< QPVDElement< 3, NNODE_1D > >
 FaceGeometry of a 3D QPVDElement element. More...
 
class  FaceGeometry< QPVDElementWithContinuousPressure< 2 > >
 FaceGeometry for 2D QPVDElementWithContinuousPressure element. More...
 
class  FaceGeometry< QPVDElementWithContinuousPressure< 3 > >
 FaceGeometry for 3D QPVDElementWithContinuousPressure element. More...
 
class  FaceGeometry< QPVDElementWithPressure< 2 > >
 FaceGeometry of 2D QPVDElementWithPressure. More...
 
class  FaceGeometry< QPVDElementWithPressure< 3 > >
 FaceGeometry of 3D QPVDElementWithPressure. More...
 
class  FaceGeometry< QScalarAdvectionElement< DIM, NNODE_1D > >
 Face geometry for the QScalarAdvectionElement elements: The spatial dimension of the face elements is one lower than that of the bulk element but they have the same number of points along their 1D edges. More...
 
class  FaceGeometry< QSpectralEulerElement< DIM, NNODE_1D > >
 Face geometry for the QEulerElement elements: The spatial dimension of the face elements is one lower than that of the bulk element but they have the same number of points along their 1D edges. More...
 
class  FaceGeometry< QSpectralPoissonElement< 1, NNODE_1D > >
 Face geometry for the 1D QPoissonElement elements: Point elements. More...
 
class  FaceGeometry< QSpectralPoissonElement< DIM, NNODE_1D > >
 
class  FaceGeometry< QSpectralScalarAdvectionElement< DIM, NNODE_1D > >
 Face geometry for the QScalarAdvectionElement elements: The spatial dimension of the face elements is one lower than that of the bulk element but they have the same number of points along their 1D edges. More...
 
class  FaceGeometry< QSphericalAdvectionDiffusionElement< NNODE_1D > >
 
class  FaceGeometry< QSphericalCrouzeixRaviartElement >
 Face geometry of the Spherical Crouzeix_Raviart elements. More...
 
class  FaceGeometry< QSphericalTaylorHoodElement >
 Face geometry of the Spherical Taylor_Hood elements. More...
 
class  FaceGeometry< QSteadyAxisymAdvectionDiffusionElement< NNODE_1D > >
 
class  FaceGeometry< QTaylorHoodElement< 2 > >
 Face geometry of the 2D Taylor_Hood elements. More...
 
class  FaceGeometry< QTaylorHoodElement< 3 > >
 Face geometry of the 3D Taylor_Hood elements. More...
 
class  FaceGeometry< QTimeHarmonicFourierDecomposedLinearElasticityElement< NNODE_1D > >
 
class  FaceGeometry< QTimeHarmonicLinearElasticityElement< 2, 2 > >
 FaceGeometry of a linear 2D QTimeHarmonicLinearElasticityElement element. More...
 
class  FaceGeometry< QTimeHarmonicLinearElasticityElement< 2, 3 > >
 FaceGeometry of a quadratic 2D QTimeHarmonicLinearElasticityElement element. More...
 
class  FaceGeometry< QTimeHarmonicLinearElasticityElement< 2, 4 > >
 FaceGeometry of a cubic 2D QTimeHarmonicLinearElasticityElement element. More...
 
class  FaceGeometry< QTimeHarmonicLinearElasticityElement< 3, 2 > >
 FaceGeometry of a linear 3D QTimeHarmonicLinearElasticityElement element. More...
 
class  FaceGeometry< QTimeHarmonicLinearElasticityElement< 3, 3 > >
 FaceGeometry of a quadratic 3D QTimeHarmonicLinearElasticityElement element. More...
 
class  FaceGeometry< QTimeHarmonicLinearElasticityElement< 3, 4 > >
 FaceGeometry of a cubic 3D QTimeHarmonicLinearElasticityElement element. More...
 
class  FaceGeometry< QUnsteadyHeatElement< 1, NNODE_1D > >
 Face geometry for the 1D QUnsteadyHeatElement elements: Point elements. More...
 
class  FaceGeometry< QUnsteadyHeatElement< DIM, NNODE_1D > >
 
class  FaceGeometry< QWomersleyElement< 1, NNODE_1D > >
 Face geometry for the 1D QWomersleyElement elements: Point elements. More...
 
class  FaceGeometry< QWomersleyElement< DIM, NNODE_1D > >
 
class  FaceGeometry< QYoungLaplaceElement< NNODE_1D > >
 
class  FaceGeometry< RefineableAxisymmetricQCrouzeixRaviartElement >
 Face geometry of the RefineableQuadQCrouzeixRaviartElements. More...
 
class  FaceGeometry< RefineableAxisymmetricQTaylorHoodElement >
 Face geometry of the RefineableQuadQTaylorHoodElements. More...
 
class  FaceGeometry< RefineableGeneralisedNewtonianAxisymmetricQCrouzeixRaviartElement >
 Face geometry of the RefineableQuadQCrouzeixRaviartElements. More...
 
class  FaceGeometry< RefineableGeneralisedNewtonianAxisymmetricQTaylorHoodElement >
 Face geometry of the RefineableQuadQTaylorHoodElements. More...
 
class  FaceGeometry< RefineableGeneralisedNewtonianQCrouzeixRaviartElement< DIM > >
 Face geometry of the RefineableQuadQCrouzeixRaviartElements. More...
 
class  FaceGeometry< RefineableGeneralisedNewtonianQTaylorHoodElement< DIM > >
 Face geometry of the RefineableQTaylorHoodElements is the same as the Face geometry of the QTaylorHoodElements. More...
 
class  FaceGeometry< RefineableLinearisedAxisymmetricQCrouzeixRaviartElement >
 Face geometry of the refineable linearised axisym Crouzeix-Raviart elements. More...
 
class  FaceGeometry< RefineableLinearisedAxisymmetricQTaylorHoodElement >
 Face geometry of the refineable linearised axisym Taylor-Hood elements. More...
 
class  FaceGeometry< RefineableLinearisedQCrouzeixRaviartElement >
 Face geometry of the refineable linearised axisym Crouzeix-Raviart elements. More...
 
class  FaceGeometry< RefineableLinearisedQTaylorHoodElement >
 Face geometry of the refineable linearised axisym Taylor-Hood elements. More...
 
class  FaceGeometry< RefineablePolarCrouzeixRaviartElement >
 Face geometry of the RefineableQuadQCrouzeixRaviartElements. More...
 
class  FaceGeometry< RefineablePolarTaylorHoodElement >
 Face geometry of the RefineablePolarTaylorHoodElements is the same as the Face geometry of the PolarTaylorHoodElements. More...
 
class  FaceGeometry< RefineablePseudoSolidNodeUpdateElement< BASIC, SOLID > >
 Explicit definition of the face geometry of these elements. More...
 
class  FaceGeometry< RefineableQAdvectionDiffusionElement< DIM, NNODE_1D > >
 
class  FaceGeometry< RefineableQAdvectionDiffusionReactionElement< NREAGENT, DIM, NNODE_1D > >
 
class  FaceGeometry< RefineableQAxisymAdvectionDiffusionElement< NNODE_1D > >
 
class  FaceGeometry< RefineableQCrouzeixRaviartElement< DIM > >
 Face geometry of the RefineableQuadQCrouzeixRaviartElements. More...
 
class  FaceGeometry< RefineableQGeneralisedAdvectionDiffusionElement< DIM, NNODE_1D > >
 
class  FaceGeometry< RefineableQGeneralisedAxisymAdvectionDiffusionElement< NNODE_1D > >
 
class  FaceGeometry< RefineableQHelmholtzElement< DIM, NNODE_1D > >
 
class  FaceGeometry< RefineableQLinearElasticityElement< 2, NNODE_1D > >
 FaceGeometry of the 2D RefineableQLinearElasticityElement elements. More...
 
class  FaceGeometry< RefineableQLinearElasticityElement< 3, NNODE_1D > >
 FaceGeometry of the 3D RefineableQLinearElasticityElement elements. More...
 
class  FaceGeometry< RefineableQLinearWaveElement< DIM, NNODE_1D > >
 
class  FaceGeometry< RefineableQPMLHelmholtzElement< DIM, NNODE_1D, PML_ELEMENT > >
 
class  FaceGeometry< RefineableQPoissonElement< DIM, NNODE_1D > >
 
class  FaceGeometry< RefineableQPVDElement< 2, NNODE_1D > >
 FaceGeometry of the 2D RefineableQPVDElement elements. More...
 
class  FaceGeometry< RefineableQPVDElement< 3, NNODE_1D > >
 FaceGeometry of the 3D RefineableQPVDElement elements. More...
 
class  FaceGeometry< RefineableQPVDElementWithContinuousPressure< 2 > >
 FaceGeometry of the 2D RefineableQPVDElementWithContinuousPressure elements. More...
 
class  FaceGeometry< RefineableQPVDElementWithContinuousPressure< 3 > >
 FaceGeometry of the 3D RefineableQPVDElementWithContinuousPressure. More...
 
class  FaceGeometry< RefineableQPVDElementWithPressure< 2 > >
 FaceGeometry of the 2D RefineableQPVDElementWithPressure. More...
 
class  FaceGeometry< RefineableQPVDElementWithPressure< 3 > >
 FaceGeometry of the 3D RefineableQPVDElementWithPressure. More...
 
class  FaceGeometry< RefineableQSpectralPoissonElement< DIM, NNODE_1D > >
 
class  FaceGeometry< RefineableQSphericalAdvectionDiffusionElement< NNODE_1D > >
 
class  FaceGeometry< RefineableQSphericalCrouzeixRaviartElement >
 Face geometry of the RefineableQuadQCrouzeixRaviartElements. More...
 
class  FaceGeometry< RefineableQSphericalTaylorHoodElement >
 Face geometry of the RefineableQuadQTaylorHoodElements. More...
 
class  FaceGeometry< RefineableQTaylorHoodElement< DIM > >
 Face geometry of the RefineableQTaylorHoodElements is the same as the Face geometry of the QTaylorHoodElements. More...
 
class  FaceGeometry< RefineableQTimeHarmonicLinearElasticityElement< 2, NNODE_1D > >
 
class  FaceGeometry< RefineableQTimeHarmonicLinearElasticityElement< 3, NNODE_1D > >
 
class  FaceGeometry< RefineableQUnsteadyHeatElement< DIM, NNODE_1D > >
 
class  FaceGeometry< RefineableQYoungLaplaceElement< NNODE_1D > >
 
class  FaceGeometry< SolidTBubbleEnrichedElement< 2, NNODE_1D > >
 
class  FaceGeometry< SolidTBubbleEnrichedElement< 3, NNODE_1D > >
 
class  FaceGeometry< SolidTElement< 1, NNODE_1D > >
 Face geometry for the 1D TElement elements: Point elements. More...
 
class  FaceGeometry< SolidTElement< DIM, NNODE_1D > >
 
class  FaceGeometry< SpineElement< ELEMENT > >
 Explicit definition of the face geometry for spine elements: The same as the face geometry of the underlying element. More...
 
class  FaceGeometry< SpineElement< FaceGeometry< ELEMENT > > >
 Explicit definition of the face geometry for spine elements: The same as the face geometry of the underlying element. More...
 
class  FaceGeometry< TAxisymmetricLinearElasticityElement< NNODE_1D > >
 
class  FaceGeometry< TAxisymmetricPoroelasticityElement< 0 > >
 Face geometry for TAxisymmetricPoroelasticityElement<0> More...
 
class  FaceGeometry< TAxisymmetricPoroelasticityElement< 1 > >
 Face geometry for TAxisymmetricPoroelasticityElement<1> More...
 
class  FaceGeometry< TBubbleEnrichedElement< 2, NNODE_1D > >
 
class  FaceGeometry< TBubbleEnrichedElement< 3, NNODE_1D > >
 
class  FaceGeometry< TCrouzeixRaviartElement< 2 > >
 Face geometry of the 2D Crouzeix_Raviart elements. More...
 
class  FaceGeometry< TCrouzeixRaviartElement< 3 > >
 Face geometry of the 3D Crouzeix_Raviart elements. More...
 
class  FaceGeometry< TDisplacementBasedFoepplvonKarmanElement< NNODE_1D > >
 Face geometry for the TDisplacementBasedFoepplvonKarmanElement. More...
 
class  FaceGeometry< TElement< 1, NNODE_1D > >
 Face geometry for the 1D TElement elements: Point elements. More...
 
class  FaceGeometry< TElement< DIM, NNODE_1D > >
 
class  FaceGeometry< TFoepplvonKarmanElement< NNODE_1D > >
 
class  FaceGeometry< TFourierDecomposedHelmholtzElement< NNODE_1D > >
 
class  FaceGeometry< THelmholtzElement< 1, NNODE_1D > >
 Face geometry for the 1D THelmholtzElement elements: Point elements. More...
 
class  FaceGeometry< THelmholtzElement< DIM, NNODE_1D > >
 
class  FaceGeometry< TLinearElasticityElement< 1, NNODE_1D > >
 Face geometry for the 1D TLinearElasticityElement elements: Point elements. More...
 
class  FaceGeometry< TLinearElasticityElement< DIM, NNODE_1D > >
 
class  FaceGeometry< TPMLFourierDecomposedHelmholtzElement< NNODE_1D, PML_ELEMENT > >
 
class  FaceGeometry< TPMLHelmholtzElement< 1, NNODE_1D, PML_ELEMENT > >
 
class  FaceGeometry< TPMLHelmholtzElement< DIM, NNODE_1D, PML_ELEMENT > >
 
class  FaceGeometry< TPMLTimeHarmonicLinearElasticityElement< 1, NNODE_1D, PML_ELEMENT > >
 
class  FaceGeometry< TPMLTimeHarmonicLinearElasticityElement< DIM, NNODE_1D, PML_ELEMENT > >
 
class  FaceGeometry< TPoissonElement< 1, NNODE_1D > >
 Face geometry for the 1D TPoissonElement elements: Point elements. More...
 
class  FaceGeometry< TPoissonElement< DIM, NNODE_1D > >
 
class  FaceGeometry< TPoroelasticityElement< 0 > >
 Face geometry for TPoroelasticityElement<0> More...
 
class  FaceGeometry< TPoroelasticityElement< 1 > >
 Face geometry for TPoroelasticityElement<1> More...
 
class  FaceGeometry< TPVDBubbleEnrichedElement< 2, NNODE_1D > >
 FaceGeometry of a 2D TPVDBubbleEnrichedElement element. More...
 
class  FaceGeometry< TPVDBubbleEnrichedElement< 3, NNODE_1D > >
 FaceGeometry of a 3D TPVDBubbleEnrichedElement element. More...
 
class  FaceGeometry< TPVDElement< 2, NNODE_1D > >
 FaceGeometry of a 2D TPVDElement element. More...
 
class  FaceGeometry< TPVDElement< 3, NNODE_1D > >
 FaceGeometry of a 3D TPVDElement element. More...
 
class  FaceGeometry< TPVDElementWithContinuousPressure< 2 > >
 Face geometry of the 2D Taylor_Hood elements. More...
 
class  FaceGeometry< TPVDElementWithContinuousPressure< 3 > >
 Face geometry of the 3D Taylor_Hood elements. More...
 
class  FaceGeometry< TRaviartThomasDarcyElement< 0 > >
 Face geometry for TRaviartThomasDarcyElement<0> More...
 
class  FaceGeometry< TRaviartThomasDarcyElement< 1 > >
 Face geometry for TRaviartThomasDarcyElement<1> More...
 
class  FaceGeometry< TTaylorHoodElement< 2 > >
 Face geometry of the 2D Taylor_Hood elements. More...
 
class  FaceGeometry< TTaylorHoodElement< 3 > >
 Face geometry of the 3D Taylor_Hood elements. More...
 
class  FaceGeometry< TTimeHarmonicFourierDecomposedLinearElasticityElement< NNODE_1D > >
 
class  FaceGeometry< TTimeHarmonicLinearElasticityElement< 1, NNODE_1D > >
 
class  FaceGeometry< TTimeHarmonicLinearElasticityElement< DIM, NNODE_1D > >
 
class  FaceGeometry< TUnsteadyHeatElement< 1, NNODE_1D > >
 Face geometry for the 1D TUnsteadyHeatElement elements: Point elements. More...
 
class  FaceGeometry< TUnsteadyHeatElement< DIM, NNODE_1D > >
 
class  FaceGeometry< TWomersleyElement< 1, NNODE_1D > >
 Face geometry for the 1D TWomersleyElement elements: Point elements. More...
 
class  FaceGeometry< TWomersleyElement< DIM, NNODE_1D > >
 
class  FD_LU
 Dense LU decomposition-based solve of linear system assembled via finite differencing of the residuals Vector. Even more inefficient than DenseLU but excellent sanity check! More...
 
class  FiniteElement
 A general Finite Element class. More...
 
class  FishDomain
 Fish shaped domain, represented by four MacroElements. Shape is parametrised by GeomObject that represents the fish's back. More...
 
class  FishMesh
 Fish shaped mesh. The geometry is defined by the Domain object FishDomain. More...
 
class  FluidInterfaceAdditionalValues
 This policy class is used to allow additional values to be added to the nodes from new surface equations, for examples of usage see the SurfactantTransportFluidInterfaceElements. The use of this class avoids issues with calling virtual functions in constructors and avoids having a global look-up able, although it functions in much the same way. Typically, this will only be filled in by "expert users" and is only required if you want to write generic surface-element classes. Specific classes can always be overloaded on a case-by-case basis. More...
 
class  FluidInterfaceAdditionalValues< FluidInterfaceElement >
 Specific policy class for the FluidInterfaceElemetnts, which do not require any additional values at the nodes. More...
 
class  FluidInterfaceAdditionalValues< SurfactantTransportInterfaceElement >
 
class  FluidInterfaceBoundingElement
 
class  FluidInterfaceElement
 
class  FluxTransportEquations
 
class  FoepplvonKarmanEquations
 
class  FoepplvonKarmanVolumeConstraintElement
 
class  FoldHandler
 
class  FourierDecomposedHelmholtzBCElementBase
 A class for elements that allow the approximation of the Sommerfeld radiation BC for Fourier decomposed Helmholtz equations. The element geometry is obtained from the FaceGeometry<ELEMENT> policy class. More...
 
class  FourierDecomposedHelmholtzDtNBoundaryElement
 
class  FourierDecomposedHelmholtzDtNMesh
 
class  FourierDecomposedHelmholtzEquations
 
class  FourierDecomposedHelmholtzFluxElement
 A class for elements that allow the imposition of an applied flux on the boundaries of Fourier decomposed Helmholtz elements. The element geometry is obtained from the FaceGeometry<ELEMENT> policy class. More...
 
class  FourierDecomposedHelmholtzFluxFromNormalDisplacementBCElement
 A class for elements that allow the imposition of an prescribed flux (determined from the normal displacements of an adjacent linearly elastic solid. Normal derivative for displacement potential is given by normal displacement of adjacent solid multiplies by FSI parameter (q = k^2 B/E). The element geometry is obtained from the FaceGeometry<ELEMENT> policy class. More...
 
class  FourierDecomposedTimeHarmonicLinElastLoadedByHelmholtzPressureBCElement
 
class  FpPreconditionerAssemblyHandler
 
class  FpPressureAdvDiffRobinBCElement
 
class  FpPressureAdvDiffRobinBCElementBase
 
class  FpPressureAdvectionDiffusionProblem
 Auxiliary Problem that can be used to assemble the pressure advection diffusion matrix needed by the FpPreconditoner. More...
 
class  FreeStandingFaceElement
 
class  FSIAxisymFoepplvonKarmanElement
 
class  FSIAxisymmetricLinearElasticityTractionElement
 
class  FSIDiagHermiteShellElement
 
class  FSIDrivenCavityMesh
 Mesh for W. Wall's FSI driven cavity problem. The mesh is derived from the SimpleRectangularQuadMesh so it's node and element numbering scheme is the same as in that mesh. Only the boundaries are numbered differently to allow the easy identification of the "collapsible" segment. Boundary coordinates are set up for all nodes located on boundary 3 (the collapsible segment). The curvilinear ("collapsible") segment is defined by a GeomObject. More...
 
class  FSIFluidElement
 The FSIFluidElement class is a base class for all fluid finite elements that apply a load (traction) onto an adjacent SolidFiniteElement. More...
 
class  FSIHermiteBeamElement
 
class  FSIImposeDisplacementByLagrangeMultiplierElement
 
class  FSILinearisedAxisymPoroelasticTractionElement
 
class  FSIPreconditioner
 FSI preconditioner. This extracts upper/lower triangular blocks in the 3x3 overall block matrix structure arising from the monolithic discretisation of FSI problems with algebraic node updates. Dofs are decomposed into fluid velocity, pressure and solid unknowns. NavierStokesSchurComplementPreconditioner is used as the inexact solver for the fluid block; SuperLU (in its incarnation as an "exact" preconditioner) is used for the solid block. By default we retain the fluid on solid off diagonal blocks. More...
 
class  FSISolidTractionElement
 
class  FSIWallElement
 This is a base class for all SolidFiniteElements that participate in FSI computations. These elements provide interfaces and generic funcionality for the two additional roles that SolidFiniteElements play in FSI problems:

  1. They parameterise the domain boundary for the fluid domain. To allow them to play this role, FSIWallElements are derived from the SolidFiniteElement and the GeomObject class, indicating that the every specific FSIWallElement must implement the pure virtual function GeomObject::position(...) which should compute the position vector to a point in the SolidFiniteElement, parametrised by its local coordinates.
  2. In FSI problems fluid exerts a traction onto the wall and this traction must be added to any other load terms (such as an external pressure acting on an elastic pipe) that are already applied to the SolidFiniteElements by other means.
More...
 
class  FullCircleDomain
 Topologically circular domain, e.g. a tube cross section. The entire domain must be defined by a GeomObject with the following convention: zeta[0] is the radial coordinate and zeta[1] is the theta coordinate around the cross-sectin. The outer boundary must lie at zeta[0] = 1. More...
 
class  FullCircleMesh
 Full circle mesh class. The domain is specified by the GeomObject that identifies the entire area. Non-refineable base version! More...
 
class  Gauss
 
class  Gauss< 1, 2 >
 
class  Gauss< 1, 3 >
 
class  Gauss< 1, 4 >
 
class  Gauss< 2, 2 >
 
class  Gauss< 2, 3 >
 
class  Gauss< 2, 4 >
 
class  Gauss< 3, 2 >
 
class  Gauss< 3, 3 >
 
class  Gauss< 3, 4 >
 
class  Gauss_Rescaled
 Class for multidimensional Gaussian integration rules, over intervals other than -1 to 1, all intervals are rescaled in this case. More...
 
class  GaussLegendre
 
class  GaussLegendre< 1, NPTS_1D >
 1D Gauss Legendre integration class More...
 
class  GaussLegendre< 2, NPTS_1D >
 2D Gauss Legendre integration class More...
 
class  GaussLegendre< 3, NPTS_1D >
 3D Gauss Legendre integration class More...
 
class  GaussLobattoLegendre
 
class  GaussLobattoLegendre< 1, NPTS_1D >
 1D Gauss Lobatto Legendre integration class More...
 
class  GaussLobattoLegendre< 2, NPTS_1D >
 2D Gauss Lobatto Legendre integration class More...
 
class  GaussLobattoLegendre< 3, NPTS_1D >
 3D Gauss Lobatto Legendre integration class More...
 
class  GeneralElasticityTensor
 
class  GeneralisedAdvectionDiffusionEquations
 A class for all elements that solve the Advection Diffusion equations in conservative form using isoparametric elements.

\[ \frac{\partial}{\partial x_{i}}\left( Pe w_{i}(x_{k}) u - D_{ij}(x_{k})\frac{\partial u}{\partial x_{j}}\right) = f(x_{j}) \]

This contains the generic maths. Shape functions, geometric mapping etc. must get implemented in derived class. More...

 
class  GeneralisedElement
 A Generalised Element class. More...
 
class  GeneralisedHookean
 
class  GeneralisedMooneyRivlin
 Generalisation of Mooney Rivlin constitutive law to compressible media as suggested on p. 553 of Fung, Y.C. & Tong, P. "Classical and Computational Solid Mechanics" World Scientific (2001). Input parameters are Young's modulus E, Poisson ratio nu and the Mooney-Rivlin constant C1. In the small-deformation-limit the behaviour becomes equivalent to that of linear elasticity with the same E and nu. More...
 
class  GeneralisedNewtonianAxisymmetricNavierStokesEquations
 
class  GeneralisedNewtonianAxisymmetricQCrouzeixRaviartElement
 
class  GeneralisedNewtonianAxisymmetricQTaylorHoodElement
 
class  GeneralisedNewtonianAxisymmetricTCrouzeixRaviartElement
 GeneralisedNewtonianAxisymmetricTCrouzeix_Raviart elements are. More...
 
class  GeneralisedNewtonianAxisymmetricTTaylorHoodElement
 
class  GeneralisedNewtonianConstitutiveEquation
 A Base class defining the generalise Newtonian constitutive relation. More...
 
class  GeneralisedNewtonianNavierStokesEquations
 
class  GeneralisedNewtonianProjectableAxisymmetricCrouzeixRaviartElement
 Crouzeix Raviart upgraded to become projectable. More...
 
class  GeneralisedNewtonianProjectableAxisymmetricTaylorHoodElement
 GeneralisedNewtonianAxisymmetric Taylor Hood upgraded to become projectable. More...
 
class  GeneralisedNewtonianQCrouzeixRaviartElement
 
class  GeneralisedNewtonianQTaylorHoodElement
 
class  GeneralisedNewtonianTCrouzeixRaviartElement
 
class  GeneralisedNewtonianTemplateFreeNavierStokesEquationsBase
 
class  GeneralisedNewtonianTTaylorHoodElement
 
class  GeneralisedTimeStepper
 Generalised timestepper that can serve a variety of purposes in continuation, bifurcation detection and periodic-orbit computations. The key generalisation is that more than one of the entries is actually a degree of freedom in the problem. These are distinct from our standard (implict) Timesteppers in which the only dof is the current value (first entry in the storage scheme). These objects will typically be used to replace exisiting timesteppers for specific tasks. More...
 
class  GeneralPurposeBlockPreconditioner
 
class  GenericLagrangeInterpolatedProjectableElement
 Class that makes the finite element specified as template argument projectable – on the assumption that all fields are interpolated by isoparametric Lagrange interpolation between the nodes. More...
 
class  GeometricTElement
 
class  GeometricTElement< 2 >
 
class  GeomObject
 
class  GeompackQuadMesh
 
class  GeompackQuadScaffoldMesh
 Mesh that is based on input files generated by the quadrilateral mesh generator Geompack. More...
 
class  GMRES
 The GMRES method. More...
 
class  GmshParameters
 Class to collate parameters for Gmsh mesh generation. More...
 
class  GmshTetMesh
 Forward declaration. More...
 
class  GmshTetScaffoldMesh
 
class  GS
 The Gauss Seidel method. More...
 
class  GS< CRDoubleMatrix >
 Explicit template specialisation of the Gauss Seidel method for compressed row format matrices. More...
 
class  HangInfo
 Class that contains data for hanging nodes. More...
 
class  HeightControlElement
 
class  HelmholtzAbsorbingBCElement
 
class  HelmholtzBCElementBase
 A class for elements that allow the approximation of the Sommerfeld radiation BC. The element geometry is obtained from the FaceGeometry<ELEMENT> policy class. More...
 
class  HelmholtzDtNBoundaryElement
 
class  HelmholtzDtNMesh
 
class  HelmholtzEquations
 
class  HelmholtzFGMRESMG
 The FGMRES method, i.e. the flexible variant of the GMRES method which allows for nonconstant preconditioners [see Saad Y, "Iterative methods for sparse linear systems", p.287]. Note, FGMRES can only cater to right preconditioning; if the user tries to switch to left preconditioning they will be notified of this. More...
 
class  HelmholtzFluxElement
 A class for elements that allow the imposition of an applied flux on the boundaries of Helmholtz elements. The element geometry is obtained from the FaceGeometry<ELEMENT> policy class. More...
 
class  HelmholtzFluxFromNormalDisplacementBCElement
 A class for elements that allow the imposition of an prescribed flux (determined from the normal displacements of an adjacent linearly elastic solid. Normal derivative for displacement potential is given by normal displacement of adjacent solid multiplies by FSI parameter (q = k^2 B/E). The element geometry is obtained from the FaceGeometry<ELEMENT> policy class. More...
 
class  HelmholtzGMRESMG
 The GMRES method for the Helmholtz solver. More...
 
class  HelmholtzMGPreconditioner
 
class  HelmholtzMGProblem
 HelmholtzMGProblem class; subclass of Problem. More...
 
class  HelmholtzSmoother
 
class  HermiteBeamElement
 Hermite Kirchhoff Love beam. Implements KirchhoffLoveBeamEquations using 2-node Hermite elements as the underlying geometrical elements. More...
 
class  HermitePVDElement
 
class  HermiteQuadMesh
 A two dimensional Hermite bicubic element quadrilateral mesh for a topologically rectangular domain. The geometry of the problem must be prescribed using the TopologicallyRectangularDomain. Non uniform node spacing can be prescribed using a function pointer. More...
 
class  HermiteShellElement
 
class  HerschelBulkleyBerEngRegConstitutiveEquation
 
class  HerschelBulkleyMenDutRegConstitutiveEquation
 
class  HerschelBulkleyPapRegConstitutiveEquation
 
class  HerschelBulkleyTanMilRegConstitutiveEquation
 
class  HerschelBulkleyTanMilRegWithBlendingConstitutiveEquation
 
class  Hijacked
 Hijacked elements are elements in which one or more Data values that affect the element's residuals, are determined by another element – the data values are then said to have been hijacked by another element. The main functionality added by the Hijacked element class is that it wipes out those entries in the element's residual vector and those rows in the element's Jacobian matrix that are determined by the "other" elements that have hijacked the values. Note that for continuation in homotopy parameters, it may be desriable to multiply the residuals and corresponding jacobian entries by a "homotopy parameter". The value of this parameter can be set by assigning residual_multiplier_pt() which has a default value of zero. Note: it would be possible to extend the functionality so that different residuals are multiplied by different values, but will this ever be required? More...
 
class  HijackedData
 Custom Data class that is used when HijackingData. The class always contains a single value that is copied from another Data object. More...
 
class  HijackedElementBase
 
class  HopfHandler
 
class  HorizontalSingleLayerSpineMesh
 
class  HSL_MA42
 
class  HypreInterface
 
class  HyprePreconditioner
 
class  HypreSolver
 
class  IdentityPreconditioner
 The Identity Preconditioner. More...
 
class  ILUZeroPreconditioner
 ILU(0) Preconditioner. More...
 
class  ILUZeroPreconditioner< CCDoubleMatrix >
 ILU(0) Preconditioner for matrices of CCDoubleMatrix Format. More...
 
class  ILUZeroPreconditioner< CRDoubleMatrix >
 ILU(0) Preconditioner for matrices of CRDoubleMatrix Format. More...
 
class  ImmersedRigidBodyElement
 
class  ImmersedRigidBodyTriangleMeshPolygon
 
class  ImposeDisplacementByLagrangeMultiplierElement
 
class  ImposeFluxForWomersleyElement
 Element to impose volume flux through collection of Womersley elements, in exchange for treating the pressure gradient as an unknown. The pressure gradient is created (as a single-valued Data item) in the constructor for this element which also takes a pointer to the Mesh containing the Womersley elements whose total flux is being controlled. While doing this we tell them that their pressure gradient is now an unknown and must be treated as external Data. More...
 
class  ImposeImpenetrabilityElement
 ImposeImpenetrabilityElement are elements that coincide with the faces of higher-dimensional "bulk" elements. They are used on boundaries where we would like to impose impenetrability. More...
 
class  ImposeParallelOutflowElement
 ImposeParallelOutflowElement are elements that coincide with the faces of higher-dimensional "bulk" elements. They are used on boundaries where we would like to impose parallel outflow and impose the pressure. More...
 
class  IMR
 
class  IMRBase
 Implicit midpoint rule base class for the two implementations. More...
 
class  IMRByBDF
 
class  InexactSubBiharmonicPreconditioner
 SubBiharmonic Preconditioner - an inexact preconditioner for the 3x3 top left hand corner sub block matrix. Used as part of the BiharmonicPreconditioner<MATRIX> More...
 
class  InnerIterationPreconditioner
 A preconditioner for performing inner iteration preconditioner solves. The template argument SOLVER specifies the inner iteration solver (which must be derived from IterativeLinearSolver) and the template argument PRECONDITIONER specifies the preconditioner for the inner iteration iterative solver. Note: For no preconditioning use the IdentityPreconditioner. More...
 
class  Integral
 
class  IsotropicElasticityTensor
 
class  IsotropicStrainEnergyFunctionConstitutiveLaw
 
class  IterativeLinearSolver
 Base class for all linear iterative solvers. This merely defines standard interfaces for linear iterative solvers, so that different solvers can be used in a clean and transparent manner. More...
 
class  KirchhoffLoveBeamEquations
 
class  KirchhoffLoveShellEquations
 
class  LagrangeEnforcedFlowPreconditioner
 The preconditioner for the Lagrange multiplier constrained Navier-Stokes equations. The velocity components are constrained by Lagrange multiplier, which are applied via OOMPH-LIB's FACE elements. More...
 
class  LAPACK_QZ
 Class for the LAPACK eigensolver. More...
 
class  LinearAlgebraDistribution
 Describes the distribution of a distributable linear algebra type object. Typically this is a container (such as a DoubleVector) or an operator (e.g Preconditioner or LinearSolver). This object is used in both serial and parallel implementations. In the serial context (no MPI) this just contains an integer indicating the number of rows. In parallel either each processor holds a subset of the set of global rows. (each processor contains only a single continuous block of rows - parametised with variables denoting the first row and the number of local rows) or, all rows are be duplicated across all processors. In parallel this object also contains an OomphCommunicator object which primarily contains the MPI_Comm communicator associated with this object. More...
 
class  LinearElasticityEquations
 
class  LinearElasticityEquationsBase
 
class  LinearElasticitySmoothMesh
 
class  LinearElasticityTractionElement
 
class  LinearisedAxisymmetricNavierStokesEquations
 A class for elements that solve the linearised version of the unsteady Navier–Stokes equations in cylindrical polar coordinates, where we have Fourier-decomposed in the azimuthal direction so that the theta-dependance is replaced by an azimuthal mode number. More...
 
class  LinearisedAxisymmetricQCrouzeixRaviartElement
 
class  LinearisedAxisymmetricQTaylorHoodElement
 
class  LinearisedAxisymPoroelasticBJS_FSIElement
 A class for elements that allow the imposition of the linearised poroelastic FSI slip condition (according to the Beavers-Joseph-Saffman condition) from an adjacent poroelastic axisymmetric medium. The element geometry is obtained from the FaceGeometry<ELEMENT> policy class. More...
 
class  LinearisedFSIAxisymmetricNStNoSlipBCElementElement
 A class for elements that allow the imposition of the linearised FSI no slip condition from an adjacent linearly elastic axisymmetric solid. The element geometry is obtained from the FaceGeometry<ELEMENT> policy class. More...
 
class  LinearisedNavierStokesEigenfunctionNormalisationElement
 
class  LinearisedNavierStokesEquations
 A class for elements that solve the linearised version of the unsteady Navier–Stokes equations in cylindrical polar coordinates, where we have Fourier-decomposed in the azimuthal direction so that the theta-dependance is replaced by an azimuthal mode number. More...
 
class  LinearisedQCrouzeixRaviartElement
 
class  LinearisedQTaylorHoodElement
 
class  LinearSolver
 
class  LinearTElement
 A class for Linear triangular shape function with 3 vertex nodes. More...
 
class  LinearTElement< 2 >
 
class  LinearWaveEquations
 
class  LinearWaveFluxElement
 A class for elements that allow the imposition of an applied flux on the boundaries of LinearWave elements. The element geometry is obtained from the FaceGeometry<ELEMENT> policy class. More...
 
class  LineDerivatives
 
class  LineElementBase
 Base class for all line elements. More...
 
class  LineFluidInterfaceBoundingElement
 Specialisation of the interface boundary constraint to a line. More...
 
class  LineMeshBase
 Base class for line meshes (meshes made of 1D line elements) More...
 
class  LineVisualiser
 Class to aid visualisation of the values on a set of points. NOTE: in a distributed problem, output is only done on processor 0. More...
 
class  LineVolumeConstraintBoundingElement
 
class  LowStorageRungeKutta
 
class  MacroElement
 
class  MacroElementNodeUpdateChannelWithLeafletMesh
 
class  MacroElementNodeUpdateCollapsibleChannelMesh
 
class  MacroElementNodeUpdateElement
 
class  MacroElementNodeUpdateElementBase
 Base class for elements that allow MacroElement-based node update. More...
 
class  MacroElementNodeUpdateMesh
 
class  MacroElementNodeUpdateNode
 
class  MacroElementNodeUpdateRefineableChannelWithLeafletMesh
 Refineable mesh with MacroElement-based node update. More...
 
class  MacroElementNodeUpdateRefineableCollapsibleChannelMesh
 
class  MacroElementNodeUpdateRefineableFishMesh
 
class  MacroElementNodeUpdateRefineableQuarterCircleSectorMesh
 
class  MacroElementNodeUpdateRefineableQuarterTubeMesh
 MacroElementNodeUpdate version of RefineableQuarterTubeMesh. More...
 
class  MapMatrix
 
class  MapMatrixMixed
 
class  Matrix
 Abstract base class for matrices, templated by the type of object that is stored in them and the type of matrix. The MATRIX_TYPE template argument is used as part of the Curiously Recurring Template Pattern, see http://en.wikipedia.org/wiki/Curiously_Recurring_Template_Pattern The pattern is used to force the inlining of the round bracket access functions by ensuring that they are NOT virtual functions. More...
 
class  MatrixBasedDiagPreconditioner
 Matrix-based diagonal preconditioner. More...
 
class  MatrixBasedLumpedPreconditioner
 Matrix-based lumped preconditioner. More...
 
class  MatrixVectorProduct
 Matrix vector product helper class - primarily a wrapper to Trilinos's Epetra matrix vector product methods. This allows the epetra matrix to be assembled once and the matrix vector product to be performed many times. More...
 
class  Mesh
 A general mesh class. More...
 
class  MeshAsGeomObject
 
class  MGPreconditioner
 An interface to allow scalar MG to be used as a Preconditioner. More...
 
class  MGProblem
 MGProblem class; subclass of Problem. More...
 
class  MGSolver
 
class  MinModLimiter
 
class  MooneyRivlin
 MooneyRivlin strain-energy function. with constitutive parameters C1 and C2:

\[ W = C_1 (I_0 - 3) + C_2 (I_1 - 3) \]

where incompressibility ( $ I_2 \equiv 1$) is assumed. More...

 
class  MPI_Helpers
 MPI_Helpers class contains static helper methods to support MPI within oomph-lib. The methods init(...) and finalize() initialize and finalize MPI in oomph-lib and manage the oomph-libs global communicator communicator_pt(). NOTE: This class encapsulates static helper methods and instances of it CANNOT be instantiated. More...
 
class  MPIOutputModifier
 
class  MumpsSolver
 Wrapper to Mumps solver. More...
 
class  NavierStokesBoussinesqElement
 
class  NavierStokesElementWithDiagonalMassMatrices
 
class  NavierStokesEquations
 
class  NavierStokesExactPreconditioner
 The exact Navier Stokes preconditioner. This extracts 2x2 blocks (corresponding to the velocity and pressure unknowns) and uses these to build a single preconditioner matrix for testing purposes. Iterative solvers should converge in a single step if this is used. If it doesn't something is wrong in the setup of the block matrices. More...
 
class  NavierStokesFluxControlElement
 
class  NavierStokesImpedanceTractionElement
 
class  NavierStokesImpedanceTractionElementBase
 
class  NavierStokesSchurComplementPreconditioner
 The least-squares commutator (LSC; formerly BFBT) Navier Stokes preconditioner. It uses blocks corresponding to the velocity and pressure unknowns, i.e. there are a total of 2x2 blocks, and all velocity components are treated as a single block of unknowns. More...
 
class  NavierStokesSurfaceDragTorqueElement
 
class  NavierStokesSurfacePowerElement
 
class  NavierStokesTractionElement
 
class  NavierStokesWomersleyPressureControlElement
 
class  NetFluxControlElement
 
class  NetFluxControlElementForWomersleyPressureControl
 
class  Newmark
 Newmark scheme for second time deriv. Stored data represents. More...
 
class  NewmarkBDF
 Newmark scheme for second time deriv with first derivatives calculated using BDF. . Stored data represents. More...
 
class  NewMumpsPreconditioner
 An interface to allow Mumps to be used as an (exact) Preconditioner. More...
 
class  NewtonianConstitutiveEquation
 
class  NewtonSolverError
 A class to handle errors in the Newton solver. More...
 
class  NicosConstitutiveEquation
 
class  Node
 Nodes are derived from Data, but, in addition, have a definite (Eulerian) position in a space of a given dimension. More...
 
class  NonLinearElasticitySmoothMesh
 
class  NonRefineableBinArrayParameters
 Helper object for dealing with the parameters used for the NonRefineableBinArray objects. More...
 
class  NonRefineableElementWithHangingNodes
 
class  NonRefineableSolidElementWithHangingNodes
 
class  Nullstream
 A small nullstream class that throws away everything sent to it. More...
 
class  OcTree
 
class  OcTreeForest
 
class  OcTreeRoot
 
class  ODEElement
 Element for integrating an initial value ODE. More...
 
class  OneDimensionalLegendreDShape
 
class  OneDimensionalLegendreShape
 Class that returns the shape functions associated with legendre. More...
 
class  OneDimensionalModalDShape
 
class  OneDimensionalModalShape
 
class  OneDLagrangianMesh
 
class  OneDLegendreDShapeParam
 
class  OneDLegendreShapeParam
 Class that returns the shape functions associated with legendre. More...
 
class  OneDMesh
 
class  OomphCommunicator
 An oomph-lib wrapper to the MPI_Comm communicator object. Just contains an MPI_Comm object (which is a pointer) and wrappers to the MPI_... methods. More...
 
class  OomphInfo
 
class  OomphLibError
 
class  OomphLibException
 
class  OomphLibPreconditionerEpetraOperator
 An Epetra_Operator class for oomph-lib preconditioners. A helper class for TrilinosOomphLibPreconditioner to allow an oomph-lib preconditioner (i.e. one derived from Preconditioner) to be used with a trilinos solver (TrilinosAztecOOSolver) More...
 
class  OomphLibQuietException
 
class  OomphLibWarning
 
class  OutputModifier
 
class  ParallelResidualsHandler
 A class that is used to assemble the residuals in parallel by overloading the get_all_vectors_and_matrices, so that only the residuals are returned. This ensures that the (moderately complex) distributed parallel assembly loops are only in one place. More...
 
class  ParameterDerivativeHandler
 A class that is used to define the functions used when assembling the derivatives of the residuals with respect to a parameter. The idea is to replace get_residuals with get_dresiduals_dparameter with a particular parameter and assembly handler that are passed on assembly. More...
 
class  PeriodicOrbitAssemblyHandler
 
class  PeriodicOrbitAssemblyHandlerBase
 
class  PeriodicOrbitBaseElement
 
class  PeriodicOrbitEquations
 
class  PeriodicOrbitTemporalMesh
 A special temporal mesh class. More...
 
class  PeriodicOrbitTimeDiscretisation
 Timestepper used to calculate periodic orbits directly. It's not really a "timestepper" per se, but represents the time storage and means of calculating time-derivatives given the underlying discretisation. More...
 
class  PicardConvergenceData
 Object that collates convergence data of Picard iteration. More...
 
class  PitchForkHandler
 
class  PMLCornerQuadMesh
 PML mesh, derived from RectangularQuadMesh. More...
 
class  PMLElementBase
 Base class for elements with pml capabilities. More...
 
class  PMLFourierDecomposedHelmholtzEquations
 
class  PMLFourierDecomposedHelmholtzEquationsBase
 
class  PMLFourierDecomposedHelmholtzFluxElement
 A class for elements that allow the imposition of an applied flux on the boundaries of Fourier decomposed Helmholtz elements. The element geometry is obtained from the FaceGeometry<ELEMENT> policy class. More...
 
class  PMLFourierDecomposedHelmholtzPowerMonitorElement
 A class for elements that allow postprocessing of the results – currently computes radiated power over domain boundaries. The element geometry is obtained from the FaceGeometry<ELEMENT> policy class. More...
 
class  PMLHelmholtzEquations
 
class  PMLHelmholtzEquationsBase
 
class  PMLHelmholtzFluxElement
 A class for elements that allow the imposition of an applied flux on the boundaries of PMLHelmholtz elements. The element geometry is obtained from the FaceGeometry<ELEMENT> policy class. More...
 
class  PMLHelmholtzFluxFromNormalDisplacementBCElement
 A class for elements that allow the imposition of an prescribed flux (determined from the normal displacements of an adjacent linearly elastic solid. Normal derivative for displacement potential is given by normal displacement of adjacent solid multiplies by FSI parameter (q = k^2 B/E). The element geometry is obtained from the FaceGeometry<ELEMENT> policy class. More...
 
class  PMLHelmholtzPowerElement
 A class for elements that allow the post-processing of radiated power and flux on the boundaries of PMLHelmholtz elements. The element geometry is obtained from the FaceGeometry<ELEMENT> policy class. More...
 
class  PMLMeshBase
 
class  PMLQuadMesh
 PML mesh, derived from RectangularQuadMesh. More...
 
class  PMLQuadMeshBase
 PML mesh class. Policy class for 2D PML meshes. More...
 
class  PMLTimeHarmonicElasticityTensor
 
class  PMLTimeHarmonicIsotropicElasticityTensor
 
class  PMLTimeHarmonicLinearElasticityEquations
 
class  PMLTimeHarmonicLinearElasticityEquationsBase
 
class  PMLTimeHarmonicLinearElasticityTractionElement
 
class  PointElement
 
class  PointFluidInterfaceBoundingElement
 Specialisation of the interface boundary constraint to a point. More...
 
class  PointIntegral
 
class  PoissonEquations
 
class  PoissonFluxElement
 A class for elements that allow the imposition of an applied flux on the boundaries of Poisson elements. The element geometry is obtained from the FaceGeometry<ELEMENT> policy class. More...
 
class  PoissonSmoothMesh
 
class  PolarCrouzeixRaviartElement
 
class  PolarNavierStokesEquations
 
class  PolarNavierStokesTractionElement
 
class  PolarStressIntegralElement
 
class  PolarTaylorHoodElement
 
class  PoroelasticityEquations
 Class implementing the generic maths of the poroelasticity equations: linear elasticity coupled with Darcy equations (using Raviart-Thomas elements with both edge and internal degrees of freedom) More...
 
class  PoroelasticityFaceElement
 
class  PowerLawBerEngRegConstitutiveEquation
 
class  Preconditioner
 Preconditioner base class. Gives an interface to call all other preconditioners through and stores the matrix and communicator pointers. All preconditioners should be derived from this class. More...
 
class  PreconditionerArray
 PreconditionerArray - NOTE - first implementation, a number of assumptions / simplifications were made: More...
 
class  PRefineableElement
 p-refineable version of RefineableElement More...
 
class  PRefineableGeneralisedNewtonianQCrouzeixRaviartElement
 
class  PRefineableQCrouzeixRaviartElement
 
class  PRefineableQElement
 
class  PRefineableQElement< 1, INITIAL_NNODE_1D >
 
class  PRefineableQElement< 2, INITIAL_NNODE_1D >
 p-refineable version of RefineableQElement<2,INITIAL_NNODE_1D>. More...
 
class  PRefineableQElement< 3, INITIAL_NNODE_1D >
 p-refineable version of RefineableQElement<3,INITIAL_NNODE_1D>. More...
 
class  PRefineableQLinearElasticityElement
 p-refineable version of 2D QLinearElasticityElement elements More...
 
class  PRefineableQPoissonElement
 p-refineable version of 2D QPoissonElement elements More...
 
class  PressureBasedSolidExactPreconditioner
 The exact solid preconditioner. This extracts 2x2 blocks (corresponding to the displacement/position and pressure unknowns) and uses these to build a single preconditioner matrix for testing purposes. Iterative solvers should converge in a single step if this is used. If it doesn't something is wrong in the setup of the block matrices. More...
 
class  PressureBasedSolidLSCPreconditioner
 The least-squares commutator (LSC; formerly BFBT) preconditioner. It uses blocks corresponding to the displacement/position and pressure unknowns, i.e. there are a total of 2x2 blocks, and all displacement/position components are treated as a single block of unknowns. More...
 
class  Problem
 The Problem class. More...
 
class  ProblemBasedShiftInvertOperator
 Class for the shift invert operation. More...
 
class  ProjectableAxisymLinearElasticityElement
 Axisym linear elasticity upgraded to become projectable. More...
 
class  ProjectableAxisymmetricCrouzeixRaviartElement
 Crouzeix Raviart upgraded to become projectable. More...
 
class  ProjectableAxisymmetricPoroelasticityElement
 Axisymmetric poro elasticity upgraded to become projectable. More...
 
class  ProjectableAxisymmetricTaylorHoodElement
 Axisymmetric Taylor Hood upgraded to become projectable. More...
 
class  ProjectableCrouzeixRaviartElement
 Crouzeix Raviart upgraded to become projectable. More...
 
class  ProjectableDarcyElement
 Darcy upgraded to become projectable. More...
 
class  ProjectableDisplacementBasedFoepplvonKarmanElement
 Foeppl von Karman upgraded to become projectable. More...
 
class  ProjectableElement
 
class  ProjectableElementBase
 Template-free Base class for projectable elements. More...
 
class  ProjectableFoepplvonKarmanElement
 Foeppl von Karman upgraded to become projectable. More...
 
class  ProjectableFourierDecomposedHelmholtzElement
 Fourier decomposed Helmholtz upgraded to become projectable. More...
 
class  ProjectableGeneralisedNewtonianCrouzeixRaviartElement
 Crouzeix Raviart upgraded to become projectable. More...
 
class  ProjectableGeneralisedNewtonianTaylorHoodElement
 Taylor Hood upgraded to become projectable. More...
 
class  ProjectableHelmholtzElement
 Helmholtz upgraded to become projectable. More...
 
class  ProjectableLinearElasticityElement
 Linear elasticity upgraded to become projectable. More...
 
class  ProjectablePMLFourierDecomposedHelmholtzElement
 Fourier decomposed Helmholtz upgraded to become projectable. More...
 
class  ProjectablePMLHelmholtzElement
 PMLHelmholtz upgraded to become projectable. More...
 
class  ProjectablePMLTimeHarmonicLinearElasticityElement
 Time-harmonic linear elasticity upgraded to become projectable. More...
 
class  ProjectablePoissonElement
 Poisson upgraded to become projectable. More...
 
class  ProjectablePVDElement
 PVDElementWithContinuousPressure upgraded to become projectable. More...
 
class  ProjectablePVDElementWithContinuousPressure
 PVDElementWithContinuousPressure upgraded to become projectable. More...
 
class  ProjectableTaylorHoodElement
 Taylor Hood upgraded to become projectable. More...
 
class  ProjectableTimeHarmonicFourierDecomposedLinearElasticityElement
 
class  ProjectableTimeHarmonicLinearElasticityElement
 Time-harmonic linear elasticity upgraded to become projectable. More...
 
class  ProjectableUnsteadyHeatElement
 UnsteadyHeat upgraded to become projectable. More...
 
class  ProjectionProblem
 
class  PseudoBucklingRing
 Pseudo buckling ring: Circular ring deformed by the N-th buckling mode of a thin-wall elastic ring.

\[ x = R_0 \cos(\zeta) + \epsilon \left( \cos(N \zeta) \cos(\zeta) - A \sin(N \zeta) \sin(\zeta) \right) sin(2 \pi t/T) \]

\[ y = R_0 \sin(\zeta) + \epsilon \left( \cos(N \zeta) \sin(\zeta) + A \sin(N \zeta) \cos(\zeta) \right) sin(2 \pi t/T) \]

where A is the ratio of the aziumuthal to the radial buckling amplitude (A=-1/N for statically buckling rings) and epsilon is the buckling amplitude. More...

 
class  PseudoBucklingRingElement
 Pseudo buckling ring: Circular ring deformed by the N-th buckling mode of a thin-wall elastic ring.

\[ x = R_0 \cos(\zeta) + \epsilon \left( \cos(N \zeta) \cos(\zeta) - A \sin(N \zeta) \sin(\zeta) \right) sin(2 \pi t/T) \]

\[ y = R_0 \sin(\zeta) + \epsilon \left( \cos(N \zeta) \sin(\zeta) + A \sin(N \zeta) \cos(\zeta) \right) sin(2 \pi t/T) \]

where A is the ratio of the aziumuthal to the radial buckling amplitude (A=-1/N for statically buckling rings) and epsilon is the buckling amplitude. Scale R_0 is adjusted to ensure conservation of (computational) volume/area. This is implemented by a pseudo-elasticity approach: The governing equation for $ R_0 $ is:

\[ p_{ref} = R_0 - 1.0 \]

The pointer to the reference pressure needs to be set with reference_pressure_pt(). More...

 
class  PseudoElasticChannelWithLeafletMesh
 Channel with leaflet mesh upgraded to (pseudo-)solid mesh. More...
 
class  PseudoElasticFSIPreconditioner
 Preconditioner for FSI problems with pseudo-elastic fluid node updates. Note: NavierStokesSchurComplementPreconditioner is applied to the Navier Stokes subsidiary system. Default solid preconditioner is SuperLUPreconditioner. Enumeration of Elastic DOF types in the Pseudo-Elastic Elements The method get_dof_types_for_unknowns() must be implemented such that DOFs subject be Lagrange multiplier and DOFs NOT subject to Lagrange multiplier have different labels. For example in a 3D problem there are 6 DOF types and the following labelling must be implemented: 0 - x displacement (without lagr mult traction) 1 - y displacement (without lagr mult traction) 2 - z displacement (without lagr mult traction) 3 - x displacement (with lagr mult traction) 4 - y displacement (with lagr mult traction) 5 - z displacement (with lagr mult traction) More...
 
class  PseudoElasticPreconditioner
 A subsidiary preconditioner for the pseudo-elastic FSI preconditioner. Also a stand-alone preconditioner for the problem of non-linear elasticity subject to prescribed displacement by Lagrange multiplier. Enumeration of Elastic DOF types in the Pseudo-Elastic Elements The method get_dof_types_for_unknowns() must be implemented such that DOFs subject be Lagrange multiplier and DOFs NOT subject to Lagrange multiplier have different labels. For example in a 3D problem there are 6 DOF types and the following labelling must be implemented: 0 - x displacement (without lagr mult traction) 1 - y displacement (without lagr mult traction) 2 - z displacement (without lagr mult traction) 4 - x displacement (with lagr mult traction) 5 - y displacement (with lagr mult traction) 6 - z displacement (with lagr mult traction) More...
 
class  PseudoElasticPreconditionerOld
 A subsidiary preconditioner for the pseudo-elastic FSI preconditioner. Also a stand-alone preconditioner for the problem of non-linear elasticity subject to prescribed displacement by Lagrange multiplier.. Enumeration of Elastic DOF types in the Pseudo-Elastic Elements The method get_dof_types_for_unknowns() must be implemented such that DOFs subject be Lagrange multiplier and DOFs NOT subject to Lagrange multiplier have different labels. For example in a 3D problem there are 6 DOF types and the following labelling must be implemented: 0 - x displacement (without lagr mult traction) 1 - y displacement (without lagr mult traction) 2 - z displacement (without lagr mult traction) 4 - x displacement (with lagr mult traction) 5 - y displacement (with lagr mult traction) 6 - z displacement (with lagr mult traction) More...
 
class  PseudoElasticPreconditionerScalingHelperOld
 A helper class for PseudoElasticPreconditioner. Note that this is NOT actually a functioning preconditioner. We simply derive from this class to get access to the blocks. More...
 
class  PseudoElasticPreconditionerSubsidiaryBlockPreconditionerOld
 
class  PseudoElasticPreconditionerSubsidiaryPreconditionerOld
 
class  PseudoSolidNodeUpdateElement
 
class  PVDEquations
 
class  PVDEquationsBase
 
class  PVDEquationsWithPressure
 
class  QAdvectionDiffusionElement
 QAdvectionDiffusionElement elements are linear/quadrilateral/brick-shaped Advection Diffusion elements with isoparametric interpolation for the function. More...
 
class  QAdvectionDiffusionReactionElement
 QAdvectionDiffusionReactionElement elements are linear/quadrilateral/brick-shaped Advection Diffusion elements with isoparametric interpolation for the function. More...
 
class  QAxisymAdvectionDiffusionElement
 QAxisymAdvectionDiffusionElement elements are linear/quadrilateral/brick-shaped Axisymmetric Advection Diffusion elements with isoparametric interpolation for the function. More...
 
class  QAxisymmetricLinearElasticityElement
 
class  QCrouzeixRaviartElement
 
class  QElement
 
class  QElement< 1, NNODE_1D >
 General QElement class specialised to one spatial dimension. More...
 
class  QElement< 2, NNODE_1D >
 General QElement class specialised to two spatial dimensions. More...
 
class  QElement< 3, NNODE_1D >
 General QElement class specialised to three spatial dimensions. More...
 
class  QElementBase
 Base class for Qelements. More...
 
class  QElementGeometricBase
 
class  QFoepplvonKarmanElement
 
class  QFourierDecomposedHelmholtzElement
 
class  QGeneralisedAdvectionDiffusionElement
 QGeneralisedAdvectionDiffusionElement elements are linear/quadrilateral/brick-shaped Advection Diffusion elements with isoparametric interpolation for the function. More...
 
class  QHelmholtzElement
 
class  QHermiteElement
 
class  QHermiteElementBase
 
class  QLinearElasticityElement
 
class  QLinearWaveElement
 
class  QMacroElement
 
class  QMacroElement< 2 >
 
class  QMacroElement< 3 >
 
class  QPMLFourierDecomposedHelmholtzElement
 
class  QPMLHelmholtzElement
 QPMLHelmholtzElement elements are linear/quadrilateral/ brick-shaped PMLHelmholtz elements with isoparametric interpolation for the function. More...
 
class  QPMLTimeHarmonicLinearElasticityElement
 
class  QPoissonElement
 
class  QPVDElement
 
class  QPVDElementWithContinuousPressure
 
class  QPVDElementWithPressure
 
class  QScalarAdvectionElement
 Non-spectral version of the classes. More...
 
class  QSolidElementBase
 Base class for Solid Qelements. More...
 
class  QSpectralElement
 
class  QSpectralElement< 1, NNODE_1D >
 General QSpectralElement class specialised to one spatial dimension. More...
 
class  QSpectralElement< 2, NNODE_1D >
 General QSpectralElement class specialised to two spatial dimensions. More...
 
class  QSpectralElement< 3, NNODE_1D >
 General QSpectralElement class specialised to three spatial dimensions. More...
 
class  QSpectralEulerElement
 
class  QSpectralPoissonElement
 
class  QSpectralScalarAdvectionElement
 
class  QSphericalAdvectionDiffusionElement
 QSphericalAdvectionDiffusionElement elements are linear/quadrilateral/brick-shaped Axisymmetric Advection Diffusion elements with isoparametric interpolation for the function. More...
 
class  QSphericalCrouzeixRaviartElement
 
class  QSphericalTaylorHoodElement
 
class  QSteadyAxisymAdvectionDiffusionElement
 QSteadyAxisymAdvectionDiffusionElement elements are linear/quadrilateral/brick-shaped Axisymmetric Advection Diffusion elements with isoparametric interpolation for the function. More...
 
class  QSUPGAdvectionDiffusionElement
 QSUPGAdvectionDiffusionElement<DIM,NNODE_1D> elements are SUPG-stabilised Advection Diffusion elements with NNODE_1D nodal points in each coordinate direction. Inherits from QAdvectionDiffusionElement and overwrites their test functions. More...
 
class  QTaylorHoodElement
 
class  QTimeHarmonicFourierDecomposedLinearElasticityElement
 
class  QTimeHarmonicLinearElasticityElement
 
class  QuadElementBase
 Base class for all quad elements. More...
 
class  QuadFromTriangleMesh
 
class  QuadMeshBase
 Base class for quad meshes (meshes made of 2D quad elements). More...
 
class  QuadTree
 
class  QuadTreeForest
 
class  QuadTreeRoot
 
class  QuarterCircleSectorDomain
 Circular sector as domain. Domain is bounded by curved boundary which is represented by a GeomObject. Domain is parametrised by three macro elements. More...
 
class  QuarterCircleSectorMesh
 
class  QuarterPipeDomain
 Domain representing a quarter pipe. More...
 
class  QuarterPipeMesh
 
class  QuarterTubeDomain
 Quarter tube as domain. Domain is bounded by curved boundary which is represented by a GeomObject. Domain is parametrised by three macro elements in each of the nlayer slices. More...
 
class  QuarterTubeMesh
 3D quarter tube mesh class. The domain is specified by the GeomObject that identifies boundary 3. Non-refineable base version! More...
 
class  QUnsteadyHeatElement
 
class  QWomersleyElement
 
class  QYoungLaplaceElement
 
class  RankFiveTensor
 A Rank 5 Tensor class. More...
 
class  RankFourTensor
 A Rank 4 Tensor class. More...
 
class  RankThreeTensor
 A Rank 3 Tensor class. More...
 
class  RectangleWithHoleDomain
 Rectangular domain with circular whole. More...
 
class  RectangleWithHoleMesh
 Domain-based mesh for rectangular mesh with circular hole. More...
 
class  RectangularQuadMesh
 
class  RefineableAdvectionDiffusionBoussinesqElement
 
class  RefineableAdvectionDiffusionEquations
 A version of the Advection Diffusion equations that can be used with non-uniform mesh refinement. In essence, the class overloads the fill_in_generic_residual_contribution_adv_diff() function so that contributions from hanging nodes (or alternatively in-compatible function values) are taken into account. More...
 
class  RefineableAdvectionDiffusionReactionEquations
 A version of the Advection Diffusion Reaction equations that can be used with non-uniform mesh refinement. In essence, the class overloads the fill_in_generic_residual_contribution_adv_diff_react() function so that contributions from hanging nodes (or alternatively in-compatible function values) are taken into account. More...
 
class  RefineableAlgebraicChannelWithLeafletMesh
 Refineable version of algebraic ChannelWithLeafletMesh. More...
 
class  RefineableAlgebraicCollapsibleChannelMesh
 
class  RefineableAlgebraicCylinderWithFlagMesh
 Refineable version of AlgebraicCylinderWithFlagMesh. More...
 
class  RefineableAlgebraicFSIDrivenCavityMesh
 
class  RefineableAxisymAdvectionDiffusionEquations
 A version of the Advection Diffusion in axisym coordinates equations that can be used with non-uniform mesh refinement. In essence, the class overloads the fill_in_generic_residual_contribution_axisym_adv_diff() function so that contributions from hanging nodes (or alternatively in-compatible function values) are taken into account. More...
 
class  RefineableAxisymmetricNavierStokesEquations
 Refineable version of the Axisymmetric Navier–Stokes equations. More...
 
class  RefineableAxisymmetricQCrouzeixRaviartElement
 
class  RefineableAxisymmetricQTaylorHoodElement
 
class  RefineableBackwardStepQuadMesh
 Refineable backward step mesh. More...
 
class  RefineableBinArrayParameters
 Helper object for dealing with the parameters used for the RefineableBinArray objects. More...
 
class  RefineableBrickFromTetMesh
 
class  RefineableBrickMesh
 
class  RefineableBuoyantQCrouzeixRaviartElement
 
class  RefineableChannelWithLeafletMesh
 Refineable version of ChannelWithLeafletMesh. More...
 
class  RefineableCollapsibleChannelMesh
 
class  RefineableCylinderWithFlagMesh
 Refineable version of CylinderWithFlagMesh. More...
 
class  RefineableEighthSphereMesh
 
class  RefineableElement
 
class  RefineableFishMesh
 
class  RefineableFpPressureAdvDiffRobinBCElement
 
class  RefineableFSIDrivenCavityMesh
 
class  RefineableFSIImposeDisplacementByLagrangeMultiplierElement
 
class  RefineableFSISolidTractionElement
 
class  RefineableFullCircleMesh
 
class  RefineableGeneralisedAdvectionDiffusionEquations
 A version of the GeneralisedAdvection Diffusion equations that can be used with non-uniform mesh refinement. In essence, the class overloads the fill_in_generic_residual_contribution_cons_adv_diff() function so that contributions from hanging nodes (or alternatively in-compatible function values) are taken into account. More...
 
class  RefineableGeneralisedAxisymAdvectionDiffusionEquations
 A version of the GeneralisedAxisymAdvectionDiffusion equations that can be used with non-uniform mesh refinement. In essence, the class overloads the fill_in_generic_residual_contribution_cons_axisym_adv_diff() function so that contributions from hanging nodes (or alternatively in-compatible function values) are taken into account. More...
 
class  RefineableGeneralisedNewtonianAxisymmetricNavierStokesEquations
 Refineable version of the Axisymmetric Navier–Stokes equations. More...
 
class  RefineableGeneralisedNewtonianAxisymmetricQCrouzeixRaviartElement
 
class  RefineableGeneralisedNewtonianAxisymmetricQTaylorHoodElement
 
class  RefineableGeneralisedNewtonianNavierStokesEquations
 
class  RefineableGeneralisedNewtonianQCrouzeixRaviartElement
 Refineable version of Crouzeix Raviart elements. Generic class definitions. More...
 
class  RefineableGeneralisedNewtonianQTaylorHoodElement
 
class  RefineableGmshTetMesh
 
class  RefineableHelmholtzEquations
 
class  RefineableImposeDisplacementByLagrangeMultiplierElement
 
class  RefineableLinearElasticityEquations
 Class for Refineable LinearElasticity equations. More...
 
class  RefineableLinearisedAxisymmetricNavierStokesEquations
 Refineable version of the linearised axisymmetric Navier–Stokes equations. More...
 
class  RefineableLinearisedAxisymmetricQCrouzeixRaviartElement
 Refineable version of linearised axisymmetric quadratic Crouzeix-Raviart elements. More...
 
class  RefineableLinearisedAxisymmetricQTaylorHoodElement
 Refineable version of linearised axisymmetric quadratic Taylor-Hood elements. More...
 
class  RefineableLinearisedNavierStokesEquations
 Refineable version of the linearised axisymmetric Navier–Stokes equations. More...
 
class  RefineableLinearisedQCrouzeixRaviartElement
 Refineable version of linearised axisymmetric quadratic Crouzeix-Raviart elements. More...
 
class  RefineableLinearisedQTaylorHoodElement
 Refineable version of linearised axisymmetric quadratic Taylor-Hood elements. More...
 
class  RefineableLinearWaveEquations
 Refineable version of LinearWave equations. More...
 
class  RefineableLineMesh
 
class  RefineableMeshBase
 
class  RefineableNavierStokesBoussinesqElement
 
class  RefineableNavierStokesEquations
 
class  RefineableNavierStokesFluxControlElement
 
class  RefineableNavierStokesTractionElement
 
class  RefineableOneDMesh
 Refineable version of the OneDMesh. More...
 
class  RefineablePMLHelmholtzEquations
 
class  RefineablePoissonEquations
 
class  RefineablePolarCrouzeixRaviartElement
 Refineable version of Crouzeix Raviart elements. Generic class definitions. More...
 
class  RefineablePolarNavierStokesEquations
 
class  RefineablePolarTaylorHoodElement
 
class  RefineablePseudoSolidNodeUpdateElement
 Refineable version of the PseudoSolidNodeUpdateELement. More...
 
class  RefineablePVDEquations
 Class for Refineable PVD equations. More...
 
class  RefineablePVDEquationsWithPressure
 
class  RefineableQAdvectionDiffusionElement
 Refineable version of QAdvectionDiffusionElement. Inherit from the standard QAdvectionDiffusionElement and the appropriate refineable geometric element and the refineable equations. More...
 
class  RefineableQAdvectionDiffusionReactionElement
 Refineable version of QAdvectionDiffusionReactionElement. Inherit from the standard QAdvectionDiffusionReactionElement and the appropriate refineable geometric element and the refineable equations. More...
 
class  RefineableQAxisymAdvectionDiffusionElement
 Refineable version of QAxisymAdvectionDiffusionElement. Inherit from the standard QAxisymAdvectionDiffusionElement and the appropriate refineable geometric element and the refineable equations. More...
 
class  RefineableQCrouzeixRaviartElement
 Refineable version of Crouzeix Raviart elements. Generic class definitions. More...
 
class  RefineableQElement
 
class  RefineableQElement< 1 >
 
class  RefineableQElement< 2 >
 
class  RefineableQElement< 3 >
 
class  RefineableQGeneralisedAdvectionDiffusionElement
 Refineable version of QGeneralisedAdvectionDiffusionElement. Inherit from the standard QGeneralisedAdvectionDiffusionElement and the appropriate refineable geometric element and the refineable equations. More...
 
class  RefineableQGeneralisedAxisymAdvectionDiffusionElement
 Refineable version of QGeneralisedAxisymAdvectionDiffusionElement. Inherit from the standard QGeneralisedAxisymAdvectionDiffusionElement and the appropriate refineable geometric element and the refineable equations. More...
 
class  RefineableQHelmholtzElement
 
class  RefineableQLinearElasticityElement
 Class for refineable QLinearElasticityElement elements. More...
 
class  RefineableQLinearWaveElement
 
class  RefineableQPMLHelmholtzElement
 
class  RefineableQPoissonElement
 
class  RefineableQPVDElement
 Class for refineable QPVDElement elements. More...
 
class  RefineableQPVDElementWithContinuousPressure
 
class  RefineableQPVDElementWithPressure
 
class  RefineableQSpectralElement
 
class  RefineableQSpectralElement< 1 >
 
class  RefineableQSpectralElement< 2 >
 
class  RefineableQSpectralElement< 3 >
 
class  RefineableQSpectralPoissonElement
 
class  RefineableQSphericalAdvectionDiffusionElement
 Refineable version of QSphericalAdvectionDiffusionElement. Inherit from the standard QSphericalAdvectionDiffusionElement and the appropriate refineable geometric element and the refineable equations. More...
 
class  RefineableQSphericalCrouzeixRaviartElement
 
class  RefineableQSphericalTaylorHoodElement
 
class  RefineableQSUPGAdvectionDiffusionElement
 Refineable version of QSUPGAdvectionDiffusionElement. Inherit from the standard QSUPGAdvectionDiffusionElement and the appropriate refineable geometric element and the refineable equations. More...
 
class  RefineableQTaylorHoodElement
 
class  RefineableQTimeHarmonicLinearElasticityElement
 Class for refineable QTimeHarmonicLinearElasticityElement elements. More...
 
class  RefineableQuadFromTriangleMesh
 Unstructured refineable QuadFromTriangleMesh. More...
 
class  RefineableQuadMesh
 
class  RefineableQuarterCircleSectorMesh
 
class  RefineableQuarterPipeMesh
 Refineable quarter pipe mesh class. More...
 
class  RefineableQuarterTubeMesh
 
class  RefineableQUnsteadyHeatElement
 
class  RefineableQYoungLaplaceElement
 
class  RefineableRectangleWithHoleMesh
 
class  RefineableRectangularQuadMesh
 
class  RefineableSimpleCubicMesh
 Refineable version of simple cubic 3D Brick mesh class. More...
 
class  RefineableSolidBrickFromTetMesh
 
class  RefineableSolidElement
 
class  RefineableSolidQElement
 
class  RefineableSolidQElement< 1 >
 Refineable version of Solid line elements. More...
 
class  RefineableSolidQElement< 2 >
 Refineable version of Solid quad elements. More...
 
class  RefineableSolidQElement< 3 >
 Refineable version of Solid brick elements. More...
 
class  RefineableSolidQuadFromTriangleMesh
 Unstructured refineable QuadFromTriangleMesh upgraded to solid mesh. More...
 
class  RefineableSolidThinLayerBrickOnTetMesh
 
class  RefineableSolidTractionElement
 
class  RefineableSolidTriangleMesh
 Unstructured refineable Triangle Mesh upgraded to solid mesh. More...
 
class  RefineableSphericalAdvectionDiffusionEquations
 A version of the Advection Diffusion in spherical coordinates equations that can be used with non-uniform mesh refinement. In essence, the class overloads the fill_in_generic_residual_contribution_spherical_adv_diff() function so that contributions from hanging nodes (or alternatively in-compatible function values) are taken into account. More...
 
class  RefineableSphericalNavierStokesEquations
 Refineable version of the Spherical Navier–Stokes equations. More...
 
class  RefineableTetgenMesh
 
class  RefineableTetMeshBase
 Base class for refineable tet meshes. More...
 
class  RefineableThinLayerBrickOnTetMesh
 
class  RefineableTimeHarmonicLinearElasticityEquations
 Class for Refineable TimeHarmonicLinearElasticity equations. More...
 
class  RefineableTriangleMesh
 Unstructured refineable Triangle Mesh. More...
 
class  RefineableTubeMesh
 
class  RefineableTwoDAnnularMesh
 
class  RefineableUnsteadyHeatEquations
 
class  RefineableYoungLaplaceEquations
 
class  ReflectedIntegral
 
class  RungeKutta
 
class  RuntimeCalculatedGaussLegendre
 
class  SamplePointContainerParameters
 Helper object for dealing with the parameters used for the SamplePointContainer objects. More...
 
class  ScalarAdvectionEquations
 Base class for advection equations. More...
 
class  ScaleFreeBermudezPMLMapping
 
class  SegregatableFSIProblem
 
class  SegregatedSolverError
 A class to handle errors in the Segregated solver. More...
 
class  Shape
 
class  ShapeWithDeepCopy
 
class  SimpleCubicMesh
 Simple cubic 3D Brick mesh class. More...
 
class  SimpleCubicScaffoldTetMesh
 Scaffold mesh for cubic tet mesh. More...
 
class  SimpleCubicTetMesh
 MySimple 3D tet mesh for TElements. More...
 
class  SimpleFSIPreconditioner
 FSI preconditioner. This extracts upper/lower triangular blocks in the 3x3 overall block matrix structure arising from the monolithic discretisation of FSI problems with algebraic node updates. Dofs are decomposed into fluid velocity, pressure and solid unknowns. Blocks are then re-assembled into one global matrix and solved with a direct solver (SuperLU in its incarnation as an exact preconditioner). By default we retain the fluid on solid off diagonal blocks. More...
 
class  SimpleRectangularQuadMesh
 
class  SimpleRectangularTriMesh
 Simple 2D triangular mesh for TElements. More...
 
class  SingleLayerCubicSpineMesh
 
class  SingleLayerSpineMesh
 
class  SiskoTanMilRegWithBlendingConstitutiveEquation
 
class  SlopeLimiter
 Base class for slope limiters. More...
 
class  Smoother
 
class  SolidBrickFromTetMesh
 
class  SolidDiagQHermiteElement
 
class  SolidElementWithDiagonalMassMatrix
 
class  SolidFaceElement
 
class  SolidFiniteElement
 SolidFiniteElement class. More...
 
class  SolidICProblem
 IC problem for an elastic body discretised on a given (sub)-mesh. We switch the elements' residuals and Jacobians to the system of equations that forces the wall shape to become that of a specified "initial condition object". More...
 
class  SolidInitialCondition
 A class to specify the initial conditions for a solid body. Solid bodies are often discretised with Hermite-type elements, for which the assignment of the generalised nodal values is nontrivial since they represent derivatives w.r.t. to the local coordinates. A SolidInitialCondition object specifies initial position (i.e. shape), velocity and acceleration of the structure with a geometric object. An integer specifies which time-derivative derivative is currently assigned. See example codes for a demonstration of its use. More...
 
class  SolidMesh
 General SolidMesh class. More...
 
class  SolidNode
 A Class for nodes that deform elastically (i.e. position is an unknown in the problem). The idea is that the Eulerian positions are stored in a Data object and the Lagrangian coordinates are stored in addition. The pointer that addresses the Eulerian positions is set to the pointer to Value in the Data object. Hence, SolidNode uses knowledge of the internal structure of Data and must be a friend of the Data class. In order to allow a mesh to deform via an elastic-style equation in deforming-domain problems, the positions are stored separately from the values, so that elastic problems may be combined with any other type of problem. More...
 
class  SolidPointElement
 Solid point element. More...
 
class  SolidQElement
 
class  SolidQElement< 1, NNODE_1D >
 SolidQElement elements, specialised to one spatial dimension. More...
 
class  SolidQElement< 2, NNODE_1D >
 SolidQElement elements, specialised to two spatial dimensions. More...
 
class  SolidQElement< 3, NNODE_1D >
 SolidQElement elements, specialised to three spatial dimensions. More...
 
class  SolidQHermiteElement
 
class  SolidQuadFromTriangleMesh
 Unstructured QuadFromTriangleMesh upgraded to solid mesh. More...
 
class  SolidTBubbleEnrichedElement
 
class  SolidTBubbleEnrichedElement< DIM, 3 >
 
class  SolidTElement
 
class  SolidTElement< 1, NNODE_1D >
 SolidTElement elements, specialised to one spatial dimension. More...
 
class  SolidTElement< 2, NNODE_1D >
 SolidTElement elements, specialised to two spatial dimensions. More...
 
class  SolidTElement< 3, NNODE_1D >
 SolidTElement elements, specialised to three spatial dimensions. More...
 
class  SolidTetgenMesh
 
class  SolidThinLayerBrickOnTetMesh
 
class  SolidTractionElement
 
class  SolidTriangleMesh
 Unstructured Triangle Mesh upgraded to solid mesh. More...
 
class  SolidXdaTetMesh
 Xda-based tet mesh upgraded to become a solid mesh. More...
 
class  SolutionFunctor
 
class  SolutionFunctorBase
 
class  SparseMatrix
 
class  SpectralElement
 
class  SpectralPeriodicOrbitElement
 
class  SphericalAdvectionDiffusionEquations
 A class for all elements that solve the Advection Diffusion equations in a spherical polar coordinate system using isoparametric elements.

\[ Pe \mathbf{w}\cdot(\mathbf{x}) \nabla u = \nabla \cdot \left( \nabla u \right) + f(\mathbf{x}) \]

This contains the generic maths. Shape functions, geometric mapping etc. must get implemented in derived class. More...

 
class  SphericalAdvectionDiffusionFluxElement
 A class for elements that allow the imposition of an applied Robin boundary condition on the boundaries of Steady Axisymmnetric Advection Diffusion Flux elements.

\[ -\Delta u \cdot \mathbf{n} + \alpha(r,z) u = \beta(r,z) \]

The element geometry is obtained from the FaceGeometry<ELEMENT> policy class. More...

 
class  SphericalNavierStokesEquations
 
class  Spine
 
class  SpineAxisymmetricFluidInterfaceElement
 
class  SpineAxisymmetricSurfactantTransportInterfaceElement
 Specialise to the Axisymmetric geometry. More...
 
class  SpineAxisymmetricVolumeConstraintBoundingElement
 
class  SpineElement
 The SpineElement<ELEMENT> class takes an existing element as a template parameter and adds the necessary additional functionality to allow the element to be update using the Method of Spines. A vector of pointers to spines and storage for the local equation numbers associated with the spines are added to the element. More...
 
class  SpineFiniteElement
 A policy class that serves only to establish the interface for assigning the spine equation numbers. More...
 
class  SpineLineFluidInterfaceBoundingElement
 Spine version of the LineFluidInterfaceBoundingElement. More...
 
class  SpineLineFluidInterfaceElement
 
class  SpineLineSurfactantTransportInterfaceElement
 Specialise to the Line geometry. More...
 
class  SpineLineVolumeConstraintBoundingElement
 
class  SpineMesh
 
class  SpineNode
 
class  SpinePointFluidInterfaceBoundingElement
 Spine version of the PointFluidInterfaceBoundingElement. More...
 
class  SpineSurfaceFluidInterfaceElement
 
class  SpineSurfaceSurfactantTransportInterfaceElement
 Specialise to surface geometry. More...
 
class  SpineSurfaceVolumeConstraintBoundingElement
 
class  SpineUpdateFluidInterfaceElement
 Generic Spine node update interface template class that can be combined with a given surface equations class and surface derivative class to provide a concrete implementation of any surface element that uses spines. More...
 
class  Steady
 
class  SteadyAxisymAdvectionDiffusionEquations
 A class for all elements that solve the Steady Axisymmetric Advection Diffusion equations using isoparametric elements.

\[ Pe \mathbf{w}\cdot(\mathbf{x}) \nabla u = \nabla \cdot \left( \nabla u \right) + f(\mathbf{x}) \]

This contains the generic maths. Shape functions, geometric mapping etc. must get implemented in derived class. More...

 
class  SteadyAxisymAdvectionDiffusionFluxElement
 A class for elements that allow the imposition of an applied Robin boundary condition on the boundaries of Steady Axisymmnetric Advection Diffusion Flux elements.

\[ -\Delta u \cdot \mathbf{n} + \alpha(r,z) u = \beta(r,z) \]

The element geometry is obtained from the FaceGeometry<ELEMENT> policy class. More...

 
class  StorableShapeElement
 
class  StorableShapeElementBase
 
class  StorableShapeSolidElement
 
class  StorableShapeSolidElementBase
 
class  StraightLine
 
class  StrainEnergyFunction
 Base class for strain energy functions to be used in solid mechanics computations. More...
 
class  SumOfMatrices
 
class  SuperLUPreconditioner
 An interface to allow SuperLU to be used as an (exact) Preconditioner. More...
 
class  SuperLUSolver
 . SuperLU Project Solver class. This is a combined wrapper for both SuperLU and SuperLU Dist. See http://crd.lbl.gov/~xiaoye/SuperLU/ Default Behaviour: If this solver is distributed over more than one processor then SuperLU Dist is used. Member data naming convention: member data associated with the SuperLU Dist solver begins Dist_... and member data associated with the serial SuperLU solver begins Serial_... . More...
 
class  SurfaceDerivatives
 
class  SurfaceVolumeConstraintBoundingElement
 
class  SurfactantTransportInterfaceElement
 
class  TangentiallyDiscontinuousConformal2DPMLElement
 
class  TangentiallyDiscontinuousConformalPMLMapping
 
class  TangentiallyVaryingConformal2DPMLElement
 
class  TangentiallyVaryingConformalPMLMapping
 
class  TanhProfileConstitutiveEquation
 
class  TAxisymmetricLinearElasticityElement
 
class  TAxisymmetricPoroelasticityElement
 
class  TBubbleEnrichedElement
 
class  TBubbleEnrichedElement< DIM, 3 >
 
class  TBubbleEnrichedElementShape
 
class  TBubbleEnrichedElementShape< 2, 3 >
 Specific Enriched TElementShape inline functions. More...
 
class  TBubbleEnrichedElementShape< 3, 3 >
 Return local coordinates of node j. More...
 
class  TBubbleEnrichedGauss
 
class  TBubbleEnrichedGauss< 2, 3 >
 
class  TBubbleEnrichedGauss< 3, 3 >
 
class  TCrouzeixRaviartElement
 
class  TDisplacementBasedFoepplvonKarmanElement
 
class  TElement
 
class  TElement< 1, NNODE_1D >
 
class  TElement< 2, NNODE_1D >
 
class  TElement< 3, NNODE_1D >
 
class  TElementBase
 
class  TElementGeometricBase
 
class  TElementShape
 
class  TElementShape< 1, 2 >
 TElementShape inline functions: More...
 
class  TElementShape< 1, 3 >
 
class  TElementShape< 1, 4 >
 
class  TElementShape< 2, 2 >
 
class  TElementShape< 2, 3 >
 
class  TElementShape< 2, 4 >
 
class  TElementShape< 3, 2 >
 Return local coordinates of node j. More...
 
class  TElementShape< 3, 3 >
 Return local coordinates of node j. More...
 
class  TemplateFreeNavierStokesEquationsBase
 
class  TemplateFreeNavierStokesFluxControlElementBase
 
class  TemplateFreeWomersleyImpedanceTubeBase
 
class  TemplateFreeWomersleyMeshBase
 Template-free base class. More...
 
class  TensorProductIntegral
 
class  TensorProductIntegral< 2 >
 
class  TetEdge
 Helper class to keep track of edges in tet mesh generation. More...
 
class  TetgenMesh
 Unstructured tet mesh based on output from Tetgen: http://wias-berlin.de/software/tetgen/. More...
 
class  TetgenScaffoldMesh
 Mesh that is based on input files generated by the tetrahedra mesh generator tetgen. More...
 
class  TetMeshBase
 Base class for tet meshes (meshes made of 3D tet elements). More...
 
class  TetMeshFacet
 
class  TetMeshFacetedClosedSurface
 
class  TetMeshFacetedSurface
 
class  TetMeshVertex
 
class  TFace
 Triangular Face class. More...
 
class  TFoepplvonKarmanElement
 
class  TFourierDecomposedHelmholtzElement
 
class  TGauss
 
class  TGauss< 1, 2 >
 
class  TGauss< 1, 3 >
 
class  TGauss< 1, 4 >
 
class  TGauss< 1, 5 >
 
class  TGauss< 2, 13 >
 
class  TGauss< 2, 16 >
 
class  TGauss< 2, 2 >
 
class  TGauss< 2, 3 >
 
class  TGauss< 2, 4 >
 
class  TGauss< 2, 5 >
 
class  TGauss< 2, 9 >
 
class  TGauss< 3, 2 >
 
class  TGauss< 3, 3 >
 
class  TGauss< 3, 5 >
 
class  THelmholtzElement
 
class  ThinLayerBrickOnTetMesh
 
class  Time
 Class to keep track of discrete/continous time. It is essential to have a single Time object when using multiple time-stepping schemes; e.g., in fluid-structure interaction problems, it is common to use different schemes for the fluid and solid domains. Storage is allocated for the current value of the (continuous) time and a limited history of previous timesteps. The number of previous timesteps must be equal to the number required by the "highest order" scheme. More...
 
class  TimeHarmonicElasticityTensor
 
class  TimeHarmonicFourierDecomposedLinearElasticityEquations
 
class  TimeHarmonicFourierDecomposedLinearElasticityEquationsBase
 
class  TimeHarmonicFourierDecomposedLinearElasticityTractionElement
 
class  TimeHarmonicIsotropicElasticityTensor
 
class  TimeHarmonicLinearElasticityEquations
 
class  TimeHarmonicLinearElasticityEquationsBase
 
class  TimeHarmonicLinearElasticityTractionElement
 
class  TimeHarmonicLinElastLoadedByHelmholtzPressureBCElement
 
class  TimeHarmonicLinElastLoadedByPMLHelmholtzPressureBCElement
 
class  Timer
 Timer. More...
 
class  TimeStepper
 Base class for time-stepping schemes. Timestepper provides an approximation of the temporal derivatives of Data such that the i-th derivative of the j-th value in Data is represented as. More...
 
class  TLinearElasticityElement
 
class  TopologicallyRectangularDomain
 Topologically Rectangular Domain - a domain dexcribing a topologically rectangular problem - primarily contains functions to access the position of the global boundary relative to the macro element boundary, as well as first and second derivates of the global boundary wrt the macro element boundary NOTE : suitable for HermiteElementQuadMesh. More...
 
class  TPMLFourierDecomposedHelmholtzElement
 
class  TPMLHelmholtzElement
 
class  TPMLTimeHarmonicLinearElasticityElement
 
class  TPoissonElement
 
class  TPoroelasticityElement
 Element which solves the Darcy equations using TElements. More...
 
class  TPVDBubbleEnrichedElement
 
class  TPVDElement
 
class  TPVDElementWithContinuousPressure
 
class  TR
 
class  TRaviartThomasDarcyElement
 
class  Tree
 
class  TreeBasedRefineableMesh
 
class  TreeBasedRefineableMeshBase
 Base class for tree-based refineable meshes. More...
 
class  TreeForest
 
class  TreeRoot
 
class  TriangleMesh
 
class  TriangleMeshBase
 
class  TriangleMeshClosedCurve
 Base class defining a closed curve for the Triangle mesh generation. More...
 
class  TriangleMeshCurve
 
class  TriangleMeshCurveSection
 
class  TriangleMeshCurviLine
 
class  TriangleMeshOpenCurve
 
class  TriangleMeshParameters
 Helper object for dealing with the parameters used for the TriangleMesh objects. More...
 
class  TriangleMeshPolygon
 Class defining a closed polygon for the Triangle mesh generation. More...
 
class  TriangleMeshPolyLine
 Class defining a polyline for use in Triangle Mesh generation. More...
 
class  TriangleScaffoldMesh
 Triangle Mesh that is based on input files generated by the triangle mesh generator Triangle. More...
 
struct  TriangulateIO
 
class  TrilinosAztecOOSolver
 An interface to the Trilinos AztecOO classes allowing it to be used as an Oomph-lib LinearSolver. The AztecOO solver is a Krylov Subspace solver; the solver type (either CG, GMRES or BiCGStab) can be set using solver_type(). This solver can be preconditioned with Trilinos Preconditioners (derived from TrilinosPreconditionerBase) or Oomph-lib preconditioners (derived from Preconditioner). Preconditioners are set using preconditioner_pt(). More...
 
class  TrilinosIFPACKPreconditioner
 An interface to the Trilinos IFPACK class- provides a function to construct an IFPACK object, and functions to modify some of the IFPACK paramaters. More...
 
class  TrilinosMLPreconditioner
 An interface to the Trilinos ML class - provides a function to construct a serial ML object, and functions to modify some of the ML paramaters. More...
 
class  TrilinosPreconditionerBase
 Base class for Trilinos preconditioners as oomph-lib preconditioner. More...
 
class  TSolidElementBase
 Base class for Solid Telements. More...
 
class  TTaylorHoodElement
 
class  TTimeHarmonicFourierDecomposedLinearElasticityElement
 
class  TTimeHarmonicLinearElasticityElement
 
class  TubeDomain
 Tube as a domain. The entire domain must be defined by a GeomObject with the following convention: zeta[0] is the coordinate along the centreline, zeta[1] is the theta coordinate around the tube wall and zeta[2] is the radial coordinate. The outer boundary must lie at zeta[2] = 1. More...
 
class  TubeMesh
 3D tube mesh class. The domain is specified by the GeomObject that identifies the entire volume. Non-refineable base version! More...
 
class  TUnsteadyHeatElement
 
class  TwoDAnnularMesh
 
class  TwoLayerSpineMesh
 
class  TWomersleyElement
 
class  UniaxialPMLMapping
 
class  UnsteadyHeatEquations
 
class  UnsteadyHeatEquationsBase
 
class  UnsteadyHeatFluxElement
 A class for elements that allow the imposition of an applied flux on the boundaries of UnsteadyHeat elements. The element geometry is obtained from the FaceGeometry<ELEMENT> policy class. More...
 
class  UnstructuredTwoDMeshGeometryBase
 
class  Vector
 
class  Vector< bool >
 A Vector of bools cannot be created because the is no compiler-independent implementation of the bit manipulators. Making all the constructors private should lead to compile-time errors. More...
 
class  VectorMatrix
 
class  VolumeConstraintBoundingElement
 
class  VolumeConstraintElement
 
class  VorticitySmootherElement
 
class  WarpedCircularDisk
 Warped disk in 3d: zeta[0]=x; zeta[1]=y (so it doesn't have coordinate singularities), with specification of two boundaries (b=0,1) that turn the whole thing into a circular disk. More...
 
class  WarpedCircularDiskWithAnnularInternalBoundary
 Warped disk in 3d: zeta[0]=x; zeta[1]=y (so it doesn't have coordinate singularities), with specification of two boundaries (b=0,1) that turn the whole thing into a circular disk. In addition has two internal boundaries (b=2,3), a distance h_annulus from the outer edge. Annual (outer) region is region 1. More...
 
class  WarpedCubeDomain
 Warped cube as domain which is parametrised by a single macro element. More...
 
class  WomersleyEquations
 
class  WomersleyImpedanceTubeBase
 
class  WomersleyMesh
 
class  WomersleyOutflowImpedanceTube
 
class  WomersleyProblem
 Womersley problem. More...
 
class  XdaTetMesh
 Tet mesh made of quadratic (ten node) tets built from xda input file. More...
 
class  YoungLaplaceContactAngleElement
 A class for elements that allow the imposition of an contact angle bcs for Young Laplace elements. The element geometry is obtained from the FaceGeometry<ELEMENT> policy class. Jacobian is evaluated by finite differencing. More...
 
class  YoungLaplaceEquations
 
class  Z2ErrorEstimator
 

Typedefs

typedef void(* CoordinateMappingFctPt) (const Vector< double > &s, Vector< double > &s_bulk)
 Typedef for the function that translates the face coordinate to the coordinate in the bulk element. More...
 
typedef void(* BulkCoordinateDerivativesFctPt) (const Vector< double > &s, DenseMatrix< double > &ds_bulk_dsface, unsigned &interior_direction)
 Typedef for the function that returns the partial derivative of the local coordinates in the bulk element with respect to the coordinates along the face. In addition this function returns an index of one of the bulk local coordinates that varies away from the edge. More...
 
typedef FiniteElementFiniteElementPt
 
typedef GeneralisedElement GeneralisedElementTypedef
 

Enumerations

enum  Sample_Point_Container_Type { UseRefineableBinArray =1, UseNonRefineableBinArray, UseCGALSamplePointContainer }
 Enumeration to identify type of sample point container. More...
 

Functions

virtual unsigned u_index_cons_axisym_adv_diff () const
 A class for all elements that solve the Advection Diffusion equations in conservative form using isoparametric elements in a cylindrical polar coordinate system. {$$} ( Pe {$w$}({$x$}) u. More...
 
double du_dt_cons_axisym_adv_diff (const unsigned &n) const
 du/dt at local node n. More...
 
void disable_ALE ()
 Disable ALE, i.e. assert the mesh is not moving – you do this at your own risk! More...
 
void enable_ALE ()
 (Re-)enable ALE, i.e. take possible mesh motion into account when evaluating the time-derivative. Note: By default, ALE is enabled, at the expense of possibly creating unnecessary work in problems where the mesh is, in fact, stationary. More...
 
void output (std::ostream &outfile)
 Output with default number of plot points. More...
 
void output (std::ostream &outfile, const unsigned &nplot)
 Output FE representation of soln: r,z,u at nplot^2 plot points. More...
 
void output (FILE *file_pt)
 C_style output with default number of plot points. More...
 
void output (FILE *file_pt, const unsigned &n_plot)
 C-style output FE representation of soln: r,z,u at n_plot^2 plot points. More...
 
void output_fct (std::ostream &outfile, const unsigned &nplot, FiniteElement::SteadyExactSolutionFctPt exact_soln_pt)
 Output exact soln: r,z,u_exact at nplot^2 plot points. More...
 
virtual void output_fct (std::ostream &outfile, const unsigned &nplot, const double &time, FiniteElement::UnsteadyExactSolutionFctPt exact_soln_pt)
 Output exact soln: r,z,,u_exact at nplot^2 plot points (dummy time-dependent version to keep intel compiler happy) More...
 
void compute_error (std::ostream &outfile, FiniteElement::SteadyExactSolutionFctPt exact_soln_pt, double &error, double &norm)
 Get error against and norm of exact solution. More...
 
void compute_error (std::ostream &outfile, FiniteElement::UnsteadyExactSolutionFctPt exact_soln_pt, const double &time, double &error, double &norm)
 Dummy, time dependent error checker. More...
 
double integrate_u ()
 Integrate the concentration over the element. More...
 
GeneralisedAxisymAdvectionDiffusionSourceFctPt & source_fct_pt ()
 Access function: Pointer to source function. More...
 
GeneralisedAxisymAdvectionDiffusionWindFctPt & wind_fct_pt ()
 Access function: Pointer to wind function. More...
 
GeneralisedAxisymAdvectionDiffusionWindFctPt & conserved_wind_fct_pt ()
 Access function: Pointer to additional (conservative) wind function. More...
 
GeneralisedAxisymAdvectionDiffusionDiffFctPt & diff_fct_pt ()
 Access function: Pointer to diffusion function. More...
 
const double & pe () const
 Peclet number. More...
 
double *& pe_pt ()
 Pointer to Peclet number. More...
 
const double & pe_st () const
 Peclet number multiplied by Strouhal number. More...
 
double *& pe_st_pt ()
 Pointer to Peclet number multipled by Strouha number. More...
 
virtual void get_source_cons_axisym_adv_diff (const unsigned &ipt, const Vector< double > &x, double &source) const
 Get source term at (Eulerian) position x. This function is virtual to allow overloading in multi-physics problems where the strength of the source function might be determined by another system of equations. More...
 
virtual void get_wind_cons_axisym_adv_diff (const unsigned &ipt, const Vector< double > &s, const Vector< double > &x, Vector< double > &wind) const
 Get wind at (Eulerian) position x and/or local coordinate s. This function is virtual to allow overloading in multi-physics problems where the wind function might be determined by another system of equations. More...
 
virtual void get_conserved_wind_cons_axisym_adv_diff (const unsigned &ipt, const Vector< double > &s, const Vector< double > &x, Vector< double > &wind) const
 Get additional (conservative) wind at (Eulerian) position x and/or local coordinate s. This function is virtual to allow overloading in multi-physics problems where the wind function might be determined by another system of equations. More...
 
virtual void get_diff_cons_axisym_adv_diff (const unsigned &ipt, const Vector< double > &s, const Vector< double > &x, DenseMatrix< double > &D) const
 Get diffusivity tensor at (Eulerian) position x and/or local coordinate s. This function is virtual to allow overloading in multi-physics problems where the wind function might be determined by another system of equations. More...
 
void get_flux (const Vector< double > &s, Vector< double > &flux) const
 Get flux: $\mbox{flux}[i] = \mbox{d}u / \mbox{d}x_i $. More...
 
void get_total_flux (const Vector< double > &s, Vector< double > &total_flux) const
 Get flux: $\mbox{flux}[i] = \mbox{d}u / \mbox{d}x_i $. More...
 
void fill_in_contribution_to_residuals (Vector< double > &residuals)
 Add the element's contribution to its residual vector (wrapper) More...
 
void fill_in_contribution_to_jacobian (Vector< double > &residuals, DenseMatrix< double > &jacobian)
 Add the element's contribution to its residual vector and the element Jacobian matrix (wrapper) More...
 
void fill_in_contribution_to_jacobian_and_mass_matrix (Vector< double > &residuals, DenseMatrix< double > &jacobian, DenseMatrix< double > &mass_matrix)
 
double interpolated_u_cons_axisym_adv_diff (const Vector< double > &s) const
 Return FE representation of function value u(s) at local coordinate s. More...
 
unsigned self_test ()
 Self-test: Return 0 for OK. More...
 
virtual double dshape_and_dtest_eulerian_cons_axisym_adv_diff (const Vector< double > &s, Shape &psi, DShape &dpsidx, Shape &test, DShape &dtestdx) const =0
 Shape/test functions and derivs w.r.t. to global coords at local coord. s; return Jacobian of mapping. More...
 
virtual double dshape_and_dtest_eulerian_at_knot_cons_axisym_adv_diff (const unsigned &ipt, Shape &psi, DShape &dpsidx, Shape &test, DShape &dtestdx) const =0
 Shape/test functions and derivs w.r.t. to global coords at integration point ipt; return Jacobian of mapping. More...
 
virtual void fill_in_generic_residual_contribution_cons_axisym_adv_diff (Vector< double > &residuals, DenseMatrix< double > &jacobian, DenseMatrix< double > &mass_matrix, unsigned flag)
 Add the element's contribution to its residual vector only (if flag=and/or element Jacobian matrix. More...
 
int superlu_complex (int *, int *, int *, int *, std::complex< double > *, int *, int *, std::complex< double > *, int *, int *, int *, void *, int *)
 
std::ostream & operator<< (std::ostream &out, const DoubleVector &v)
 output operator More...
 
void post_midpoint_update (Data *dat_pt, const bool &update_pinned)
 
std::ostream & operator<< (std::ostream &stream, LinearAlgebraDistribution &dist)
 output operator More...
 
int superlu (int *, int *, int *, int *, double *, int *, int *, double *, int *, int *, int *, void *, int *)
 
void superlu_dist_global_matrix (int opt_flag, int allow_permutations, int n, int nnz, double *values, int *row_index, int *col_start, double *b, int nprow, int npcol, int doc, void **data, int *info, MPI_Comm comm)
 
void superlu_dist_distributed_matrix (int opt_flag, int allow_permutations, int n, int nnz_local, int nrow_local, int first_row, double *values, int *col_index, int *row_start, double *b, int nprow, int npcol, int doc, void **data, int *info, MPI_Comm comm)
 
void superlu_cr_to_cc (int nrow, int ncol, int nnz, double *cr_values, int *cr_index, int *cr_start, double **cc_values, int **cc_index, int **cc_start)
 
std::ostream & operator<< (std::ostream &out, const Node &nd)
 
void pause (std::string message)
 Pause and display message. More...
 
template<class Target , class Source >
Target checked_dynamic_cast (Source *x)
 Runtime checked dynamic cast. This is the safe but slightly slower cast. Use it in any of these cases: More...
 
template<class Target , class Source >
Target checked_static_cast (Source *x)
 Checked static cast. Only use this cast if ALL of these are true: More...
 
void METIS_PartGraphKway (int *, int *, int *, int *, int *, int *, int *, int *, int *, int *, int *)
 Metis graph partitioning function – decomposes nodal graph based on minimum edgecut. More...
 
void METIS_PartGraphVKway (int *, int *, int *, int *, int *, int *, int *, int *, int *, int *, int *)
 Metis graph partitioning function – decomposes nodal graph based on minimum communication volume. More...
 
void triangulate (char *triswitches, struct oomph::TriangulateIO *in, struct oomph::TriangulateIO *out, struct oomph::TriangulateIO *vorout)
 

Variables

double * Pe_pt
 Pointer to global Peclet number. More...
 
double * PeSt_pt
 Pointer to global Peclet number multiplied by Strouhal number. More...
 
GeneralisedAxisymAdvectionDiffusionSourceFctPt Source_fct_pt
 Pointer to source function: More...
 
GeneralisedAxisymAdvectionDiffusionWindFctPt Wind_fct_pt
 Pointer to wind function: More...
 
GeneralisedAxisymAdvectionDiffusionWindFctPt Conserved_wind_fct_pt
 Pointer to additional (conservative) wind function: More...
 
GeneralisedAxisymAdvectionDiffusionDiffFctPt Diff_fct_pt
 Pointer to diffusivity funciton. More...
 
bool ALE_is_disabled
 Boolean flag to indicate if ALE formulation is disabled when time-derivatives are computed. Only set to false if you're sure that the mesh is stationary. More...
 
static double Default_peclet_number
 Static default value for the Peclet number. More...
 
Nullstream oomph_nullstream
 Single (global) instantiation of the Nullstream. More...
 
OomphInfo oomph_info
 
OutputModifier default_output_modifier
 Single global instatiation of the default output modifier. More...
 
MPIOutputModifier oomph_mpi_output
 Single (global) instantiation of the mpi output modifier. More...
 
struct oomph::classcomp Bottom_left_sorter
 

Typedef Documentation

◆ BulkCoordinateDerivativesFctPt

typedef void(* oomph::BulkCoordinateDerivativesFctPt) (const Vector< double > &s, DenseMatrix< double > &ds_bulk_dsface, unsigned &interior_direction)

Typedef for the function that returns the partial derivative of the local coordinates in the bulk element with respect to the coordinates along the face. In addition this function returns an index of one of the bulk local coordinates that varies away from the edge.

Definition at line 1253 of file elements.h.

◆ CoordinateMappingFctPt

typedef void(* oomph::CoordinateMappingFctPt) (const Vector< double > &s, Vector< double > &s_bulk)

Typedef for the function that translates the face coordinate to the coordinate in the bulk element.

Definition at line 1245 of file elements.h.

◆ FiniteElementPt

Definition at line 48 of file pml_elements.h.

◆ GeneralisedElementTypedef

Definition at line 49 of file pml_elements.h.

Enumeration Type Documentation

◆ Sample_Point_Container_Type

Enumeration to identify type of sample point container.

Enumerator
UseRefineableBinArray 
UseNonRefineableBinArray 
UseCGALSamplePointContainer 

Definition at line 44 of file sample_point_parameters.h.

Function Documentation

◆ checked_dynamic_cast()

template<class Target , class Source >
Target oomph::checked_dynamic_cast ( Source *  x)
inline

Runtime checked dynamic cast. This is the safe but slightly slower cast. Use it in any of these cases:

  • You aren't entirely sure the cast is always safe.
  • You have strange inheritance structures (e.g. the "Diamond of Death" in element inheritance).
  • Efficiency is not critical. Note that if you just want to check if a pointer can be converted to some type you will need to use a plain dynamic_cast. Adapted from polymorphic_cast in boost/cast.hpp, see http://www.boost.org/doc/libs/1_52_0/libs/conversion/cast.htm for more details.

Definition at line 269 of file oomph_utilities.h.

Referenced by oomph::Mesh::get_node_reordering().

◆ checked_static_cast()

template<class Target , class Source >
Target oomph::checked_static_cast ( Source *  x)
inline

Checked static cast. Only use this cast if ALL of these are true:

  • You are sure that the cast will always succeed.
  • You aren't using any strange inheritance structures (e.g. the "Diamond of Death" in element inheritance, if you aren't sure just try compiling).
  • You need efficiency. Adapted from polymorphic_downcast in boost/cast.hpp, See http://www.boost.org/doc/libs/1_52_0/libs/conversion/cast.htm for more details.

Definition at line 291 of file oomph_utilities.h.

◆ compute_error() [1/2]

void oomph::compute_error ( std::ostream &  outfile,
FiniteElement::SteadyExactSolutionFctPt  exact_soln_pt,
double &  error,
double &  norm 
)

◆ compute_error() [2/2]

void oomph::compute_error ( std::ostream &  outfile,
FiniteElement::UnsteadyExactSolutionFctPt  exact_soln_pt,
const double &  time,
double &  error,
double &  norm 
)

Dummy, time dependent error checker.

Definition at line 212 of file gen_axisym_advection_diffusion_elements.h.

References integrate_u().

◆ conserved_wind_fct_pt()

GeneralisedAxisymAdvectionDiffusionWindFctPt oomph::conserved_wind_fct_pt ( )

Access function: Pointer to additional (conservative) wind function.

Access function: Pointer to additional (conservative) wind function. Const version.

Definition at line 248 of file gen_axisym_advection_diffusion_elements.h.

References Conserved_wind_fct_pt.

Referenced by oomph::RefineableGeneralisedAxisymAdvectionDiffusionEquations::further_build().

◆ diff_fct_pt()

GeneralisedAxisymAdvectionDiffusionDiffFctPt oomph::diff_fct_pt ( )

Access function: Pointer to diffusion function.

Access function: Pointer to diffusion function. Const version.

Definition at line 259 of file gen_axisym_advection_diffusion_elements.h.

References Diff_fct_pt.

◆ disable_ALE()

void oomph::disable_ALE ( )

Disable ALE, i.e. assert the mesh is not moving – you do this at your own risk!

Definition at line 147 of file gen_axisym_advection_diffusion_elements.h.

References ALE_is_disabled.

◆ dshape_and_dtest_eulerian_at_knot_cons_axisym_adv_diff()

virtual double oomph::dshape_and_dtest_eulerian_at_knot_cons_axisym_adv_diff ( const unsigned &  ipt,
Shape psi,
DShape dpsidx,
Shape test,
DShape dtestdx 
) const
protectedpure virtual

◆ dshape_and_dtest_eulerian_cons_axisym_adv_diff()

virtual double oomph::dshape_and_dtest_eulerian_cons_axisym_adv_diff ( const Vector< double > &  s,
Shape psi,
DShape dpsidx,
Shape test,
DShape dtestdx 
) const
protectedpure virtual

Shape/test functions and derivs w.r.t. to global coords at local coord. s; return Jacobian of mapping.

Referenced by interpolated_u_cons_axisym_adv_diff(), and QGeneralisedAxisymAdvectionDiffusionElement< NNODE_1D >::output_fct().

◆ du_dt_cons_axisym_adv_diff()

double oomph::du_dt_cons_axisym_adv_diff ( const unsigned &  n) const

◆ enable_ALE()

void oomph::enable_ALE ( )

(Re-)enable ALE, i.e. take possible mesh motion into account when evaluating the time-derivative. Note: By default, ALE is enabled, at the expense of possibly creating unnecessary work in problems where the mesh is, in fact, stationary.

Definition at line 157 of file gen_axisym_advection_diffusion_elements.h.

References ALE_is_disabled.

◆ fill_in_contribution_to_jacobian()

void oomph::fill_in_contribution_to_jacobian ( Vector< double > &  residuals,
DenseMatrix< double > &  jacobian 
)

◆ fill_in_contribution_to_jacobian_and_mass_matrix()

void oomph::fill_in_contribution_to_jacobian_and_mass_matrix ( Vector< double > &  residuals,
DenseMatrix< double > &  jacobian,
DenseMatrix< double > &  mass_matrix 
)

◆ fill_in_contribution_to_residuals()

void oomph::fill_in_contribution_to_residuals ( Vector< double > &  residuals)

◆ fill_in_generic_residual_contribution_cons_axisym_adv_diff()

virtual void oomph::fill_in_generic_residual_contribution_cons_axisym_adv_diff ( Vector< double > &  residuals,
DenseMatrix< double > &  jacobian,
DenseMatrix< double > &  mass_matrix,
unsigned  flag 
)
protectedvirtual

Add the element's contribution to its residual vector only (if flag=and/or element Jacobian matrix.

Referenced by fill_in_contribution_to_jacobian(), fill_in_contribution_to_jacobian_and_mass_matrix(), fill_in_contribution_to_residuals(), and interpolated_u_cons_axisym_adv_diff().

◆ get_conserved_wind_cons_axisym_adv_diff()

virtual void oomph::get_conserved_wind_cons_axisym_adv_diff ( const unsigned &  ipt,
const Vector< double > &  s,
const Vector< double > &  x,
Vector< double > &  wind 
) const
inlinevirtual

Get additional (conservative) wind at (Eulerian) position x and/or local coordinate s. This function is virtual to allow overloading in multi-physics problems where the wind function might be determined by another system of equations.

Definition at line 325 of file gen_axisym_advection_diffusion_elements.h.

References Conserved_wind_fct_pt, and i.

Referenced by oomph::RefineableGeneralisedAxisymAdvectionDiffusionEquations::fill_in_generic_residual_contribution_cons_axisym_adv_diff(), and get_total_flux().

◆ get_diff_cons_axisym_adv_diff()

virtual void oomph::get_diff_cons_axisym_adv_diff ( const unsigned &  ipt,
const Vector< double > &  s,
const Vector< double > &  x,
DenseMatrix< double > &  D 
) const
inlinevirtual

Get diffusivity tensor at (Eulerian) position x and/or local coordinate s. This function is virtual to allow overloading in multi-physics problems where the wind function might be determined by another system of equations.

Definition at line 350 of file gen_axisym_advection_diffusion_elements.h.

References oomph::OcTreeNames::D, Diff_fct_pt, and i.

Referenced by oomph::RefineableGeneralisedAxisymAdvectionDiffusionEquations::fill_in_generic_residual_contribution_cons_axisym_adv_diff(), and get_total_flux().

◆ get_flux()

void oomph::get_flux ( const Vector< double > &  s,
Vector< double > &  flux 
) const

◆ get_source_cons_axisym_adv_diff()

virtual void oomph::get_source_cons_axisym_adv_diff ( const unsigned &  ipt,
const Vector< double > &  x,
double &  source 
) const
inlinevirtual

Get source term at (Eulerian) position x. This function is virtual to allow overloading in multi-physics problems where the strength of the source function might be determined by another system of equations.

Definition at line 282 of file gen_axisym_advection_diffusion_elements.h.

References Source_fct_pt.

Referenced by oomph::RefineableGeneralisedAxisymAdvectionDiffusionEquations::fill_in_generic_residual_contribution_cons_axisym_adv_diff().

◆ get_total_flux()

void oomph::get_total_flux ( const Vector< double > &  s,
Vector< double > &  total_flux 
) const

◆ get_wind_cons_axisym_adv_diff()

virtual void oomph::get_wind_cons_axisym_adv_diff ( const unsigned &  ipt,
const Vector< double > &  s,
const Vector< double > &  x,
Vector< double > &  wind 
) const
inlinevirtual

Get wind at (Eulerian) position x and/or local coordinate s. This function is virtual to allow overloading in multi-physics problems where the wind function might be determined by another system of equations.

Definition at line 300 of file gen_axisym_advection_diffusion_elements.h.

References i, and Wind_fct_pt.

Referenced by oomph::RefineableGeneralisedAxisymAdvectionDiffusionEquations::fill_in_generic_residual_contribution_cons_axisym_adv_diff().

◆ integrate_u()

double oomph::integrate_u ( )

Integrate the concentration over the element.

Referenced by compute_error().

◆ interpolated_u_cons_axisym_adv_diff()

double oomph::interpolated_u_cons_axisym_adv_diff ( const Vector< double > &  s) const
inline

◆ METIS_PartGraphKway()

void oomph::METIS_PartGraphKway ( int *  ,
int *  ,
int *  ,
int *  ,
int *  ,
int *  ,
int *  ,
int *  ,
int *  ,
int *  ,
int *   
)

Metis graph partitioning function – decomposes nodal graph based on minimum edgecut.

Referenced by oomph::METIS::partition_distributed_mesh(), and oomph::METIS::partition_mesh().

◆ METIS_PartGraphVKway()

void oomph::METIS_PartGraphVKway ( int *  ,
int *  ,
int *  ,
int *  ,
int *  ,
int *  ,
int *  ,
int *  ,
int *  ,
int *  ,
int *   
)

Metis graph partitioning function – decomposes nodal graph based on minimum communication volume.

Referenced by oomph::METIS::partition_distributed_mesh(), and oomph::METIS::partition_mesh().

◆ operator<<() [1/3]

std::ostream& oomph::operator<< ( std::ostream &  stream,
LinearAlgebraDistribution dist 
)

◆ operator<<() [2/3]

std::ostream& oomph::operator<< ( std::ostream &  out,
const Node nd 
)

Node output operator: output equation numbers and values at all times, along with any extra information stored for the timestepper.

Definition at line 359 of file nodes.cc.

References oomph::Node::ndim(), oomph::Data::ntstorage(), t, and oomph::Node::x().

◆ operator<<() [3/3]

std::ostream& oomph::operator<< ( std::ostream &  out,
const DoubleVector v 
)

output operator

Ouput operator for DoubleVector.

Definition at line 949 of file double_vector.cc.

References i.

◆ output() [1/4]

void oomph::output ( std::ostream &  outfile)

Output with default number of plot points.

Definition at line 164 of file gen_axisym_advection_diffusion_elements.h.

Referenced by oomph::Node::all_geom_object_pt(), oomph::CommandLineArgs::check_arg_index(), oomph::VectorHelpers::cross(), oomph::TriangleMeshCurve::disable_polyline_unrefinement(), RefineableBin::operator=(), oomph::UnsteadyHeatFluxElement< ELEMENT >::output(), oomph::FourierDecomposedHelmholtzEquations::output(), output(), oomph::AxisymmetricNavierStokesTractionElement< ELEMENT >::output(), oomph::DarcyFaceElement< ELEMENT >::output(), oomph::SolidTractionElement< ELEMENT >::output(), oomph::AxisymmetricLinearElasticityTractionElement< ELEMENT >::output(), oomph::PMLFourierDecomposedHelmholtzEquationsBase::output(), oomph::TimeHarmonicLinearElasticityTractionElement< ELEMENT >::output(), oomph::PMLTimeHarmonicLinearElasticityTractionElement< ELEMENT >::output(), oomph::LinearisedAxisymPoroelasticBJS_FSIElement< FLUID_BULK_ELEMENT, POROELASTICITY_BULK_ELEMENT >::output(), oomph::FourierDecomposedTimeHarmonicLinElastLoadedByHelmholtzPressureBCElement< ELASTICITY_BULK_ELEMENT, HELMHOLTZ_BULK_ELEMENT >::output(), oomph::TimeHarmonicLinElastLoadedByHelmholtzPressureBCElement< ELASTICITY_BULK_ELEMENT, HELMHOLTZ_BULK_ELEMENT >::output(), oomph::TimeHarmonicLinElastLoadedByPMLHelmholtzPressureBCElement< ELASTICITY_BULK_ELEMENT, HELMHOLTZ_BULK_ELEMENT >::output(), oomph::AxisymmetricPoroelasticityTractionElement< POROELASTICITY_BULK_ELEMENT >::output(), oomph::SpineUpdateFluidInterfaceElement< FluidInterfaceElement, LineDerivatives, ELEMENT >::output(), oomph::WomersleyEquations< DIM >::output(), oomph::TetMeshFacetedSurface::output(), oomph::PseudoSolidNodeUpdateElement< BASIC, SOLID >::output(), oomph::QSpectralElement< 1, NNODE_1D >::output(), oomph::SolidQHermiteElement< 2 >::output(), oomph::FourierDecomposedHelmholtzFluxFromNormalDisplacementBCElement< HELMHOLTZ_BULK_ELEMENT, ELASTICITY_BULK_ELEMENT >::output(), oomph::HelmholtzFluxFromNormalDisplacementBCElement< HELMHOLTZ_BULK_ELEMENT, ELASTICITY_BULK_ELEMENT >::output(), oomph::FSIAxisymmetricLinearElasticityTractionElement< ELASTICITY_BULK_ELEMENT, NAVIER_STOKES_BULK_ELEMENT >::output(), oomph::QElement< 1, NNODE_1D >::output(), oomph::LinearisedFSIAxisymmetricNStNoSlipBCElementElement< FLUID_BULK_ELEMENT, SOLID_BULK_ELEMENT >::output(), oomph::QSpectralElement< 2, NNODE_1D >::output(), oomph::ElasticUpdateFluidInterfaceElement< FluidInterfaceElement, LineDerivatives, ELEMENT >::output(), oomph::ProjectableDarcyElement< DARCY_ELEMENT >::output(), oomph::PMLHelmholtzFluxFromNormalDisplacementBCElement< HELMHOLTZ_BULK_ELEMENT, ELASTICITY_BULK_ELEMENT >::output(), oomph::ProjectableFourierDecomposedHelmholtzElement< FOURIER_DECOMPOSED_HELMHOLTZ_ELEMENT >::output(), oomph::ProjectableHelmholtzElement< HELMHOLTZ_ELEMENT >::output(), oomph::ProjectablePMLFourierDecomposedHelmholtzElement< FOURIER_DECOMPOSED_HELMHOLTZ_ELEMENT >::output(), oomph::QElement< 2, NNODE_1D >::output(), oomph::QSpectralElement< 3, NNODE_1D >::output(), oomph::ProjectablePMLHelmholtzElement< HELMHOLTZ_ELEMENT >::output(), oomph::RefineablePseudoSolidNodeUpdateElement< BASIC, SOLID >::output(), oomph::QElement< 3, NNODE_1D >::output(), oomph::TElement< 1, NNODE_1D >::output(), oomph::ImposeDisplacementByLagrangeMultiplierElement< ELEMENT >::output(), oomph::ProjectableAxisymmetricPoroelasticityElement< AXISYMMETRIC_POROELASTICITY_ELEMENT >::output(), oomph::TElement< 2, NNODE_1D >::output(), oomph::NavierStokesImpedanceTractionElement< BULK_NAVIER_STOKES_ELEMENT, WOMERSLEY_ELEMENT, DIM >::output(), oomph::FSIImposeDisplacementByLagrangeMultiplierElement< ELEMENT >::output(), oomph::TElement< 3, NNODE_1D >::output(), oomph::StringConversion::to_lower(), oomph::StringConversion::to_upper(), oomph::TElement< 1, NNODE_1D >::write_paraview_offsets(), oomph::TElement< 2, NNODE_1D >::write_paraview_offsets(), oomph::TElement< 3, NNODE_1D >::write_paraview_offsets(), and oomph::TriangleMeshCurveSection::~TriangleMeshCurveSection().

◆ output() [2/4]

void oomph::output ( std::ostream &  outfile,
const unsigned &  nplot 
)

Output FE representation of soln: r,z,u at nplot^2 plot points.

◆ output() [3/4]

void oomph::output ( FILE *  file_pt)

C_style output with default number of plot points.

Definition at line 175 of file gen_axisym_advection_diffusion_elements.h.

References output(), and output_fct().

◆ output() [4/4]

void oomph::output ( FILE *  file_pt,
const unsigned &  n_plot 
)

C-style output FE representation of soln: r,z,u at n_plot^2 plot points.

Referenced by QGeneralisedAxisymAdvectionDiffusionElement< NNODE_1D >::output().

◆ output_fct() [1/2]

void oomph::output_fct ( std::ostream &  outfile,
const unsigned &  nplot,
FiniteElement::SteadyExactSolutionFctPt  exact_soln_pt 
)

◆ output_fct() [2/2]

virtual void oomph::output_fct ( std::ostream &  outfile,
const unsigned &  nplot,
const double &  time,
FiniteElement::UnsteadyExactSolutionFctPt  exact_soln_pt 
)
virtual

Output exact soln: r,z,,u_exact at nplot^2 plot points (dummy time-dependent version to keep intel compiler happy)

Definition at line 194 of file gen_axisym_advection_diffusion_elements.h.

References compute_error().

Referenced by QGeneralisedAxisymAdvectionDiffusionElement< NNODE_1D >::output_fct().

◆ pause()

void oomph::pause ( std::string  message)

◆ pe()

const double& oomph::pe ( ) const

◆ pe_pt()

double* & oomph::pe_pt ( )

Pointer to Peclet number.

Definition at line 270 of file gen_axisym_advection_diffusion_elements.h.

References Pe_pt.

◆ pe_st()

const double& oomph::pe_st ( ) const

◆ pe_st_pt()

double* & oomph::pe_st_pt ( )

Pointer to Peclet number multipled by Strouha number.

Definition at line 276 of file gen_axisym_advection_diffusion_elements.h.

References PeSt_pt.

◆ post_midpoint_update()

void oomph::post_midpoint_update ( Data dat_pt,
const bool &  update_pinned 
)

Local (not exported in header) helper function to handle midpoint update on a data object.

Definition at line 190 of file implicit_midpoint_rule.cc.

References oomph::Data::eqn_number(), oomph::Data::is_a_copy(), oomph::Data::nvalue(), oomph::Data::set_value(), and oomph::Data::value().

Referenced by oomph::IMRByBDF::actions_after_timestep().

◆ self_test()

unsigned oomph::self_test ( )

◆ source_fct_pt()

GeneralisedAxisymAdvectionDiffusionSourceFctPt oomph::source_fct_pt ( )

Access function: Pointer to source function.

Access function: Pointer to source function. Const version.

Definition at line 228 of file gen_axisym_advection_diffusion_elements.h.

References Source_fct_pt.

Referenced by oomph::BiharmonicProblem< DIM >::set_source_function().

◆ superlu()

int oomph::superlu ( int *  ,
int *  ,
int *  ,
int *  ,
double *  ,
int *  ,
int *  ,
double *  ,
int *  ,
int *  ,
int *  ,
void *  ,
int *   
)

◆ superlu_complex()

int oomph::superlu_complex ( int *  ,
int *  ,
int *  ,
int *  ,
std::complex< double > *  ,
int *  ,
int *  ,
std::complex< double > *  ,
int *  ,
int *  ,
int *  ,
void *  ,
int *   
)

◆ superlu_cr_to_cc()

void oomph::superlu_cr_to_cc ( int  nrow,
int  ncol,
int  nnz,
double *  cr_values,
int *  cr_index,
int *  cr_start,
double **  cc_values,
int **  cc_index,
int **  cc_start 
)

◆ superlu_dist_distributed_matrix()

void oomph::superlu_dist_distributed_matrix ( int  opt_flag,
int  allow_permutations,
int  n,
int  nnz_local,
int  nrow_local,
int  first_row,
double *  values,
int *  col_index,
int *  row_start,
double *  b,
int  nprow,
int  npcol,
int  doc,
void **  data,
int *  info,
MPI_Comm  comm 
)

◆ superlu_dist_global_matrix()

void oomph::superlu_dist_global_matrix ( int  opt_flag,
int  allow_permutations,
int  n,
int  nnz,
double *  values,
int *  row_index,
int *  col_start,
double *  b,
int  nprow,
int  npcol,
int  doc,
void **  data,
int *  info,
MPI_Comm  comm 
)

◆ triangulate()

void oomph::triangulate ( char *  triswitches,
struct oomph::TriangulateIO in,
struct oomph::TriangulateIO out,
struct oomph::TriangulateIO vorout 
)

◆ u_index_cons_axisym_adv_diff()

virtual unsigned oomph::u_index_cons_axisym_adv_diff ( ) const
inlinevirtual

A class for all elements that solve the Advection Diffusion equations in conservative form using isoparametric elements in a cylindrical polar coordinate system. {$$} ( Pe {$w$}({$x$}) u.

  • D({$x$){$$} u) = f({$x$}) This contains the generic maths. Shape functions, geometric

    mapping etc. must get implemented in derived class.

class GeneralisedAxisymAdvectionDiffusionEquations : public virtual FiniteElement {

public:

Function pointer to source function fct(x,f(x)) – x is a Vector! typedef void (*GeneralisedAxisymAdvectionDiffusionSourceFctPt) (const Vector<double>& x, double& f);

Function pointer to wind function fct(x,w(x)) – x is a Vector! typedef void (*GeneralisedAxisymAdvectionDiffusionWindFctPt) (const Vector<double>& x, Vector<double>& wind);

Function pointer to a diffusivity function typedef void (*GeneralisedAxisymAdvectionDiffusionDiffFctPt) (const Vector<double> &x, DenseMatrix<double> &D);

Constructor: Initialise the Source_fct_pt and Wind_fct_pt to null and set (pointer to) Peclet number to default GeneralisedAxisymAdvectionDiffusionEquations() : Source_fct_pt(0), Wind_fct_pt(0), Conserved_wind_fct_pt(0), Diff_fct_pt(0), ALE_is_disabled(false) { Set Peclet number to default Pe_pt = Set Peclet Strouhal number to default PeSt_pt = }

Broken copy constructor GeneralisedAxisymAdvectionDiffusionEquations( const GeneralisedAxisymAdvectionDiffusionEquations& dummy) { BrokenCopy::broken_copy("GeneralisedAxisymAdvectionDiffusionEquations"); }

Broken assignment operator Commented out broken assignment operator because this can lead to a conflict warning when used in the virtual inheritence hierarchy. Essentially the compiler doesn't realise that two separate implementations of the broken function are the same and so, quite rightly, it shouts. /*void operator=(const GeneralisedAxisymAdvectionDiffusionEquations&) { BrokenCopy::broken_assign("GeneralisedAxisymAdvectionDiffusionEquations"); } Return the index at which the unknown value is stored. The default value, 0, is appropriate for single-physics problems, when there is only one variable, the value that satisfies the advection-diffusion equation. In derived multi-physics elements, this function should be overloaded to reflect the chosen storage scheme. Note that these equations require that the unknown is always stored at the same index at each node.

Definition at line 117 of file gen_axisym_advection_diffusion_elements.h.

Referenced by du_dt_cons_axisym_adv_diff(), oomph::RefineableGeneralisedAxisymAdvectionDiffusionEquations::fill_in_generic_residual_contribution_cons_axisym_adv_diff(), get_flux(), oomph::RefineableGeneralisedAxisymAdvectionDiffusionEquations::get_interpolated_values(), get_total_flux(), and interpolated_u_cons_axisym_adv_diff().

◆ wind_fct_pt()

GeneralisedAxisymAdvectionDiffusionWindFctPt oomph::wind_fct_pt ( )

Access function: Pointer to wind function.

Access function: Pointer to wind function. Const version.

Definition at line 238 of file gen_axisym_advection_diffusion_elements.h.

References Wind_fct_pt.

Variable Documentation

◆ ALE_is_disabled

bool oomph::ALE_is_disabled
protected

Boolean flag to indicate if ALE formulation is disabled when time-derivatives are computed. Only set to false if you're sure that the mesh is stationary.

Definition at line 585 of file gen_axisym_advection_diffusion_elements.h.

Referenced by oomph::GeneralisedNewtonianNavierStokesEquations< DIM >::d_kin_energy_dt(), oomph::NavierStokesEquations< DIM >::d_kin_energy_dt(), disable_ALE(), oomph::UnsteadyHeatEquations< DIM >::disable_ALE(), enable_ALE(), oomph::UnsteadyHeatEquations< DIM >::enable_ALE(), oomph::RefineableAdvectionDiffusionEquations< DIM >::fill_in_generic_residual_contribution_adv_diff(), oomph::AdvectionDiffusionEquations< DIM >::fill_in_generic_residual_contribution_adv_diff(), oomph::RefineableAdvectionDiffusionReactionEquations< NREAGENT, DIM >::fill_in_generic_residual_contribution_adv_diff_react(), oomph::AdvectionDiffusionReactionEquations< NREAGENT, DIM >::fill_in_generic_residual_contribution_adv_diff_react(), oomph::RefineableGeneralisedAdvectionDiffusionEquations< DIM >::fill_in_generic_residual_contribution_cons_adv_diff(), oomph::GeneralisedAdvectionDiffusionEquations< DIM >::fill_in_generic_residual_contribution_cons_adv_diff(), oomph::RefineableGeneralisedAxisymAdvectionDiffusionEquations::fill_in_generic_residual_contribution_cons_axisym_adv_diff(), oomph::RefineableGeneralisedNewtonianNavierStokesEquations< DIM >::fill_in_generic_residual_contribution_nst(), oomph::GeneralisedNewtonianNavierStokesEquations< DIM >::fill_in_generic_residual_contribution_nst(), oomph::RefineableNavierStokesEquations< DIM >::fill_in_generic_residual_contribution_nst(), oomph::NavierStokesEquations< DIM >::fill_in_generic_residual_contribution_nst(), oomph::RefineableUnsteadyHeatEquations< DIM >::fill_in_generic_residual_contribution_ust_heat(), oomph::UnsteadyHeatEquations< DIM >::fill_in_generic_residual_contribution_ust_heat(), oomph::RefineableGeneralisedAxisymAdvectionDiffusionEquations::further_build(), oomph::RefineableNavierStokesEquations< DIM >::further_build(), oomph::RefineableGeneralisedNewtonianNavierStokesEquations< DIM >::get_dresidual_dnodal_coordinates(), oomph::RefineableNavierStokesEquations< DIM >::get_dresidual_dnodal_coordinates(), oomph::GeneralisedNewtonianNavierStokesEquations< DIM >::get_dresidual_dnodal_coordinates(), and oomph::NavierStokesEquations< DIM >::get_dresidual_dnodal_coordinates().

◆ Bottom_left_sorter

struct oomph::classcomp oomph::Bottom_left_sorter

◆ Conserved_wind_fct_pt

GeneralisedAxisymAdvectionDiffusionWindFctPt oomph::Conserved_wind_fct_pt
protected

◆ default_output_modifier

OutputModifier oomph::default_output_modifier

Single global instatiation of the default output modifier.

Definition at line 317 of file oomph_definitions.cc.

Referenced by oomph::OutputModifier::operator()().

◆ Default_peclet_number

double oomph::Default_peclet_number
staticprivate

Static default value for the Peclet number.

Definition at line 590 of file gen_axisym_advection_diffusion_elements.h.

◆ Diff_fct_pt

GeneralisedAxisymAdvectionDiffusionDiffFctPt oomph::Diff_fct_pt
protected

◆ oomph_info

OomphInfo oomph::oomph_info

Single (global) instantiation of the OomphInfo object – this is used throughout the library as a "replacement" for std::cout

Definition at line 311 of file oomph_definitions.cc.

Referenced by oomph::BiharmonicProblem< DIM >::actions_before_newton_solve(), oomph::BiharmonicFluidProblem< DIM >::actions_before_newton_solve(), oomph::NonLinearElasticitySmoothMesh< ELEMENT >::actions_before_newton_solve(), oomph::RefineableTetgenMesh< ELEMENT >::adapt(), oomph::TreeBasedRefineableMeshBase::adapt(), oomph::RefineableGmshTetMesh< ELEMENT >::adapt(), oomph::RefineableTriangleMesh< ELEMENT >::adapt(), oomph::Problem::adapt(), oomph::Problem::adapt_based_on_error_estimates(), oomph::TreeBasedRefineableMeshBase::adapt_mesh(), oomph::PeriodicOrbitAssemblyHandler< NNODE_1D >::adapt_temporal_mesh(), oomph::Problem::adaptive_unsteady_newton_solve(), oomph::RefineableTriangleMesh< ELEMENT >::add_element_load_balance_helper(), oomph::GeneralisedElement::add_external_data(), oomph::Missing_masters_functions::add_external_halo_master_node_helper(), oomph::Multi_domain_functions::add_external_halo_master_node_helper(), oomph::Missing_masters_functions::add_external_halo_node_helper(), oomph::Multi_domain_functions::add_external_halo_node_helper(), oomph::RefineableTriangleMesh< ELEMENT >::add_halo_element_helper(), oomph::RefineableTriangleMesh< ELEMENT >::add_halo_node_helper(), oomph::GeneralisedElement::add_internal_data(), oomph::RefineableTriangleMesh< ELEMENT >::add_received_node_load_balance_helper(), oomph::Problem::add_time_stepper_pt(), oomph::TreeBasedRefineableMesh< oomph::SpectralPeriodicOrbitElement< NNODE_1D > >::additional_synchronise_hanging_nodes(), oomph::Problem::arc_length_step_solve(), oomph::Problem::arc_length_step_solve_helper(), oomph::TetMeshBase::assess_mesh_quality(), oomph::Problem::assign_eqn_numbers(), oomph::Multi_domain_functions::aux_setup_multi_domain_interaction(), oomph::MumpsSolver::backsub(), oomph::Problem::bifurcation_adapt_helper(), oomph::BlackBoxFDNewtonSolver::black_box_fd_newton_solve(), oomph::HelmholtzMGPreconditioner< DIM >::block_preconditioner_self_test(), oomph::BrethertonSpineMesh< ELEMENT, INTERFACE_ELEMENT >::BrethertonSpineMesh(), oomph::QSpectralElement< 3, NNODE_1D >::build_face_element(), oomph::MeshAsGeomObject::build_it(), oomph::FishMesh< ELEMENT >::build_mesh(), oomph::TriangleMesh< ELEMENT >::build_triangulateio(), oomph::CassonTanMilRegWithBlendingConstitutiveEquation< DIM >::CassonTanMilRegWithBlendingConstitutiveEquation(), CGALSamplePointContainer::CGALSamplePointContainer(), oomph::BinaryTreeForest::check_all_neighbours(), oomph::QuadTreeForest::check_all_neighbours(), oomph::OcTreeForest::check_all_neighbours(), oomph::Mesh::check_for_repeated_nodes(), oomph::Mesh::check_halo_schemes(), oomph::Problem::check_halo_schemes(), oomph::HypreHelpers::check_HYPRE_error_flag(), oomph::RefineableQElement< 3 >::check_integrity(), oomph::RefineableQElement< 1 >::check_integrity(), oomph::RefineableQElement< 2 >::check_integrity(), oomph::PRefineableQElement< 2, INITIAL_NNODE_1D >::check_integrity(), oomph::TreeBasedRefineableMeshBase::classify_halo_and_haloed_nodes(), oomph::Mesh::classify_halo_and_haloed_nodes(), oomph::TreeBasedRefineableMeshBase::complete_hanging_nodes(), oomph::ComplexDampedJacobi< MATRIX >::complex_solve_helper(), oomph::ComplexGMRES< MATRIX >::complex_solve_helper(), oomph::RefineableTriangleMesh< ELEMENT >::compute_area_target(), oomph::CRDoubleMatrixHelpers::concatenate(), oomph::Missing_masters_functions::construct_new_external_halo_master_node_helper(), oomph::Multi_domain_functions::construct_new_external_halo_master_node_helper(), oomph::Missing_masters_functions::construct_new_external_halo_node_helper(), oomph::Multi_domain_functions::construct_new_external_halo_node_helper(), oomph::RefineableTriangleMesh< ELEMENT >::construct_new_halo_node_helper(), oomph::RefineableTriangleMesh< ELEMENT >::construct_new_node_load_balance_helper(), oomph::Problem::copy(), oomph::RefineableTriangleMesh< ELEMENT >::create_element_load_balance_helper(), oomph::Multi_domain_functions::create_external_halo_elements(), oomph::RefineableTriangleMesh< ELEMENT >::create_halo_element(), oomph::GmshTetScaffoldMesh::create_mesh_from_msh_file(), oomph::RefineableTriangleMesh< ELEMENT >::create_new_shared_boundaries(), oomph::FiniteElement::d_dshape_eulerian_dnodal_coordinates_templated_helper(), oomph::Problem::debug_hook_fct(), oomph::HelmholtzMGPreconditioner< DIM >::disable_output(), oomph::MGSolver< DIM >::disable_output(), oomph::Problem::disable_store_local_dof_pt_in_elements(), oomph::Mesh::distribute(), oomph::Problem::distribute(), oomph::FiniteElement::dJ_eulerian_dnodal_coordinates_templated_helper(), oomph::LeakCheckNames::doc(), oomph::CommandLineArgs::doc_available_flags(), oomph::Mesh::doc_boundary_coordinates(), oomph::Problem::doc_errors(), oomph::OcTree::doc_face_neighbours(), oomph::Mesh::doc_shared_nodes(), oomph::BiharmonicProblem< DIM >::doc_solution(), oomph::BiharmonicFluidProblem< DIM >::doc_solution(), oomph::NonLinearElasticitySmoothMesh< ELEMENT >::doc_solution(), oomph::CommandLineArgs::doc_specified_flags(), oomph::OcTree::doc_true_edge_neighbours(), oomph::BlockPreconditioner< CRDoubleMatrix >::document(), oomph::Problem::doubly_adaptive_unsteady_newton_solve_helper(), oomph::PRefineableQElement< 1, INITIAL_NNODE_1D >::dshape_local(), oomph::CRDoubleMatrix::entries_are_sorted(), oomph::MumpsSolver::factorise(), oomph::SolidFiniteElement::fill_in_generic_jacobian_for_solid_ic(), oomph::BrethertonSpineMesh< ELEMENT, INTERFACE_ELEMENT >::find_distance_to_free_surface(), oomph::HelmholtzMGPreconditioner< DIM >::full_setup(), oomph::MGSolver< DIM >::full_setup(), oomph::FullCircleMesh< ELEMENT >::FullCircleMesh(), oomph::GeompackQuadScaffoldMesh::GeompackQuadScaffoldMesh(), oomph::Problem::get_all_error_estimates(), oomph::KirchhoffLoveShellEquations::get_energy(), oomph::Problem::get_inverse_mass_matrix_times_residuals(), oomph::FpPressureAdvectionDiffusionProblem< ELEMENT >::get_pressure_advection_diffusion_jacobian(), oomph::VorticitySmootherElement< ELEMENT >::get_raw_velocity_deriv(), oomph::VorticitySmootherElement< ELEMENT >::get_raw_vorticity_deriv(), oomph::VorticitySmootherElement< ELEMENT >::get_raw_vorticity_second_deriv(), oomph::VorticitySmootherElement< ELEMENT >::get_raw_vorticity_third_deriv(), VorticitySmoother< ELEMENT >::get_recovered_vorticity_in_patch(), oomph::Missing_masters_functions::get_required_master_nodal_information_helper(), oomph::GmshTetScaffoldMesh::GmshTetScaffoldMesh(), oomph::HerschelBulkleyTanMilRegConstitutiveEquation< DIM >::HerschelBulkleyTanMilRegConstitutiveEquation(), oomph::HerschelBulkleyTanMilRegWithBlendingConstitutiveEquation< DIM >::HerschelBulkleyTanMilRegWithBlendingConstitutiveEquation(), oomph::HypreInterface::hypre_matrix_setup(), oomph::HypreInterface::hypre_solve(), oomph::HypreInterface::hypre_solver_setup(), oomph::MPI_Helpers::init(), oomph::FiniteElement::invert_jacobian(), oomph::FiniteElement::J_eulerian(), oomph::BellElementBase< NNODE_1D >::J_eulerian1(), oomph::C1CurvedElementBase< NNODE_1D >::J_eulerian1(), oomph::FiniteElement::J_eulerian_at_knot(), oomph::Problem::load_balance(), oomph::RefineableTriangleMesh< ELEMENT >::load_balance(), oomph::PRefineableQElement< 1, INITIAL_NNODE_1D >::local_coordinate_of_node(), oomph::FiniteElement::locate_zeta(), oomph::HelmholtzMGPreconditioner< DIM >::mg_solve(), oomph::MGSolver< DIM >::mg_solve(), oomph::Problem::newton_solve(), oomph::Problem::newton_solve_continuation(), NonRefineableBinArray::NonRefineableBinArray(), oomph::DGEulerFaceElement< ELEMENT >::numerical_flux(), oomph::ObsoleteCode::obsolete(), oomph::PRefineableQElement< 3, INITIAL_NNODE_1D >::oc_hang_helper(), oomph::NonLinearElasticitySmoothMesh< ELEMENT >::operator()(), oomph::LinearElasticitySmoothMesh< LINEAR_ELASTICITY_ELEMENT >::operator()(), oomph::PoissonSmoothMesh< POISSON_ELEMENT >::operator()(), RefineableBin::output(), oomph::CommandLineArgs::output(), oomph::ClampedHermiteShellBoundaryConditionElement::output(), oomph::Mesh::output(), RefineableBin::output_bin_vertices(), oomph::Mesh::output_fct(), oomph::OomphInfo::output_modifier_pt(), RefineableBinArray::output_neighbouring_bins(), oomph::TreeBasedRefineableMeshBase::p_adapt(), oomph::Problem::p_adapt(), oomph::TreeBasedRefineableMeshBase::p_adapt_mesh(), oomph::Problem::p_refine_selected_elements(), oomph::Problem::p_refine_uniformly(), oomph::Problem::p_refine_uniformly_aux(), oomph::Problem::p_unrefine_uniformly(), oomph::Problem::parallel_sparse_assemble(), oomph::CommandLineArgs::parse_and_assign(), oomph::METIS::partition_distributed_mesh(), oomph::Problem::partition_global_mesh(), oomph::METIS::partition_mesh(), pause(), oomph::PeriodicOrbitAssemblyHandler< NNODE_1D >::PeriodicOrbitAssemblyHandler(), oomph::StorableShapeElementBase::pre_compute_d2shape_eulerian_at_knots(), oomph::StorableShapeSolidElementBase::pre_compute_d2shape_lagrangian_at_knots(), oomph::StorableShapeElementBase::pre_compute_d2shape_local_at_knots(), oomph::PressureBasedSolidLSCPreconditioner::preconditioner_solve(), oomph::BlockDiagonalPreconditioner< MATRIX >::preconditioner_solve(), oomph::HelmholtzMGPreconditioner< DIM >::preconditioner_solve(), oomph::MGPreconditioner< DIM >::preconditioner_solve(), BinArray::profile_get_neighbouring_bins_helper(), oomph::ProjectionProblem< PROJECTABLE_ELEMENT >::project(), oomph::Mesh::prune_halo_elements_and_nodes(), oomph::Problem::prune_halo_elements_and_nodes(), oomph::PseudoBucklingRing::PseudoBucklingRing(), oomph::PRefineableQElement< 2, INITIAL_NNODE_1D >::quad_hang_helper(), oomph::QuarterTubeMesh< ELEMENT >::QuarterTubeMesh(), oomph::Problem::read(), oomph::Problem::recompute_load_balanced_assembly(), VorticitySmoother< ELEMENT >::recover_vorticity(), oomph::Missing_masters_functions::recursively_add_masters_of_external_halo_node_to_storage(), oomph::Multi_domain_functions::recursively_add_masters_of_external_halo_node_to_storage(), oomph::TreeBasedRefineableMeshBase::refine_as_in_reference_mesh(), oomph::Problem::refine_selected_elements(), oomph::Problem::refine_uniformly(), oomph::Problem::refine_uniformly_aux(), RefineableBinArray::RefineableBinArray(), oomph::RefineableFullCircleMesh< ELEMENT >::RefineableFullCircleMesh(), oomph::RefineableQuarterTubeMesh< ELEMENT >::RefineableQuarterTubeMesh(), oomph::RefineableTubeMesh< ELEMENT >::RefineableTubeMesh(), oomph::TriangleMeshBase::remesh_from_triangulateio(), oomph::Problem::remove_duplicate_data(), oomph::HSL_MA42::reorder_elements(), oomph::HyprePreconditioner::report_cumulative_solve_times(), oomph::DGFaceElement::report_info(), oomph::BrethertonSpineMesh< ELEMENT, INTERFACE_ELEMENT >::reposition_spines(), oomph::RefineableTriangleMesh< ELEMENT >::reset_halo_haloed_scheme(), oomph::RefineableTriangleMesh< ELEMENT >::reset_halo_haloed_scheme_helper(), oomph::Mesh::resize_halo_nodes(), oomph::MumpsSolver::resolve(), oomph::TrilinosAztecOOSolver::resolve(), oomph::SuperLUSolver::resolve(), oomph::VorticitySmootherElement< ELEMENT >::scalar_name_paraview(), oomph::SegregatableFSIProblem::segregated_solve(), oomph::BinaryTree::self_test(), oomph::QuadTree::self_test(), oomph::MGSolver< DIM >::self_test(), oomph::OcTree::self_test(), oomph::BinaryTreeForest::self_test(), oomph::AlgebraicNode::self_test(), oomph::Data::self_test(), oomph::QuadTreeForest::self_test(), oomph::Mesh::self_test(), oomph::AlgebraicMesh::self_test(), oomph::OcTreeForest::self_test(), oomph::GeneralisedElement::self_test(), oomph::Problem::self_test(), oomph::RefineableTriangleMesh< ELEMENT >::send_and_receive_elements_nodes_info(), oomph::Multi_domain_functions::send_and_receive_located_info(), oomph::Problem::set_default_first_and_last_element_for_assembly(), oomph::Biharmonic_schur_complement_Hypre_defaults::set_defaults(), oomph::Problem::set_explicit_time_stepper_pt(), oomph::SolidICProblem::set_newmark_initial_condition_consistently(), oomph::SolidICProblem::set_newmark_initial_condition_directly(), oomph::SolidICProblem::set_static_initial_condition(), oomph::SuperLUPreconditioner::setup(), oomph::MatrixVectorProduct::setup(), oomph::BiharmonicPreconditioner::setup(), oomph::FSIPreconditioner::setup(), oomph::PressureBasedSolidLSCPreconditioner::setup(), oomph::NewMumpsPreconditioner::setup(), oomph::BlockDiagonalPreconditioner< MATRIX >::setup(), oomph::HelmholtzMGPreconditioner< DIM >::setup(), oomph::LineVisualiser::setup(), oomph::MGPreconditioner< DIM >::setup(), oomph::NavierStokesSchurComplementPreconditioner::setup(), oomph::HyprePreconditioner::setup(), oomph::WomersleyImpedanceTubeBase< WOMERSLEY_ELEMENT, DIM >::setup(), oomph::HelmholtzMGPreconditioner< DIM >::setup_coarsest_level_structures(), oomph::LineVisualiser::setup_from_file(), oomph::TR::setup_initial_derivative(), oomph::HelmholtzMGPreconditioner< DIM >::setup_mg_hierarchy(), oomph::MGSolver< DIM >::setup_mg_hierarchy(), oomph::HelmholtzMGPreconditioner< DIM >::setup_mg_structures(), oomph::MGSolver< DIM >::setup_mg_structures(), oomph::Z2ErrorEstimator::setup_patches(), VorticitySmoother< ELEMENT >::setup_patches(), oomph::SolidICProblem::setup_problem(), oomph::SegregatableFSIProblem::setup_segregated_solver(), oomph::Mesh::setup_shared_node_scheme(), oomph::HelmholtzMGPreconditioner< DIM >::setup_smoothers(), oomph::MGSolver< DIM >::setup_smoothers(), oomph::OcTree::setup_static_data(), oomph::HelmholtzMGPreconditioner< DIM >::setup_transfer_matrices(), oomph::MGSolver< DIM >::setup_transfer_matrices(), oomph::TrilinosMLPreconditioner::setup_trilinos_preconditioner(), oomph::PRefineableQElement< 1, INITIAL_NNODE_1D >::shape(), oomph::SimpleCubicTetMesh< ELEMENT >::SimpleCubicTetMesh(), oomph::SiskoTanMilRegWithBlendingConstitutiveEquation< DIM >::SiskoTanMilRegWithBlendingConstitutiveEquation(), oomph::TetMeshBase::snap_nodes_onto_geometric_objects(), oomph::MumpsSolver::solve(), oomph::HSL_MA42::solve(), oomph::DenseLU::solve(), oomph::CG< MATRIX >::solve(), oomph::FD_LU::solve(), oomph::TrilinosAztecOOSolver::solve(), oomph::BiCGStab< MATRIX >::solve(), oomph::MGSolver< DIM >::solve(), oomph::SuperLUSolver::solve(), oomph::GS< MATRIX >::solve(), oomph::HypreSolver::solve(), oomph::GS< CRDoubleMatrix >::solve(), oomph::DampedJacobi< MATRIX >::solve(), oomph::GMRES< MATRIX >::solve(), oomph::HelmholtzGMRESMG< MATRIX >::solve(), oomph::HelmholtzFGMRESMG< MATRIX >::solve(), oomph::ARPACK::solve_eigenproblem(), oomph::ANASAZI::solve_eigenproblem(), oomph::CG< MATRIX >::solve_helper(), oomph::BiCGStab< MATRIX >::solve_helper(), oomph::GS< MATRIX >::solve_helper(), oomph::GS< CRDoubleMatrix >::solve_helper(), oomph::DampedJacobi< MATRIX >::solve_helper(), oomph::GMRES< MATRIX >::solve_helper(), oomph::HelmholtzGMRESMG< MATRIX >::solve_helper(), oomph::HelmholtzFGMRESMG< MATRIX >::solve_helper(), oomph::TrilinosAztecOOSolver::solve_using_AztecOO(), oomph::TrilinosAztecOOSolver::solver_setup(), oomph::Problem::sparse_assemble_row_or_column_compressed_with_lists(), oomph::Problem::sparse_assemble_row_or_column_compressed_with_maps(), oomph::Problem::sparse_assemble_row_or_column_compressed_with_two_arrays(), oomph::Problem::sparse_assemble_row_or_column_compressed_with_two_vectors(), oomph::Problem::sparse_assemble_row_or_column_compressed_with_vectors_of_pairs(), oomph::TetMeshBase::split_elements_in_corners(), oomph::Problem::steady_newton_solve(), oomph::SegregatableFSIProblem::steady_segregated_solve(), oomph::Problem::synchronise_eqn_numbers(), oomph::TreeBasedRefineableMeshBase::synchronise_hanging_nodes(), oomph::TreeBasedRefineableMeshBase::synchronise_nonhanging_nodes(), oomph::Mesh::synchronise_shared_nodes(), oomph::TubeMesh< ELEMENT >::TubeMesh(), oomph::Problem::unrefine_uniformly(), oomph::Problem::unsteady_newton_solve(), oomph::SegregatableFSIProblem::unsteady_segregated_solve(), oomph::FpPressureAdvectionDiffusionProblem< ELEMENT >::validate(), oomph::WomersleyProblem< WOMERSLEY_ELEMENT, DIM >::WomersleyProblem(), and oomph::HyprePreconditioner::~HyprePreconditioner().

◆ oomph_mpi_output

MPIOutputModifier oomph::oomph_mpi_output

Single (global) instantiation of the mpi output modifier.

Definition at line 1167 of file oomph_utilities.cc.

Referenced by oomph::MPIOutputModifier::allow_output_from_all_processors(), and oomph::MPI_Helpers::init().

◆ oomph_nullstream

Nullstream oomph::oomph_nullstream

◆ Pe_pt

double* oomph::Pe_pt
protected

◆ PeSt_pt

double* oomph::PeSt_pt
protected

Pointer to global Peclet number multiplied by Strouhal number.

Definition at line 568 of file gen_axisym_advection_diffusion_elements.h.

Referenced by oomph::RefineableGeneralisedAxisymAdvectionDiffusionEquations::further_build(), pe_st(), and pe_st_pt().

◆ Source_fct_pt

GeneralisedAxisymAdvectionDiffusionSourceFctPt oomph::Source_fct_pt
protected

◆ Wind_fct_pt

GeneralisedAxisymAdvectionDiffusionWindFctPt oomph::Wind_fct_pt
protected