| 
 | 
| 
  | 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. 
  | 
|   | 
| 
virtual  | ~AbstractGrid () | 
|   | Destructor. 
  | 
|   |