ESScript  Revision_4488
Public Member Functions | Protected Member Functions | Private Member Functions | Private Attributes | List of all members
ripley::Rectangle Class Reference

Rectangle is the 2-dimensional implementation of a RipleyDomain. More...

#include <Rectangle.h>

Inheritance diagram for ripley::Rectangle:
ripley::RipleyDomain escript::AbstractContinuousDomain escript::AbstractDomain

Public Member Functions

 Rectangle (int n0, int n1, double x0, double y0, double x1, double y1, int d0=-1, int d1=-1)
 creates a rectangular mesh with n0 x n1 elements over the rectangle [x0,x1] x [y0,y1].
 ~Rectangle ()
 Destructor.
virtual std::string getDescription () const
 returns a description for this domain
virtual bool operator== (const escript::AbstractDomain &other) const
 equality operator
void dump (const std::string &filename) const
 dumps the mesh to a file with the given name
virtual void readBinaryGrid (escript::Data &out, std::string filename, const std::vector< int > &first, const std::vector< int > &numValues, const std::vector< int > &multiplier) const
virtual void readNcGrid (escript::Data &out, std::string filename, std::string varname, const std::vector< int > &first, const std::vector< int > &numValues, const std::vector< int > &multiplier) const
virtual void writeBinaryGrid (const escript::Data &in, std::string filename, int byteOrder, int dataType) const
const int * borrowSampleReferenceIDs (int fsType) const
 returns the array of reference numbers for a function space type
virtual bool ownSample (int fs_code, index_t id) const
 returns true if this rank owns the sample id.
virtual void setToNormal (escript::Data &out) const
 copies the surface normals at data points into out. The actual function space to be considered is defined by out. out has to be defined on this domain.
virtual void setToSize (escript::Data &out) const
 copies the size of samples into out. The actual function space to be considered is defined by out. out has to be defined on this domain.
virtual int getNumDataPointsGlobal () const
 returns the number of data points summed across all MPI processes
virtual void Print_Mesh_Info (const bool full=false) const
 writes information about the mesh to standard output
virtual const int * getNumNodesPerDim () const
 returns the number of nodes per MPI rank in each dimension
virtual const int * getNumElementsPerDim () const
 returns the number of elements per MPI rank in each dimension
virtual const int * getNumFacesPerBoundary () const
 returns the number of face elements in the order (left,right,bottom,top) on current MPI rank
virtual IndexVector getNodeDistribution () const
 returns the node distribution vector
virtual const int * getNumSubdivisionsPerDim () const
 returns the number of spatial subdivisions in each dimension
virtual double getLocalCoordinate (int index, int dim) const
 returns the index'th coordinate value in given dimension for this rank
virtual boost::python::tuple getGridParameters () const
 returns the tuple (origin, spacing, number_of_elements)
- Public Member Functions inherited from ripley::RipleyDomain
 RipleyDomain (dim_t dim)
 Constructor with number of dimensions. Allocates MPI info structure.
 ~RipleyDomain ()
 Destructor.
virtual int getMPISize () const
 returns the number of processors used for this domain
virtual int getMPIRank () const
 returns the MPI rank of this processor
virtual void MPIBarrier () const
 if compiled for MPI then executes an MPI_Barrier, else does nothing
virtual bool onMasterProcessor () const
 returns true if on MPI processor 0, else false
unsigned int getMPIComm () const
 returns the MPI communicator
virtual bool isValidFunctionSpaceType (int fsType) const
 returns true if the argument is a valid function space type for this domain
virtual std::string functionSpaceTypeAsString (int fsType) const
 returns a description for the given function space type code
virtual int getDim () const
 returns the number of spatial dimensions of the domain
virtual bool operator!= (const escript::AbstractDomain &other) const
 inequality operator
virtual std::pair< int, int > getDataShape (int fsType) const
 returns the number of data points per sample, and the number of samples as a pair.
int getTagFromSampleNo (int fsType, int sampleNo) const
 returns the tag key for the given sample number
virtual void setTagMap (const std::string &name, int tag)
 sets a map from a clear tag name to a tag key
virtual int getTag (const std::string &name) const
 returns the tag key for tag name
