Galeri Development
Loading...
Searching...
No Matches
Public Member Functions | List of all members
Galeri::FiniteElements::TRIANGLEGrid Class Reference
Inheritance diagram for Galeri::FiniteElements::TRIANGLEGrid:
Inheritance graph
[legend]
Collaboration diagram for Galeri::FiniteElements::TRIANGLEGrid:
Collaboration graph
[legend]

Public Member Functions

 TRIANGLEGrid (const Epetra_Comm &Comm, const int NumPoints, const double *x, const double *y, const double MaxArea)
 
virtual int NumDimensions () const
 Returns the number of dimensions of the grid.
 
virtual int NumVerticesPerElement () const
 Returns the number of vertices contained in each element.
 
virtual int NumFacesPerElement () const
 Returns the number of faces contained in each element.
 
virtual int NumVerticesPerFace () const
 Returns the number of vertices contained in each face.
 
virtual std::string ElementType () const
 Returns a string containing the element type.
 
virtual int NumNeighborsPerElement () const
 Returns the number of neighboring elements.
 
virtual int NumMyElements () const
 Returns the number of finite elements on the calling process.
 
virtual int NumGlobalElements () const
 Returns the global number of finite elements.
 
virtual int NumMyVertices () const
 Returns the number of vertices on the calling process.
 
virtual int NumGlobalVertices () const
 Returns the global number of vertices.
 
virtual int NumMyBoundaryFaces () const
 Returns the number of boundary faces on the calling process.
 
virtual int NumGlobalBoundaryFaces () const
 Returns the global number of boundary faces.
 
virtual double MyVolume () const
 Returns the volume of all local elements.
 
virtual double GlobalVolume () const
 Returns the global volume of the grid.
 
virtual void VertexCoord (const int LocalVertex, double *coord) const
 Returns the coordinates of local vertex LocalVertex in vector coord.
 
virtual void VertexCoord (const int Length, const int *IDs, double *x, double *y, double *z) const
 Returns the coordinates of specified local vertices.
 
virtual void ElementVertices (const int LocalElement, int *elements) const
 Returns the local vertex IDs of the specified local finite element.
 
virtual void FaceVertices (const int LocalFace, int &tag, int *IDs) const
 Returns the local vertex IDs of vertices contained in the specified boundary face.
 
virtual void ElementNeighbors (const int LocalElement, int *elements) const
 Returns the local IDs of neighboring elements.
 
virtual int FacePatch (const int LocalFace) const
 Returns the patch ID of the specified face.
 
virtual double ElementMinLength (const int LocalElement) const
 Returns the volume of the specified local finite element.
 
virtual double ElementMaxLength (const int LocalElement) const
 Returns the volume of the specified local finite element.
 
virtual double ElementVolume (const int LocalElement) const
 Returns the volume of the specified local finite element.
 
virtual double FaceArea (const int LocalFace) const
 Returns the area of the specified local face.
 
virtual const Epetra_Map & VertexMap () const
 Returns a reference to the map representing the vertex distribution.
 
virtual const Epetra_Map & RowMap () const
 Returns a reference to the map representing the distribution of rows.
 
virtual void ExportToVertexMap (const Epetra_DistObject &RowObject, Epetra_DistObject &VertexObject) const
 Exports distributed object from RowMap() to VertexMap().
 
virtual void ExportToRowMap (const Epetra_DistObject &RowObject, Epetra_DistObject &VertexObject) const
 Exports distributed object from VertexMap() to RowMap().
 
virtual const Epetra_Comm & Comm () const
 Returns a reference to the communicator object.
 
- Public Member Functions inherited from Galeri::FiniteElements::AbstractGrid
virtual ~AbstractGrid ()
 Destructor.
 

Member Function Documentation

◆ Comm()

virtual const Epetra_Comm & Galeri::FiniteElements::TRIANGLEGrid::Comm ( ) const
inlinevirtual

Returns a reference to the communicator object.

