Namespaces | Classes | Functions | Variables
oomph Namespace Reference

Namespaces

namespace  MeshExtrusionHelpers
 

Classes

class  AlgebraicChannelWithLeafletMesh
 Algebraic version of ChannelWithLeafletMesh. Leaflet is assumed to be in its undeformed (straight vertical) position when the algebraic node update is set up. More...
 
class  AlgebraicCollapsibleChannelMesh
 Collapsible channel mesh with algebraic node update. More...
 
class  AlgebraicCylinderWithFlagMesh
 Algebraic version of CylinderWithFlagMesh. More...
 
class  AlgebraicFishMesh
 Fish shaped mesh with algebraic node update function for nodes. More...
 
class  AlgebraicFSIDrivenCavityMesh
 / Alebraic node update version of FSIDrivenCavityMesh More...
 
class  AlgebraicRefineableFishMesh
 Refineable fish shaped mesh with algebraic node update function. More...
 
class  AlgebraicRefineableQuarterCircleSectorMesh
 Algebraic version of RefineableQuarterCircleSectorMesh. More...
 
class  AlgebraicRefineableQuarterTubeMesh
 AlgebraicMesh version of RefineableQuarterTubeMesh. More...
 
class  AnnularDomain
 Annular domain. More...
 
class  BackwardStepQuadMesh
 Backward step mesh. More...
 
class  BrethertonSpineMesh
 Mesh for 2D Bretherton problem – based on single layer mesh. Templated by spine-ified Navier-Stokes element type (e.g. SpineElement<QCrouzeixRaviartElement<2> > and the corresponding interface element (e.g. SpineLineFluidInterfaceElement<SpineElement<QCrouzeixRaviartElement<2> > > More...
 
class  BrickFromTetMesh
 Brick mesh built by brickifying an existing tet mesh – each tet gets split into four bricks. Can only be built with quadratic (27 node) elements. More...
 
class  ChannelSpineMesh
 Spine mesh class derived from standard 2D mesh. The mesh contains a StraightLine GeomObject which defines the height of the left and right regions (0,2) and another GeomObject is passed to the constructor to define the height in the central region. More...
 
class  ChannelWithLeafletDomain
 Rectangular domain with a leaflet blocking the lower half. More...
 
class  ChannelWithLeafletMesh
 Channel with leaflet mesh. More...
 
class  CircularCylindricalShellMesh
 A 2D solid mesh for (topologically) circular cylindrical shells. The shell is represented by two Lagrangian coordinates that correspond to z and theta in cylindrical polars. The required mesh is therefore a 2D mesh and is therefore inherited from the generic RectangularQuadMesh. More...
 
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  CylinderWithFlagDomain
 Domain for cylinder with flag as in Turek benchmark. More...
 
class  CylinderWithFlagMesh
 Domain-based mesh for cylinder with flag as in Turek benchmark. More...
 
class  EighthSphereDomain
 Eighth sphere as domain. Domain is parametrised by four macro elements. More...
 
class  EighthSphereMesh
 Eight of a sphere brick mesh, based on the EightSphereDomain Non-refineable version with four brick elements. The eighth-sphere is located in the positive octant, centred at the origin. The mesh boundaries are numbered as follows: More...
 
class  ElasticQuarterPipeMesh
 Non refineable elastic quarter pipe mesh class setup lagrangian coordinates for solid mechanics problems. More...
 
class  ElasticRectangularQuadMesh
 Elastic quad mesh with functionality to attach traction elements to the specified boundaries. We "upgrade" the RectangularQuadMesh to become an SolidMesh and equate the Eulerian and Lagrangian coordinates, thus making the domain represented by the mesh the stress-free configuration. More...
 
class  ElasticRefineableQuarterPipeMesh
 Refineable elastic quarter pipe mesh class. More...
 
class  ElasticRefineableRectangularQuadMesh
 Elastic refineable quad mesh with functionality to attach traction elements to the specified boundaries. We "upgrade" the RefineableRectangularQuadMesh to become an SolidMesh and equate the Eulerian and Lagrangian coordinates, thus making the domain represented by the mesh the stress-free configuration. We also move the mesh "down" by half the the "height" so x=0 is located on the centreline – appropriate for the beam-type problems for which this mesh was developed. More...
 
class  ExtrudedCubeMeshFromQuadMesh
 Mesh class that takes a 2D mesh consisting of quadrilateral elements and "extrudes" it in the z-direction. 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  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  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  GeompackQuadMesh
 Quadrilateral mesh generator; Uses input from Geompack++. See: http://members.shaw.ca/bjoe/ Currently only for four-noded quads – extension to higher-order quads should be trivial (see the corresponding classes for triangular meshes). More...
 
class  GmshParameters
 Class to collate parameters for Gmsh mesh generation. More...
 
class  GmshTetMesh
 Forward declaration. More...
 
class  GmshTetScaffoldMesh
 
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  HorizontalSingleLayerSpineMesh
 Horizontal Single-layer spine mesh class derived from standard 2D mesh. The mesh contains a layer of spinified fluid elements (of type ELEMENT; e.g SpineElement<QCrouzeixRaviartElement<2>) and the information required to update their position. Additional equations must be specified in order to determine how the spines move. More...
 
class  MacroElementNodeUpdateChannelWithLeafletMesh
 Channel with leaflet mesh with MacroElement-based node update. The leaflet is represented by the specified geometric object. Some or all of the geometric Data in that geometric object may contain unknowns in the global Problem. The dependency on these unknowns is taken into account when setting up the Jacobian matrix of the elements. For this purpose, the element (whose type is specified by the template parameter) must inherit from MacroElementNodeUpdateElementBase. More...
 
class  MacroElementNodeUpdateCollapsibleChannelMesh
 Collapsible channel mesh with MacroElement-based node update. The collapsible segment is represented by the specified geometric object. Some or all of the geometric Data in that geometric object may contain unknowns in the global Problem. The dependency on these unknowns is taken into account when setting up the Jacobian matrix of the elements. For this purpose, the element (whose type is specified by the template parameter) must inherit from MacroElementNodeUpdateElementBase. More...
 
class  MacroElementNodeUpdateRefineableChannelWithLeafletMesh
 Refineable mesh with MacroElement-based node update. More...
 
class  MacroElementNodeUpdateRefineableCollapsibleChannelMesh
 Refineable collapsible channel mesh with MacroElement-based node update. The collapsible segment is represented by the specified geometric object. Some or all of the geometric Data in that geometric object may contain unknowns in the global Problem. The dependency on these unknowns is taken into account when setting up the Jacobian matrix of the elements. For this purpose, the element (whose type is specified by the template parameter) must inherit from MacroElementNodeUpdateElementBase. More...
 
class  MacroElementNodeUpdateRefineableFishMesh
 Refineable fish shaped mesh with MacroElement-based node update. The fish's back is represented by a specified geometric object. Some or all of the geometric Data in that geometric object may contain unknowns in the global Problem. The dependency on these unknowns is taken into account when setting up the Jacobian matrix of the elements. For this purpose, the element (whose type is specified by the template parameter) must inherit from MacroElementNodeUpdateElementBase. More...
 
class  MacroElementNodeUpdateRefineableQuarterCircleSectorMesh
 MacroElementNodeUpdate version of RefineableQuarterCircleSectorMesh. More...
 
class  MacroElementNodeUpdateRefineableQuarterTubeMesh
 MacroElementNodeUpdate version of RefineableQuarterTubeMesh. More...
 
class  OneDLagrangianMesh
 1D mesh parametrised in terms of a 1D Lagrangian coordinate. The Eulerian positions of the nodes are determined by the GeomObject. More...
 
class  OneDMesh
 1D mesh consisting of N one-dimensional elements from the QElement family. More...
 
class  PseudoElasticChannelWithLeafletMesh
 Channel with leaflet mesh upgraded to (pseudo-)solid mesh. More...
 
class  QuadFromTriangleMesh
 Quad mesh built on top of triangle scaffold mesh coming from the triangle mesh generator Triangle. http://www.cs.cmu.edu/~quake/triangle.html. More...
 
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
 2D quarter ring mesh class. The domain is specified by the GeomObject that identifies boundary 1. More...
 
class  QuarterPipeDomain
 Domain representing a quarter pipe. More...
 
class  QuarterPipeMesh
 Non refineable quarter pipe mesh class Deform a simple cubic mesh into a quarter pipe r: radial direction theta: azimuthal direction z: axis direction. More...
 
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  RectangleWithHoleAndAnnularRegionDomain
 Rectangular domain with circular whole DRAIG: This looks like a redefinition of the RectangleWithHoleAndAnnularRegionDomain in src/meshes but it creates 8 macro-elements instead of 4 macro-elements and creates an annular region around the cylinder. It's probably a good idea to rename this class to avoid ambiguity and a name clash... More...
 
class  RectangleWithHoleAndAnnularRegionMesh
 Domain-based mesh for rectangular mesh with circular hole. More...
 
class  RectangleWithHoleDomain
 Rectangular domain with circular whole. More...
 
class  RectangleWithHoleMesh
 Domain-based mesh for rectangular mesh with circular hole. More...
 
class  RectangularQuadMesh
 RectangularQuadMesh is a two-dimensional mesh of Quad elements with Nx elements in the "x" (horizonal) direction and Ny elements in the "y" (vertical) direction. Two Constructors are provided. The basic constructor assumes that the lower-left-hand corner of the mesh is (0,0) and takes only the arguments, Nx, Ny, Xmax and Ymax. The more complex constructor takes the additional arguments Xmin and Ymin. More...
 
class  RefineableAlgebraicChannelWithLeafletMesh
 Refineable version of algebraic ChannelWithLeafletMesh. More...
 
class  RefineableAlgebraicCollapsibleChannelMesh
 Refineable version of the CollapsibleChannel mesh with algebraic node update. More...
 
class  RefineableAlgebraicCylinderWithFlagMesh
 Refineable version of AlgebraicCylinderWithFlagMesh. More...
 
class  RefineableAlgebraicFSIDrivenCavityMesh
 Refineable version algebraic FSIDrivenCavityMesh. More...
 
class  RefineableBackwardStepQuadMesh
 Refineable backward step mesh. More...
 
class  RefineableBrickFromTetMesh
 Refineable brick mesh built by brickifying an existing tet mesh – each tet gets split into four bricks. Can only be built with quadratic (27 node) elements. More...
 
class  RefineableChannelWithLeafletMesh
 Refineable version of ChannelWithLeafletMesh. More...
 
class  RefineableCollapsibleChannelMesh
 Refineable 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  RefineableCylinderWithFlagMesh
 Refineable version of CylinderWithFlagMesh. More...
 
class  RefineableEighthSphereMesh
 Refineable version of the eight of a sphere brick mesh. The eighth-sphere is located in the positive octant, centred at the origin. The mesh boundaries are numbered as follows: More...
 
class  RefineableExtrudedCubeMeshFromQuadMesh
 Mesh class that takes a 2D mesh, "extrudes" it in the z-direction and also makes the resulting mesh refineable. More...
 
class  RefineableFishMesh
 Refineable fish shaped mesh. The geometry is defined by the Domain object FishDomain. More...
 
class  RefineableFSIDrivenCavityMesh
 Refineable version of FSIDrivenCavityMesh. 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  RefineableFullCircleMesh
 Adaptative version of the FullCircleMesh base mesh. The domain is specified by the GeomObject that identifies the entire area. More...
 
class  RefineableGmshTetMesh
 
class  RefineableOneDMesh
 Refineable version of the OneDMesh. More...
 
class  RefineableQuadFromTriangleMesh
 Unstructured refineable QuadFromTriangleMesh. More...
 
class  RefineableQuadMeshWithMovingCylinder
 My Mesh. More...
 
class  RefineableQuarterCircleSectorMesh
 2D quarter ring mesh class inherited from RefineableQuadMesh. The domain is specified by the GeomObject that identifies boundary 1. More...
 
class  RefineableQuarterPipeMesh
 Refineable quarter pipe mesh class. More...
 
class  RefineableQuarterTubeMesh
 Adaptative version of the QuarterTubeMesh base mesh. The domain is specified by the GeomObject that identifies boundary 3. More...
 
class  RefineableRectangleWithHoleAndAnnularRegionMesh
 Refineable version of RectangleWithHoleAndAnnularRegionMesh. Applies one uniform refinement immediately to avoid problems with the automatic applications of boundary conditions in subsequent refinements. More...
 
class  RefineableRectangleWithHoleMesh
 Refineable version of RectangleWithHoleMesh. For some reason this needs on uniform refinement to work... More...
 
class  RefineableRectangularQuadMesh
 Refineable version of the RectangularQuadMesh: A two-dimensional mesh of Quad elements with Nx elements in the "x" (horizonal) direction and Ny elements in the "y" (vertical) direction. Two Constructors are provided. The basic constructor assumes that the lower-left-hand corner of the mesh is (0,0) and takes only the arguments, Nx, Ny, Xmax and Ymax. The more complex constructor takes the additional arguments Xmin and Ymin. More...
 
class  RefineableSimpleCubicMesh
 Refineable version of simple cubic 3D Brick mesh class. More...
 
class  RefineableSolidBrickFromTetMesh
 Refineable solid brick mesh built by brickifying an existing tet mesh – each tet gets split into four bricks. Can only be built with quadratic (27 node) elements. More...
 
class  RefineableSolidQuadFromTriangleMesh
 Unstructured refineable QuadFromTriangleMesh upgraded to solid mesh. More...
 
class  RefineableSolidTetgenMesh
 
class  RefineableSolidThinLayerBrickOnTetMesh
 Refineable solid brick mesh layer built on top of a given tet mesh. Typically used in FSI problems where the tet mesh is the fluid mesh and this mesh acts as the solid mesh that surrounds the FSI interface. More...
 
class  RefineableSolidTriangleMesh
 Unstructured refineable Triangle Mesh upgraded to solid mesh. More...
 
class  RefineableTetgenMesh
 
class  RefineableThinLayerBrickOnTetMesh
 Refineable brick mesh layer built on top of a given tet mesh. Typically used in FSI problems where the tet mesh is the fluid mesh and this mesh acts as the solid mesh that surrounds the FSI interface. More...
 
class  RefineableTriangleMesh
 Unstructured refineable Triangle Mesh. More...
 
class  RefineableTubeMesh
 Adaptative version of the TubeMesh base mesh. The domain is specified by the GeomObject that identifies the entire volume. More...
 
class  RefineableTwoDAnnularMesh
 Refineable 2D annular mesh with a unit circle in the middle and a layer of thickness h surrounding it. More...
 
class  SimpleCubicMesh
 Simple cubic 3D Brick mesh class. More...
 
class  SimpleCubicTetMesh
 MySimple 3D tet mesh for TElements. More...
 
class  SimpleRectangularQuadMesh
 Simple rectangular 2D Quad mesh class. Nx : number of elements in the x direction. More...
 
class  SimpleRectangularTriMesh
 Simple 2D triangular mesh for TElements. More...
 
class  SingleLayerCubicSpineMesh
 Spine mesh class derived from standard cubic 3D mesh. The mesh contains a layer of spinified fluid elements (of type ELEMENT; e.g SpineElement<QCrouzeixRaviartElement<3>) for 3D problems, in which the interface's vertical position can vary. More...
 
class  SingleLayerSpineMesh
 Single-layer spine mesh class derived from standard 2D mesh. The mesh contains a layer of spinified fluid elements (of type ELEMENT; e.g SpineElement<QCrouzeixRaviartElement<2>). It constructs the spines and contains the information on how to update the nodal positions within the mesh as a function of the spine lengths. Equations that determine the spine heights (even if they are pinned) must be specified externally or else there will be problems. More...
 
class  SolidBrickFromTetMesh
 Solid brick mesh built by brickifying an existing tet mesh – each tet gets split into four bricks. Can only be built with quadratic (27 node) elements. More...
 
class  SolidQuadFromTriangleMesh
 Unstructured QuadFromTriangleMesh upgraded to solid mesh. More...
 
class  SolidTetgenMesh
 Tetgen-based mesh upgraded to become a solid mesh. Automatically enumerates all boundaries. More...
 
class  SolidThinLayerBrickOnTetMesh
 Solid brick mesh layer built on top of a given tet mesh. Typically used in FSI problems where the tet mesh is the fluid mesh and this mesh acts as the solid mesh that surrounds the FSI interface. More...
 
class  SolidTriangleMesh
 Unstructured Triangle Mesh upgraded to solid mesh. More...
 
class  SolidXdaTetMesh
 Xda-based tet mesh upgraded to become a solid mesh. More...
 
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  ThinLayerBrickOnTetMesh
 Brick mesh layer built on top of a given tet mesh. Typically used in FSI problems where the tet mesh is the fluid mesh and this mesh acts as the solid mesh that surrounds the FSI interface. More...
 
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  TriangleMesh
 Triangle mesh build with the help of the scaffold mesh coming from the triangle mesh generator Triangle. http://www.cs.cmu.edu/~quake/triangle.html. More...
 
class  TriangleMeshParameters
 Helper object for dealing with the parameters used for the TriangleMesh objects. More...
 
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  TwoDAnnularMesh
 2D annular mesh with a unit circle in the middle and a layer of thickness h surrounding it. More...
 
class  TwoLayerSpineMesh
 Two-layer spine mesh class derived from standard 2D mesh. The mesh contains two layers of spinified fluid elements (of type ELEMENT; e.g SpineElement<QCrouzeixRaviartElement<2>). More...
 
class  XdaTetMesh
 Tet mesh made of quadratic (ten node) tets built from xda input file. More...
 

Functions

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

Variables

struct oomph::classcomp Bottom_left_sorter
 

Function Documentation

◆ triangulate()

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

Variable Documentation

◆ Bottom_left_sorter

struct oomph::classcomp oomph::Bottom_left_sorter