Public Member Functions | |
FileGrid (const Epetra_Comm &Comm, const std::string FileName) | |
Constructor. More... | |
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. More... | |
virtual const Epetra_Comm & | Comm () const |
Returns a reference to the communicator object. | |
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 void | VertexCoord (const int LocalID, double *coord) const |
Returns the coordinates of local vertex LocalVertex in vector coord . More... | |
virtual void | VertexCoord (const int Length, const int *IDs, double *x, double *y, double *z) const |
Returns the coordinates of specified local vertices. More... | |
virtual void | ElementVertices (const int LocalID, int *elements) const |
Returns the local vertex IDs of the specified local finite element. More... | |
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 const RefCountPtr < Epetra_Map > | RCPVertexMap () const |
virtual const RefCountPtr < Epetra_Map > | RCPElementMap () const |
virtual const Epetra_Map & | VertexMap () const |
Returns a reference to the map representing the vertex distribution. | |
virtual const Epetra_Map & | ElementMap () const |
virtual const Epetra_Map & | RowMap () const |
Returns a reference to the map representing the distribution of rows. | |
virtual const Epetra_Import & | Importer () const |
virtual int | ElementTag (const int LocalID) const |
virtual int | VertexTag (const int LocalID) const |
virtual double | ElementVolume () const |
virtual void | FaceVertices (const int LocalFace, int &tag, int *IDs) const |
Returns the local vertex IDs of vertices contained in the specified boundary face. | |
int | FacePatch (const int LocalFace) const |
Returns the patch ID of the specified face. More... | |
virtual double | ElementVolume (const int LocalElement) const |
Returns the volume of the specified local finite element. More... | |
virtual double | FaceArea (const int LocalFace) const |
Returns the area of the specified local face. More... | |
virtual double | MyVolume () const |
Returns the volume of all local elements. | |
virtual double | GlobalVolume () const |
Returns the global volume of the grid. | |
void | ExportToVertexMap (const Epetra_DistObject &RowObject, Epetra_DistObject &VertexObject) const |
Exports distributed object from RowMap() to VertexMap(). | |
void | ExportToRowMap (const Epetra_DistObject &VertexObject, Epetra_DistObject &RowObject) const |
Exports distributed object from VertexMap() to RowMap(). | |
int | NumNeighborsPerElement () const |
Returns the number of neighboring elements. | |
void | ElementNeighbors (int, int *) const |
Returns the local IDs of neighboring elements. | |
Public Member Functions inherited from Galeri::FiniteElements::AbstractGrid | |
virtual | ~AbstractGrid () |
Destructor. | |
|
inline |
Constructor.
Comm | - (In) Communicator object. |
FileName | - (In) Name of grid file. |
|
inlinevirtual |
Returns a string containing the element type.
Returns a string containing the type of element. This string is used in the quadrature class. Currently supported options are:
Implements Galeri::FiniteElements::AbstractGrid.
|
inlinevirtual |
Returns the local vertex IDs of the specified local finite element.
LocalElement | - (In) ID of the required local element. |
elements | - (Out) array of length NumElementVertices(), in output will contain the local ID of the vertices of the specified element. |
Implements Galeri::FiniteElements::AbstractGrid.
|
inlinevirtual |
Returns the volume of the specified local finite element.
Returns the area (in 2D) or the volume (in 3D) of the specified local element
Implements Galeri::FiniteElements::AbstractGrid.
|
inlinevirtual |
Returns the area of the specified local face.
Returns the length (in 2D) or the area (in 3D) of the specified boundary face
Implements Galeri::FiniteElements::AbstractGrid.
|
inlinevirtual |
Returns the patch ID of the specified face.
Returns an integer ID that identifies the given boundary face as belonging to a given part of the domain. It can be used by the user to specify the value and the type of the boundary condition.
Implements Galeri::FiniteElements::AbstractGrid.
|
inlinevirtual |
Returns the coordinates of local vertex LocalVertex
in vector coord
.
LocalVertex | - (In) Local ID of the vertex for whic coordinates are required. Must be contained in the interval [0, NumMyVertices()) |
coord | - (Out) double array of size 3. In output, contains the x-, y- and z-coordinate of the specified vertex. |
coord
must be allocated of size 3 for both 2D and 3D problems. Implements Galeri::FiniteElements::AbstractGrid.
|
inlinevirtual |
Returns the coordinates of specified local vertices.
Length | - (In) Length of array IDs . |
IDs | - (In) Contains the list of vertices of which coordinates are required. |
x | - (Out) double array of size Length . In output, contains the x-coordinates of the specified vertices. |
y | - (Out) double array of size Length . In output, contains the y-coordinates of the specified vertices. |
z | - (Out) double array of size Length . In output, contains the z-coordinates of the specified vertices. |
z
array must be allocated for both 2D and 3D problems. Implements Galeri::FiniteElements::AbstractGrid.