Implements Galeri::FiniteElements::AbstractGrid.

◆ ElementMaxLength()

virtual double Galeri::FiniteElements::TRIANGLEGrid::ElementMaxLength ( const int LocalElement) const
inlinevirtual

Returns the volume of the specified local finite element.

Implements Galeri::FiniteElements::AbstractGrid.

◆ ElementMinLength()

virtual double Galeri::FiniteElements::TRIANGLEGrid::ElementMinLength ( const int LocalElement) const
inlinevirtual

Returns the volume of the specified local finite element.

Implements Galeri::FiniteElements::AbstractGrid.

◆ ElementNeighbors()

virtual void Galeri::FiniteElements::TRIANGLEGrid::ElementNeighbors ( const int LocalElement,
int * elements ) const
inlinevirtual

Returns the local IDs of neighboring elements.

Implements Galeri::FiniteElements::AbstractGrid.

◆ ElementType()

virtual std::string Galeri::FiniteElements::TRIANGLEGrid::ElementType ( ) const
inlinevirtual

Returns a string containing the element type.

Implements Galeri::FiniteElements::AbstractGrid.

◆ ElementVertices()

virtual void Galeri::FiniteElements::TRIANGLEGrid::ElementVertices ( const int LocalElement,
int * elements ) const
inlinevirtual

Returns the local vertex IDs of the specified local finite element.

Implements Galeri::FiniteElements::AbstractGrid.

◆ ElementVolume()

virtual double Galeri::FiniteElements::TRIANGLEGrid::ElementVolume ( const int LocalElement) const
inlinevirtual

Returns the volume of the specified local finite element.

Implements Galeri::FiniteElements::AbstractGrid.

◆ ExportToRowMap()

virtual void Galeri::FiniteElements::TRIANGLEGrid::ExportToRowMap ( const Epetra_DistObject & RowObject,
Epetra_DistObject & VertexObject ) const
inlinevirtual

Exports distributed object from VertexMap() to RowMap().

Implements Galeri::FiniteElements::AbstractGrid.

◆ ExportToVertexMap()

virtual void Galeri::FiniteElements::TRIANGLEGrid::ExportToVertexMap ( const Epetra_DistObject & RowObject,
Epetra_DistObject & VertexObject ) const
inlinevirtual

Exports distributed object from RowMap() to VertexMap().

Implements Galeri::FiniteElements::AbstractGrid.

◆ FaceArea()

virtual double Galeri::FiniteElements::TRIANGLEGrid::FaceArea ( const int LocalFace) const
inlinevirtual

Returns the area of the specified local face.

Implements Galeri::FiniteElements::AbstractGrid.

◆ FacePatch()

virtual int Galeri::FiniteElements::TRIANGLEGrid::FacePatch ( const int LocalFace) const
inlinevirtual

Returns the patch ID of the specified face.

Implements Galeri::FiniteElements::AbstractGrid.

◆ FaceVertices()

virtual void Galeri::FiniteElements::TRIANGLEGrid::FaceVertices ( const int LocalFace,
int & tag,
int * IDs ) const
inlinevirtual

Returns the local vertex IDs of vertices contained in the specified boundary face.

Implements Galeri::FiniteElements::AbstractGrid.

◆ GlobalVolume()

virtual double Galeri::FiniteElements::TRIANGLEGrid::GlobalVolume ( ) const
inlinevirtual

Returns the global volume of the grid.

Implements Galeri::FiniteElements::AbstractGrid.

◆ MyVolume()

virtual double Galeri::FiniteElements::TRIANGLEGrid::MyVolume ( ) const
inlinevirtual

Returns the volume of all local elements.

Implements Galeri::FiniteElements::AbstractGrid.

◆ NumDimensions()

virtual int Galeri::FiniteElements::TRIANGLEGrid::NumDimensions ( ) const
inlinevirtual

Returns the number of dimensions of the grid.

Implements Galeri::FiniteElements::AbstractGrid.