virtual bool isValidTagName (const std::string &name) const
 returns true if name is a defined tag name
virtual std::string showTagNames () const
 returns all tag names in a single string separated by commas
virtual void setNewX (const escript::Data &arg)
 assigns new location to the domain.
virtual void interpolateOnDomain (escript::Data &target, const escript::Data &source) const
 interpolates data given on source onto target where source and target have to be given on the same domain
virtual bool probeInterpolationOnDomain (int fsType_source, int fsType_target) const
 returns true if data on fsType_source can be interpolated onto fsType_target, false otherwise
virtual signed char preferredInterpolationOnDomain (int fsType_source, int fsType_target) const
 Preferred direction of interpolation.
bool commonFunctionSpace (const std::vector< int > &fs, int &resultcode) const
 given a vector of FunctionSpace type codes, passes back a code which all can be interpolated to
virtual void interpolateACross (escript::Data &target, const escript::Data &source) const
 interpolates data given on source onto target where source and target are given on different domains
virtual bool probeInterpolationACross (int, const escript::AbstractDomain &, int) const
 determines whether interpolation from source to target is possible
virtual escript::Data getX () const
 returns locations in the FEM nodes
virtual escript::Data getNormal () const
 returns boundary normals at the quadrature point on the face elements
virtual escript::Data getSize () const
 returns the element size
virtual void setToX (escript::Data &arg) const
 copies the location of data points into arg. The domain of arg has to match this domain.
virtual void setToGradient (escript::Data &out, const escript::Data &in) const
 copies the gradient of 'in' into 'out'. The actual function space to be considered for the gradient is defined by 'in'. Both arguments have to be defined on this domain.
virtual void setTags (const int fsType, const int newTag, const escript::Data &mask) const
 assigns new tag newTag to all samples of given function space with a positive value of mask for any of its sample points
virtual bool isCellOriented (int fsType) const
 returns true if data on this domain and given function space type has to be considered as cell centered data
virtual StatusType getStatus () const
 returns a status indicator of the domain. The status identifier should be unique over the lifetime of the object but may be updated if changes to the domain happen, e.g. modifications to its geometry.
virtual int getNumberOfTagsInUse (int fsType) const
 returns the number of tags in use for a function space type
virtual const int * borrowListOfTagsInUse (int fsType) const
 returns a pointer to the list of tags in use for a function space type
virtual bool canTag (int fsType) const
 checks if this domain allows tags for the specified function space type
virtual int getApproximationOrder (const int fsType) const
 returns the approximation order used for a function space
virtual bool supportsContactElements () const
 returns true if this domain supports contact elements, false otherwise
virtual int getContinuousFunctionCode () const
 returns a continuous FunctionSpace code
virtual int getReducedContinuousFunctionCode () const
 returns a continuous on reduced order nodes FunctionSpace code
virtual int getFunctionCode () const
 returns a function FunctionSpace code
virtual int getReducedFunctionCode () const
 returns a function with reduced integration order FunctionSpace code
virtual int getFunctionOnBoundaryCode () const
 returns a function on boundary FunctionSpace code
virtual int getReducedFunctionOnBoundaryCode () const
 returns a function on boundary with reduced integration order FunctionSpace code
virtual int getFunctionOnContactZeroCode () const
 return a FunctionOnContactZero code
virtual int getReducedFunctionOnContactZeroCode () const
 returns a FunctionOnContactZero code with reduced integration order
virtual int getFunctionOnContactOneCode () const
 returns a FunctionOnContactOne code
virtual int getReducedFunctionOnContactOneCode () const
 returns a FunctionOnContactOne code with reduced integration order
virtual int getSolutionCode () const
 returns a Solution FunctionSpace code
virtual int getReducedSolutionCode () const
 returns a ReducedSolution FunctionSpace code
virtual int getDiracDeltaFunctionsCode () const
 returns a DiracDeltaFunctions FunctionSpace code
virtual int getSystemMatrixTypeId (const int solver, const int preconditioner, const int package, const bool symmetry) const
 returns the identifier of the matrix type to be used for the global stiffness matrix when a particular solver, package, preconditioner, and symmetric matrix is used
virtual int getTransportTypeId (const int solver, const int preconditioner, const int package, const bool symmetry) const
 returns the identifier of the transport problem type to be used when a particular solver, preconditioner, package and symmetric matrix is used
virtual void setToIntegrals (DoubleVector &integrals, const escript::Data &arg) const
 copies the integrals of the function defined by arg into integrals. arg has to be defined on this domain.
virtual void addPDEToSystem (escript::AbstractSystemMatrix &mat, escript::Data &rhs, const escript::Data &A, const escript::Data &B, const escript::Data &C, const escript::Data &D, const escript::Data &X, const escript::Data &Y, const escript::Data &d, const escript::Data &y, const escript::Data &d_contact, const escript::Data &y_contact, const escript::Data &d_dirac, const escript::Data &y_dirac) const
 adds a PDE onto the stiffness matrix mat and rhs
virtual void addPDEToRHS (escript::Data &rhs, const escript::Data &X, const escript::Data &Y, const escript::Data &y, const escript::Data &y_contact, const escript::Data &y_dirac) const
 adds a PDE onto rhs
virtual void addPDEToTransportProblem (escript::AbstractTransportProblem &tp, escript::Data &source, const escript::Data &M, const escript::Data &A, const escript::Data &B, const escript::Data &C, const escript::Data &D, const escript::Data &X, const escript::Data &Y, const escript::Data &d, const escript::Data &y, const escript::Data &d_contact, const escript::Data &y_contact, const escript::Data &d_dirac, const escript::Data &y_dirac) const
 adds a PDE onto a transport problem
virtual escript::ASM_ptr newSystemMatrix (const int row_blocksize, const escript::FunctionSpace &row_functionspace, const int column_blocksize, const escript::FunctionSpace &column_functionspace, const int type) const
 creates a stiffness matrix and initializes it with zeros
virtual escript::ATP_ptr newTransportProblem (const int blocksize, const escript::FunctionSpace &functionspace, const int type) const
 creates a transport problem
- Public Member Functions inherited from escript::AbstractContinuousDomain
 AbstractContinuousDomain ()
 Default constructor for AbstractContinuousDomain.
virtual ~AbstractContinuousDomain ()
 Destructor for AbstractContinuousDomain.
virtual void setToIntegrals (std::vector< double > &integrals, const escript::Data &arg) const
 copies the integrals of the function defined by arg into integrals. arg has to be defined on this. has to be implemented by the Domain Adapter.
- Public Member Functions inherited from escript::AbstractDomain
Domain_ptr getPtr ()
 Returns smart pointer which is managing this object. If one does not exist yet it creates one.
const_Domain_ptr getPtr () const
 AbstractDomain ()
 Default constructor for AbstractDomain.
virtual ~AbstractDomain ()
 Destructor for AbstractDomain.
virtual void write (const std::string &filename) const
 Writes the domain to an external file filename.
void throwStandardException (const std::string &functionName) const
 Throw a standard exception. This function is called if any attempt is made to use a base class function.

Protected Member Functions

virtual dim_t getNumNodes () const
 returns the number of nodes per MPI rank
virtual dim_t getNumElements () const
 returns the number of elements per MPI rank
virtual dim_t getNumFaceElements () const
 returns the number of face elements on current MPI rank
virtual dim_t getNumDOF () const
 returns the number of degrees of freedom per MPI rank
virtual dim_t insertNeighbourNodes (IndexVector &index, index_t node) const
virtual void assembleCoordinates (escript::Data &arg) const
 populates the data object 'arg' with the node coordinates
virtual void assembleGradient (escript::Data &out, escript::Data &in) const
 computes the gradient of 'in' and puts the result in 'out'
virtual void assembleIntegrate (DoubleVector &integrals, escript::Data &arg) const
 copies the integrals of the function defined by 'arg' into 'integrals'
virtual void assemblePDESingle (Paso_SystemMatrix *mat, escript::Data &rhs, const escript::Data &A, const escript::Data &B, const escript::Data &C, const escript::Data &D, const escript::Data &X, const escript::Data &Y) const
virtual void assemblePDEBoundarySingle (Paso_SystemMatrix *mat, escript::Data &rhs, const escript::Data &d, const escript::Data &y) const
virtual void assemblePDESingleReduced (Paso_SystemMatrix *mat, escript::Data &rhs, const escript::Data &A, const escript::Data &B, const escript::Data &C, const escript::Data &D, const escript::Data &X, const escript::Data &Y) const
virtual void assemblePDEBoundarySingleReduced (Paso_SystemMatrix *mat, escript::Data &rhs, const escript::Data &d, const escript::Data &y) const
virtual void assemblePDESystem (Paso_SystemMatrix *mat, escript::Data &rhs, const escript::Data &A, const escript::Data &B, const escript::Data &C, const escript::Data &D, const escript::Data &X, const escript::Data &Y) const
virtual void assemblePDEBoundarySystem (Paso_SystemMatrix *mat, escript::Data &rhs, const escript::Data &d, const escript::Data &y) const
virtual void assemblePDESystemReduced (Paso_SystemMatrix *mat, escript::Data &rhs, const escript::Data &A, const escript::Data &B, const escript::Data &C, const escript::Data &D, const escript::Data &X, const escript::Data &Y) const
virtual void assemblePDEBoundarySystemReduced (Paso_SystemMatrix *mat, escript::Data &rhs, const escript::Data &d, const escript::Data &y) const
virtual Paso_SystemMatrixPatterngetPattern (bool reducedRowOrder, bool reducedColOrder) const
 returns the Paso system matrix pattern
virtual void interpolateNodesOnElements (escript::Data &out, escript::Data &in, bool reduced) const
 interpolates data on nodes in 'in' onto (reduced) elements in 'out'
virtual void interpolateNodesOnFaces (escript::Data &out, escript::Data &in, bool reduced) const
 interpolates data on nodes in 'in' onto (reduced) face elements in 'out'
virtual void nodesToDOF (escript::Data &out, escript::Data &in) const
 converts data on nodes in 'in' to degrees of freedom in 'out'
virtual void dofToNodes (escript::Data &out, escript::Data &in) const
 converts data on degrees of freedom in 'in' to nodes in 'out'
- Protected Member Functions inherited from ripley::RipleyDomain
void copyData (escript::Data &out, escript::Data &in) const
 copies data in 'in' to 'out' (both must be on same function space)
void averageData (escript::Data &out, escript::Data &in) const
 averages data in 'in' to 'out' (from non-reduced to reduced fs)
void multiplyData (escript::Data &out, escript::Data &in) const
 copies data in 'in' to 'out' (from reduced to non-reduced fs)
void updateTagsInUse (int fsType) const
Paso_PatterncreatePasoPattern (const IndexVector &ptr, const IndexVector &index, const dim_t M, const dim_t N) const
 allocates and returns a Paso pattern structure
Paso_PatterncreateMainPattern () const
 creates the pattern for the main block of the system matrix
void createCouplePatterns (const std::vector< IndexVector > &colIndices, const dim_t N, Paso_Pattern **colPattern, Paso_Pattern **rowPattern) const
void addToSystemMatrix (Paso_SystemMatrix *in, const IndexVector &nodes_Eq, dim_t num_Eq, const IndexVector &nodes_Sol, dim_t num_Sol, const DoubleVector &array) const

Private Member Functions

void populateSampleIds ()
void createPattern ()
void addToMatrixAndRHS (Paso_SystemMatrix *S, escript::Data &F, const DoubleVector &EM_S, const DoubleVector &EM_F, bool addS, bool addF, index_t firstNode, dim_t nEq=1, dim_t nComp=1) const
template<typename ValueType >
void writeBinaryGridImpl (const escript::Data &in, const std::string &filename, int byteOrder) const

Private Attributes

dim_t m_gNE [2]
 total number of elements in each dimension
double m_origin [2]
 origin of domain
double m_length [2]
 side lengths of domain
double m_dx [2]
 grid spacings / cell sizes of domain
int m_NX [2]
 number of spatial subdivisions
dim_t m_NE [2]
 number of elements for this rank in each dimension including shared
dim_t m_ownNE [2]
 number of own elements for this rank in each dimension
dim_t m_NN [2]
 number of nodes for this rank in each dimension
dim_t m_offset [2]
 first node on this rank is at (offset0,offset1) in global mesh
int m_faceCount [4]
 number of face elements per edge (left, right, bottom, top)
IndexVector m_faceOffset
IndexVector m_dofId
 vector of sample reference identifiers
IndexVector m_nodeId
IndexVector m_elementId
IndexVector m_faceId
IndexVector m_nodeDistribution
IndexVector m_dofMap
Paso_Connectorm_connector
Paso_SystemMatrixPatternm_pattern

Additional Inherited Members

- Public Types inherited from escript::AbstractDomain
typedef int StatusType
typedef struct ValueBuffer ValueBuffer
typedef std::map< int,
ValueBuffer
BufferMapType
- Protected Attributes inherited from ripley::RipleyDomain
dim_t m_numDim
StatusType m_status
Esys_MPIInfom_mpiInfo
TagMap m_tagMap
IndexVector m_nodeTags
IndexVector m_nodeTagsInUse
IndexVector m_elementTags
IndexVector m_elementTagsInUse
IndexVector m_faceTags
IndexVector m_faceTagsInUse

Detailed Description

Rectangle is the 2-dimensional implementation of a RipleyDomain.

Constructor & Destructor Documentation

ripley::Rectangle::Rectangle ( int  n0,
int  n1,
double  x0,
double  y0,
double  x1,
double  y1,
int  d0 = -1,
int  d1 = -1 
)

creates a rectangular mesh with n0 x n1 elements over the rectangle [x0,x1] x [y0,y1].

Parameters
n0,n1number of elements in each dimension
x0,y0,x1,y1coordinates of bottom-left and top-right corners
d0,d1number of subdivisions in each dimension

References createPattern(), m_dx, m_gNE, m_length, ripley::RipleyDomain::m_mpiInfo, m_NE, m_NN, m_NX, m_offset, m_origin, m_ownNE, populateSampleIds(), Esys_MPIInfo::rank, and Esys_MPIInfo::size.

ripley::Rectangle::~Rectangle ( )

Member Function Documentation

void ripley::Rectangle::addToMatrixAndRHS ( Paso_SystemMatrix S,
escript::Data F,
const DoubleVector EM_S,
const DoubleVector EM_F,
bool  addS,
bool  addF,
index_t  firstNode,
dim_t  nEq = 1,
dim_t  nComp = 1 
) const
private
void ripley::Rectangle::assembleCoordinates ( escript::Data arg) const
protectedvirtual
void ripley::Rectangle::assembleGradient ( escript::Data out,
escript::Data in 
) const
protectedvirtual
void ripley::Rectangle::assembleIntegrate ( DoubleVector integrals,
escript::Data arg 
) const
protectedvirtual
void ripley::Rectangle::assemblePDEBoundarySingle ( Paso_SystemMatrix mat,
escript::Data rhs,
const escript::Data d,
const escript::Data y 
) const
protectedvirtual

assembles boundary conditions of a single PDE into the system matrix 'mat' and the right hand side 'rhs'

Implements ripley::RipleyDomain.

References escript::Data::actsExpanded(), addToMatrixAndRHS(), getSampleDataRO(), INDEX2, escript::Data::isEmpty(), m_dx, m_faceOffset, m_NE, m_NN, and escript::Data::requireWrite().

void ripley::Rectangle::assemblePDEBoundarySingleReduced ( Paso_SystemMatrix mat,
escript::Data rhs,
const escript::Data d,
const escript::Data y 
) const
protectedvirtual

assembles boundary conditions of a single PDE with reduced order into the system matrix 'mat' and the right hand side 'rhs'

Implements ripley::RipleyDomain.

References addToMatrixAndRHS(), getSampleDataRO(), INDEX2, escript::Data::isEmpty(), m_dx, m_faceOffset, m_NE, m_NN, and escript::Data::requireWrite().

void ripley::Rectangle::assemblePDEBoundarySystem ( Paso_SystemMatrix mat,
escript::Data rhs,
const escript::Data d,
const escript::Data y 
) const
protectedvirtual
void ripley::Rectangle::assemblePDEBoundarySystemReduced ( Paso_SystemMatrix mat,
escript::Data rhs,
const escript::Data d,
const escript::Data y 
) const
protectedvirtual

assembles boundary conditions of a system of PDEs with reduced order into the system matrix 'mat' and the right hand side 'rhs'

Implements ripley::RipleyDomain.

References addToMatrixAndRHS(), escript::Data::getDataPointSize(), getSampleDataRO(), INDEX2, INDEX4, escript::Data::isEmpty(), Paso_SystemMatrix::logical_col_block_size, Paso_SystemMatrix::logical_row_block_size, m_dx, m_faceOffset, m_NE, m_NN, and escript::Data::requireWrite().

void ripley::Rectangle::assemblePDESingle ( Paso_SystemMatrix mat,
escript::Data rhs,
const escript::Data A,
const escript::Data B,
const escript::Data C,
const escript::Data D,
const escript::Data X,
const escript::Data Y 
) const
protectedvirtual

assembles a single PDE into the system matrix 'mat' and the right hand side 'rhs'

Implements ripley::RipleyDomain.

References escript::Data::actsExpanded(), addToMatrixAndRHS(), getSampleDataRO(), INDEX2, INDEX3, escript::Data::isEmpty(), m_dx, m_NE, m_NN, and escript::Data::requireWrite().

void ripley::Rectangle::assemblePDESingleReduced ( Paso_SystemMatrix mat,
escript::Data rhs,
const escript::Data A,
const escript::Data B,
const escript::Data C,
const escript::Data D,
const escript::Data X,
const escript::Data Y 
) const
protectedvirtual

assembles a single PDE with reduced order into the system matrix 'mat' and the right hand side 'rhs'

Implements ripley::RipleyDomain.

References addToMatrixAndRHS(), getSampleDataRO(), INDEX2, escript::Data::isEmpty(), m_dx, m_NE, m_NN, and escript::Data::requireWrite().

void ripley::Rectangle::assemblePDESystem ( Paso_SystemMatrix mat,
escript::Data rhs,
const escript::Data A,
const escript::Data B,
const escript::Data C,
const escript::Data D,
const escript::Data X,
const escript::Data Y 
) const
protectedvirtual
void ripley::Rectangle::assemblePDESystemReduced ( Paso_SystemMatrix mat,
escript::Data rhs,
const escript::Data A,
const escript::Data B,
const escript::Data C,
const escript::Data D,
const escript::Data X,
const escript::Data Y 
) const
protectedvirtual
const int * ripley::Rectangle::borrowSampleReferenceIDs ( int  fsType) const
virtual

returns the array of reference numbers for a function space type

Parameters
fsTypeThe function space type

Implements ripley::RipleyDomain.

References ripley::DegreesOfFreedom, ripley::Elements, ripley::FaceElements, m_dofId, m_elementId, m_faceId, m_nodeId, ripley::Nodes, ripley::ReducedDegreesOfFreedom, ripley::ReducedElements, ripley::ReducedFaceElements, and ripley::ReducedNodes.

void ripley::Rectangle::createPattern ( )
private
void ripley::Rectangle::dofToNodes ( escript::Data out,
escript::Data in 
) const
protectedvirtual
void ripley::Rectangle::dump ( const std::string &  filename) const
virtual
string ripley::Rectangle::getDescription ( ) const
virtual

returns a description for this domain

Implements ripley::RipleyDomain.

Referenced by dump().

boost::python::tuple ripley::Rectangle::getGridParameters ( ) const
inlinevirtual

returns the tuple (origin, spacing, number_of_elements)

Implements ripley::RipleyDomain.

References m_dx, m_gNE, and m_origin.

double ripley::Rectangle::getLocalCoordinate ( int  index,
int  dim 
) const
inlinevirtual

returns the index'th coordinate value in given dimension for this rank

Implements ripley::RipleyDomain.

References EsysAssert, m_dx, m_NN, m_offset, and m_origin.

Referenced by assembleCoordinates(), dump(), and Print_Mesh_Info().

virtual IndexVector ripley::Rectangle::getNodeDistribution ( ) const
inlinevirtual

returns the node distribution vector

Implements ripley::RipleyDomain.

int ripley::Rectangle::getNumDataPointsGlobal ( ) const
inlinevirtual

returns the number of data points summed across all MPI processes

Implements ripley::RipleyDomain.

References m_gNE.

Referenced by populateSampleIds().

dim_t ripley::Rectangle::getNumDOF ( ) const
inlineprotectedvirtual

returns the number of degrees of freedom per MPI rank

Implements ripley::RipleyDomain.

References m_gNE, and m_NX.

Referenced by addToMatrixAndRHS(), dofToNodes(), ownSample(), and populateSampleIds().

dim_t ripley::Rectangle::getNumElements ( ) const
inlineprotectedvirtual

returns the number of elements per MPI rank

Implements ripley::RipleyDomain.

References m_NE.

Referenced by populateSampleIds(), and setToSize().

virtual const int* ripley::Rectangle::getNumElementsPerDim ( ) const
inlinevirtual

returns the number of elements per MPI rank in each dimension

Implements ripley::RipleyDomain.

Referenced by dump().

dim_t ripley::Rectangle::getNumFaceElements ( ) const
inlineprotectedvirtual

returns the number of face elements on current MPI rank

Implements ripley::RipleyDomain.

References m_faceCount.

Referenced by populateSampleIds().

virtual const int* ripley::Rectangle::getNumFacesPerBoundary ( ) const
inlinevirtual

returns the number of face elements in the order (left,right,bottom,top) on current MPI rank

Implements ripley::RipleyDomain.

dim_t ripley::Rectangle::getNumNodes ( ) const
inlineprotectedvirtual

returns the number of nodes per MPI rank

Implements ripley::RipleyDomain.

References m_NN.

Referenced by assembleCoordinates(), createPattern(), dofToNodes(), populateSampleIds(), and Print_Mesh_Info().

virtual const int* ripley::Rectangle::getNumNodesPerDim ( ) const
inlinevirtual

returns the number of nodes per MPI rank in each dimension

Implements ripley::RipleyDomain.

Referenced by dump().

virtual const int* ripley::Rectangle::getNumSubdivisionsPerDim ( ) const
inlinevirtual

returns the number of spatial subdivisions in each dimension

Implements ripley::RipleyDomain.

Paso_SystemMatrixPattern * ripley::Rectangle::getPattern ( bool  reducedRowOrder,
bool  reducedColOrder 
) const
inlineprotectedvirtual

returns the Paso system matrix pattern

Implements ripley::RipleyDomain.

References m_pattern.

dim_t ripley::Rectangle::insertNeighbourNodes ( IndexVector index,
index_t  node 
) const
protectedvirtual

inserts the nodes that share an element with 'node' into 'index' and returns the number of these neighbours

Implements ripley::RipleyDomain.

References m_gNE, and m_NX.

void ripley::Rectangle::interpolateNodesOnElements ( escript::Data out,
escript::Data in,
bool  reduced 
) const
protectedvirtual

interpolates data on nodes in 'in' onto (reduced) elements in 'out'

Implements ripley::RipleyDomain.

References escript::Data::getDataPointSize(), escript::Data::getSampleDataRO(), escript::Data::getSampleDataRW(), INDEX2, m_NE, m_NN, and escript::Data::requireWrite().

void ripley::Rectangle::interpolateNodesOnFaces ( escript::Data out,
escript::Data in,
bool  reduced 
) const
protectedvirtual

interpolates data on nodes in 'in' onto (reduced) face elements in 'out'

Implements ripley::RipleyDomain.

References escript::Data::getDataPointSize(), escript::Data::getSampleDataRO(), escript::Data::getSampleDataRW(), INDEX2, m_faceOffset, m_NE, m_NN, and escript::Data::requireWrite().

void ripley::Rectangle::nodesToDOF ( escript::Data out,
escript::Data in 
) const
protectedvirtual
bool ripley::Rectangle::operator== ( const escript::AbstractDomain other) const
virtual

equality operator

Reimplemented from ripley::RipleyDomain.

References m_gNE, m_length, m_NX, and m_origin.

bool ripley::Rectangle::ownSample ( int  fs_code,
index_t  id 
) const
virtual
void ripley::Rectangle::populateSampleIds ( )
private
void ripley::Rectangle::Print_Mesh_Info ( const bool  full = false) const
virtual

writes information about the mesh to standard output

Parameters
fullwhether to print additional data

Reimplemented from ripley::RipleyDomain.

References getLocalCoordinate(), getNumNodes(), m_NN, and m_nodeId.

void ripley::Rectangle::readBinaryGrid ( escript::Data out,
std::string  filename,
const std::vector< int > &  first,
const std::vector< int > &  numValues,
const std::vector< int > &  multiplier 
) const
virtual
void ripley::Rectangle::readNcGrid ( escript::Data out,
std::string  filename,
std::string  varname,
const std::vector< int > &  first,
const std::vector< int > &  numValues,
const std::vector< int > &  multiplier 
) const
virtual
void ripley::Rectangle::setToNormal ( escript::Data out) const
virtual

copies the surface normals at data points into out. The actual function space to be considered is defined by out. out has to be defined on this domain.

Implements ripley::RipleyDomain.

References ripley::FaceElements, escript::Data::getFunctionSpace(), escript::Data::getSampleDataRW(), escript::FunctionSpace::getTypeCode(), m_faceOffset, m_NE, ripley::ReducedFaceElements, and escript::Data::requireWrite().

void ripley::Rectangle::setToSize ( escript::Data out) const
virtual
void ripley::Rectangle::writeBinaryGrid ( const escript::Data in,
std::string  filename,
int  byteOrder,
int  dataType 
) const
virtual
template<typename ValueType >
void ripley::Rectangle::writeBinaryGridImpl ( const escript::Data in,
const std::string &  filename,
int  byteOrder 
) const
private

Member Data Documentation

Paso_Connector* ripley::Rectangle::m_connector
private
IndexVector ripley::Rectangle::m_dofId
private

vector of sample reference identifiers

Referenced by borrowSampleReferenceIDs(), and populateSampleIds().

IndexVector ripley::Rectangle::m_dofMap
private
double ripley::Rectangle::m_dx[2]
private
IndexVector ripley::Rectangle::m_elementId
private
int ripley::Rectangle::m_faceCount[4]
private

number of face elements per edge (left, right, bottom, top)

Referenced by getNumFaceElements(), ownSample(), and populateSampleIds().

IndexVector ripley::Rectangle::m_faceId
private
IndexVector ripley::Rectangle::m_faceOffset
private

faceOffset[i]=-1 if face i is not an external face, otherwise it is the index of that face (where i: 0=left, 1=right, 2=bottom, 3=top)

Referenced by assembleGradient(), assembleIntegrate(), assemblePDEBoundarySingle(), assemblePDEBoundarySingleReduced(), assemblePDEBoundarySystem(), assemblePDEBoundarySystemReduced(), interpolateNodesOnFaces(), populateSampleIds(), setToNormal(), and setToSize().

dim_t ripley::Rectangle::m_gNE[2]
private
double ripley::Rectangle::m_length[2]
private

side lengths of domain

Referenced by operator==(), and Rectangle().

dim_t ripley::Rectangle::m_NE[2]
private
dim_t ripley::Rectangle::m_NN[2]
private
IndexVector ripley::Rectangle::m_nodeDistribution
private

Referenced by createPattern(), and populateSampleIds().

IndexVector ripley::Rectangle::m_nodeId
private
int ripley::Rectangle::m_NX[2]
private
dim_t ripley::Rectangle::m_offset[2]
private

first node on this rank is at (offset0,offset1) in global mesh

Referenced by assembleIntegrate(), createPattern(), getLocalCoordinate(), nodesToDOF(), populateSampleIds(), readBinaryGrid(), readNcGrid(), Rectangle(), and writeBinaryGridImpl().

double ripley::Rectangle::m_origin[2]
private

origin of domain

Referenced by getGridParameters(), getLocalCoordinate(), operator==(), and Rectangle().

dim_t ripley::Rectangle::m_ownNE[2]
private

number of own elements for this rank in each dimension

Referenced by assembleIntegrate(), and Rectangle().

Paso_SystemMatrixPattern* ripley::Rectangle::m_pattern
private

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