◆ NumFacesPerElement()

virtual int Galeri::FiniteElements::TRIANGLEGrid::NumFacesPerElement ( ) const
inlinevirtual

Returns the number of faces contained in each element.

Implements Galeri::FiniteElements::AbstractGrid.

◆ NumGlobalBoundaryFaces()

virtual int Galeri::FiniteElements::TRIANGLEGrid::NumGlobalBoundaryFaces ( ) const
inlinevirtual

Returns the global number of boundary faces.

Implements Galeri::FiniteElements::AbstractGrid.

◆ NumGlobalElements()

virtual int Galeri::FiniteElements::TRIANGLEGrid::NumGlobalElements ( ) const
inlinevirtual

Returns the global number of finite elements.

Implements Galeri::FiniteElements::AbstractGrid.

◆ NumGlobalVertices()

virtual int Galeri::FiniteElements::TRIANGLEGrid::NumGlobalVertices ( ) const
inlinevirtual

Returns the global number of vertices.

Implements Galeri::FiniteElements::AbstractGrid.

◆ NumMyBoundaryFaces()

virtual int Galeri::FiniteElements::TRIANGLEGrid::NumMyBoundaryFaces ( ) const
inlinevirtual

Returns the number of boundary faces on the calling process.

Implements Galeri::FiniteElements::AbstractGrid.

◆ NumMyElements()

virtual int Galeri::FiniteElements::TRIANGLEGrid::NumMyElements ( ) const
inlinevirtual

Returns the number of finite elements on the calling process.

Implements Galeri::FiniteElements::AbstractGrid.

◆ NumMyVertices()

virtual int Galeri::FiniteElements::TRIANGLEGrid::NumMyVertices ( ) const
inlinevirtual

Returns the number of vertices on the calling process.

Implements Galeri::FiniteElements::AbstractGrid.

◆ NumNeighborsPerElement()

virtual int Galeri::FiniteElements::TRIANGLEGrid::NumNeighborsPerElement ( ) const
inlinevirtual

Returns the number of neighboring elements.

Implements Galeri::FiniteElements::AbstractGrid.

◆ NumVerticesPerElement()

virtual int Galeri::FiniteElements::TRIANGLEGrid::NumVerticesPerElement ( ) const
inlinevirtual

Returns the number of vertices contained in each element.

Implements Galeri::FiniteElements::AbstractGrid.

◆ NumVerticesPerFace()

virtual int Galeri::FiniteElements::TRIANGLEGrid::NumVerticesPerFace ( ) const
inlinevirtual

Returns the number of vertices contained in each face.

Implements Galeri::FiniteElements::AbstractGrid.

◆ RowMap()

virtual const Epetra_Map & Galeri::FiniteElements::TRIANGLEGrid::RowMap ( ) const
inlinevirtual

Returns a reference to the map representing the distribution of rows.

Implements Galeri::FiniteElements::AbstractGrid.

◆ VertexCoord() [1/2]

virtual void Galeri::FiniteElements::TRIANGLEGrid::VertexCoord ( const int Length,
const int * IDs,
double * x,
double * y,
double * z ) const
inlinevirtual

Returns the coordinates of specified local vertices.

Implements Galeri::FiniteElements::AbstractGrid.

References Galeri::FiniteElements::Length().

◆ VertexCoord() [2/2]

virtual void Galeri::FiniteElements::TRIANGLEGrid::VertexCoord ( const int LocalVertex,
double * coord ) const
inlinevirtual

Returns the coordinates of local vertex LocalVertex in vector coord.

Implements Galeri::FiniteElements::AbstractGrid.

◆ VertexMap()

virtual const Epetra_Map & Galeri::FiniteElements::TRIANGLEGrid::VertexMap ( ) const
inlinevirtual

Returns a reference to the map representing the vertex distribution.

Implements Galeri::FiniteElements::AbstractGrid.


The documentation for this class was generated from the following file: