escript Revision_
speckley::SpeckleyDomain Class Referenceabstract

SpeckleyDomain extends the AbstractContinuousDomain interface for the Speckley library and is the base class for Rectangle and Brick. More...

#include <SpeckleyDomain.h>

Inheritance diagram for speckley::SpeckleyDomain:
escript::AbstractContinuousDomain escript::AbstractDomain speckley::Brick speckley::Rectangle

Public Member Functions

 SpeckleyDomain (dim_t dim, int order, escript::SubWorld_ptr p=escript::SubWorld_ptr())
 Constructor with number of dimensions. Allocates MPI info structure.
 
 ~SpeckleyDomain ()
 Destructor.
 
virtual escript::JMPI getMPI () const
 returns a reference to the MPI information wrapper for this domain
 
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
 
MPI_Comm 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
 equality operator
 
virtual bool operator!= (const escript::AbstractDomain &other) const
 inequality operator
 
virtual std::pair< int, dim_tgetDataShape (int fsType) const
 returns the number of data points per sample, and the number of samples as a pair.
 
int getTagFromSampleNo (int fsType, dim_t 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. If you really need to test for a particular direction, then use probeInterpolation.
 
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 =0
 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 =0
 determines whether interpolation from source to target is possible
 
virtual escript::Data getX () const
 returns locations in the SEM 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 (int fsType, 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 (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 boost::python::object &options) 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 (int solver, int preconditioner, int package, 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 (std::vector< real_t > &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 setToIntegrals (std::vector< cplx_t > &integrals, const escript::Data &arg) const
 
virtual void addToSystem (escript::AbstractSystemMatrix &mat, escript::Data &rhs, const DataMap &data, Assembler_ptr assembler) const
 adds a PDE onto the stiffness matrix mat and rhs, used for custom solvers with varying arguments counts and so on
 
virtual void addToSystemFromPython (escript::AbstractSystemMatrix &mat, escript::Data &rhs, const boost::python::list &data, Assembler_ptr assembler) const
 a wrapper for addToSystem that allows calling from Python
 
virtual void addToRHS (escript::Data &rhs, const DataMap &data, Assembler_ptr assembler) const
 adds a PDE onto rhs, used for custom solvers with varying arguments counts and so on
 
virtual void addToRHSFromPython (escript::Data &rhs, const boost::python::list &data, Assembler_ptr assembler) const
 a wrapper for addToRHS that allows calling from Python
 
virtual void addPDEToTransportProblem (escript::AbstractTransportProblem &tp, escript::Data &source, const DataMap &data, Assembler_ptr assembler) const
 adds a PDE onto a transport problem
 
void addPDEToTransportProblemFromPython (escript::AbstractTransportProblem &tp, escript::Data &source, const boost::python::list &data, Assembler_ptr assembler) const
 adds a PDE onto a transport problem
 
virtual escript::ASM_ptr newSystemMatrix (int row_blocksize, const escript::FunctionSpace &row_functionspace, int column_blocksize, const escript::FunctionSpace &column_functionspace, int type) const
 creates a stiffness matrix and initializes it with zeros
 
virtual escript::ATP_ptr newTransportProblem (int blocksize, const escript::FunctionSpace &functionspace, int type) const
 creates a transport problem
 
virtual void Print_Mesh_Info (bool full=false) const
 writes information about the mesh to standard output
 
virtual void write (const std::string &filename) const =0
 writes the current mesh to a file with the given name
 
virtual std::string getDescription () const =0
 returns a description for this domain
 
void dump (const std::string &filename) const =0
 dumps the mesh to a file with the given name
 
const index_tborrowSampleReferenceIDs (int fsType) const =0
 returns the array of reference numbers for a function space type
 
virtual void setToNormal (escript::Data &out) const =0
 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 =0
 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 void readNcGrid (escript::Data &out, std::string filename, std::string varname, const ReaderParameters &params) const =0
 reads grid data from a netCDF file into a Data object
 
virtual void readBinaryGrid (escript::Data &out, std::string filename, const ReaderParameters &params) const =0
 reads grid data from a raw binary file into a Data object
 
virtual void readBinaryGridFromZipped (escript::Data &out, std::string filename, const ReaderParameters &params) const =0
 reads grid data from a compressed raw binary file into a Data object
 
virtual void writeBinaryGrid (const escript::Data &in, std::string filename, int byteOrder, int dataType) const =0
 writes a Data object to a file in raw binary format
 
virtual bool ownSample (int fsType, index_t id) const =0
 returns true if this rank owns the sample id on given function space
 
virtual dim_t getNumDataPointsGlobal () const =0
 returns the number of data points summed across all MPI processes
 
virtual const dim_tgetNumNodesPerDim () const =0
 returns the number of nodes per MPI rank in each dimension
 
virtual const dim_tgetNumElementsPerDim () const =0
 returns the number of elements per MPI rank in each dimension
 
virtual const dim_tgetNumFacesPerBoundary () const =0
 returns the number of face elements in the order (left,right,bottom,top,[front,back]) on current MPI rank
 
virtual IndexVector getNodeDistribution () const =0
 returns the node distribution vector
 
virtual const int * getNumSubdivisionsPerDim () const =0
 returns the number of spatial subdivisions in each dimension
 
virtual double getLocalCoordinate (dim_t index, int dim) const =0
 returns the index'th coordinate value in given dimension for this rank
 
virtual boost::python::tuple getGridParameters () const =0
 returns the tuple (origin, spacing, number_of_elements)
 
virtual bool supportsFilter (const boost::python::tuple &t) const
 returns true if this domain can handle the specified tuple of filter options.
 
virtual Assembler_ptr createAssembler (const std::string type, const DataMap &options) const
 
Assembler_ptr createAssemblerFromPython (const std::string type, const boost::python::list &options) const
 
virtual const double * getLength () const =0
 returns the lengths of the domain
 
int getOrder () const
 returns the order of the domain
 
- Public Member Functions inherited from escript::AbstractContinuousDomain
 AbstractContinuousDomain ()
 Default constructor for AbstractContinuousDomain.
 
virtual ~AbstractContinuousDomain ()
 Destructor for AbstractContinuousDomain.
 
virtual void addPDEToSystem (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
 Return the domain as const AbstractContinuousDomain&.
 
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 the lumped stiffness matrix matrix
 
virtual void addPDEToTransportProblem (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
 
- 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
 
virtual ~AbstractDomain ()
 Destructor for AbstractDomain.
 
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.
 
virtual escript::Data randomFill (const DataTypes::ShapeType &shape, const FunctionSpace &what, long seed, const boost::python::tuple &filter) const =0
 Fills the data object with filtered random values.
 

Protected Member Functions

template<typename Scalar >
void copyData (escript::Data &out, const escript::Data &in) const
 copies data in 'in' to 'out' (both must be on same function space)
 
void updateTagsInUse (int fsType) const
 
void addToSystemMatrix (escript::AbstractSystemMatrix *mat, const IndexVector &nodes, dim_t numEq, const DoubleVector &array) const
 
void addPoints (const std::vector< double > &coords, const std::vector< int > &tags)
 
template<typename Scalar >
void multiplyData (escript::Data &out, const escript::Data &in) const
 expands ReducedFunction (in) to Function (out)
 
virtual dim_t getNumNodes () const =0
 returns the number of nodes per MPI rank
 
virtual dim_t getNumElements () const =0
 returns the number of elements per MPI rank
 
virtual dim_t getNumDOF () const =0
 returns the number of degrees of freedom per MPI rank
 
virtual void assembleCoordinates (escript::Data &arg) const =0
 populates the data object 'arg' with the node coordinates
 
virtual void assembleGradient (escript::Data &out, const escript::Data &in) const =0
 computes the gradient of 'in' and puts the result in 'out'
 
virtual void assembleIntegrate (std::vector< real_t > &integrals, const escript::Data &arg) const =0
 copies the integrals of the function defined by 'arg' into 'integrals'
 
virtual void assembleIntegrate (std::vector< cplx_t > &integrals, const escript::Data &arg) const =0
 
virtual void interpolateNodesOnElements (escript::Data &out, const escript::Data &in, bool reduced) const =0
 interpolates data on nodes in 'in' onto elements in 'out'
 
virtual void interpolateElementsOnNodes (escript::Data &out, const escript::Data &in) const =0
 interpolates data on elements in 'in' onto nodes in 'out'
 
virtual dim_t getDofOfNode (dim_t node) const =0
 
virtual void reduceElements (escript::Data &out, const escript::Data &in) const =0
 interpolates from Element -> ReducedElement
 

Protected Attributes

int m_numDim
 
StatusType m_status
 
escript::JMPI m_mpiInfo
 
TagMap m_tagMap
 
std::vector< int > m_nodeTags
 
std::vector< int > m_nodeTagsInUse
 
std::vector< int > m_elementTags
 
std::vector< int > m_elementTagsInUse
 
std::vector< DiracPointm_diracPoints
 
IndexVector m_diracPointNodeIDs
 
assembler_t assembler_type
 
int m_order
 element order (will be m_order + 1 quad points in each axis)
 

Private Member Functions

void assemblePDE (escript::AbstractSystemMatrix *mat, escript::Data &rhs, const DataMap &coefs, Assembler_ptr assembler) const
 calls the right PDE assembly routines after performing input checks
 
void assemblePDEBoundary (escript::AbstractSystemMatrix *mat, escript::Data &rhs, const DataMap &coefs, Assembler_ptr assembler) const
 
void assemblePDEDiracWrap (escript::AbstractSystemMatrix *mat, escript::Data &rhs, const DataMap &coefs, Assembler_ptr assembler) const
 
void assemblePDEDirac (escript::AbstractSystemMatrix *mat, escript::Data &rhs, const DataMap &coefs, Assembler_ptr assembler) const
 
void assembleComplexPDEDirac (escript::AbstractSystemMatrix *mat, escript::Data &rhs, const DataMap &coefs, Assembler_ptr assembler) const
 
template<typename Scalar >
void setToIntegralsWorker (std::vector< Scalar > &integrals, const escript::Data &arg) const
 
virtual dim_t findNode (const double *coords) const =0
 finds the node that the given point coordinates belong to
 

Additional Inherited Members

- Public Types inherited from escript::AbstractDomain
typedef int StatusType
 

Detailed Description

SpeckleyDomain extends the AbstractContinuousDomain interface for the Speckley library and is the base class for Rectangle and Brick.

Constructor & Destructor Documentation

◆ SpeckleyDomain()

speckley::SpeckleyDomain::SpeckleyDomain ( dim_t dim,
int order,
escript::SubWorld_ptr p = escript::SubWorld_ptr() )

Constructor with number of dimensions. Allocates MPI info structure.

References assembler_type, speckley::DEFAULT_ASSEMBLER, m_mpiInfo, escript::makeInfo(), and MPI_COMM_WORLD.

◆ ~SpeckleyDomain()

speckley::SpeckleyDomain::~SpeckleyDomain ( )

Destructor.

Member Function Documentation

◆ addPDEToTransportProblem()

void speckley::SpeckleyDomain::addPDEToTransportProblem ( escript::AbstractTransportProblem & tp,
escript::Data & source,
const DataMap & data,
Assembler_ptr assembler ) const
virtual

adds a PDE onto a transport problem

◆ addPDEToTransportProblemFromPython()

void speckley::SpeckleyDomain::addPDEToTransportProblemFromPython ( escript::AbstractTransportProblem & tp,
escript::Data & source,
const boost::python::list & data,
Assembler_ptr assembler ) const

adds a PDE onto a transport problem

◆ addPoints()

void speckley::SpeckleyDomain::addPoints ( const std::vector< double > & coords,
const std::vector< int > & tags )
protected

◆ addToRHS()

void speckley::SpeckleyDomain::addToRHS ( escript::Data & rhs,
const DataMap & data,
Assembler_ptr assembler ) const
virtual

adds a PDE onto rhs, used for custom solvers with varying arguments counts and so on

References assemblePDE(), assemblePDEBoundary(), assemblePDEDiracWrap(), escript::Data::isEmpty(), and speckley::isNotEmpty().

Referenced by addToRHSFromPython().

◆ addToRHSFromPython()

void speckley::SpeckleyDomain::addToRHSFromPython ( escript::Data & rhs,
const boost::python::list & data,
Assembler_ptr assembler ) const
virtual

a wrapper for addToRHS that allows calling from Python

References addToRHS(), escript::Data::expand(), and speckley::tupleListToMap().

Referenced by BOOST_PYTHON_MODULE().

◆ addToSystem()

void speckley::SpeckleyDomain::addToSystem ( escript::AbstractSystemMatrix & mat,
escript::Data & rhs,
const DataMap & data,
Assembler_ptr assembler ) const
virtual

adds a PDE onto the stiffness matrix mat and rhs, used for custom solvers with varying arguments counts and so on

Referenced by addToSystemFromPython().

◆ addToSystemFromPython()

void speckley::SpeckleyDomain::addToSystemFromPython ( escript::AbstractSystemMatrix & mat,
escript::Data & rhs,
const boost::python::list & data,
Assembler_ptr assembler ) const
virtual

a wrapper for addToSystem that allows calling from Python

References addToSystem(), and speckley::tupleListToMap().

Referenced by BOOST_PYTHON_MODULE().

◆ addToSystemMatrix()

void speckley::SpeckleyDomain::addToSystemMatrix ( escript::AbstractSystemMatrix * mat,
const IndexVector & nodes,
dim_t numEq,
const DoubleVector & array ) const
protected

◆ assembleComplexPDEDirac()

◆ assembleCoordinates()

virtual void speckley::SpeckleyDomain::assembleCoordinates ( escript::Data & arg) const
protectedpure virtual

populates the data object 'arg' with the node coordinates

Implemented in speckley::Brick, and speckley::Rectangle.

Referenced by setToX().

◆ assembleGradient()

virtual void speckley::SpeckleyDomain::assembleGradient ( escript::Data & out,
const escript::Data & in ) const
protectedpure virtual

computes the gradient of 'in' and puts the result in 'out'

Implemented in speckley::Brick, and speckley::Rectangle.

Referenced by setToGradient().

◆ assembleIntegrate() [1/2]

virtual void speckley::SpeckleyDomain::assembleIntegrate ( std::vector< cplx_t > & integrals,
const escript::Data & arg ) const
protectedpure virtual

Implemented in speckley::Brick, and speckley::Rectangle.

◆ assembleIntegrate() [2/2]

virtual void speckley::SpeckleyDomain::assembleIntegrate ( std::vector< real_t > & integrals,
const escript::Data & arg ) const
protectedpure virtual

copies the integrals of the function defined by 'arg' into 'integrals'

Implemented in speckley::Brick, and speckley::Rectangle.

Referenced by setToIntegralsWorker().

◆ assemblePDE()

void speckley::SpeckleyDomain::assemblePDE ( escript::AbstractSystemMatrix * mat,
escript::Data & rhs,
const DataMap & coefs,
Assembler_ptr assembler ) const
private

◆ assemblePDEBoundary()

void speckley::SpeckleyDomain::assemblePDEBoundary ( escript::AbstractSystemMatrix * mat,
escript::Data & rhs,
const DataMap & coefs,
Assembler_ptr assembler ) const
private

◆ assemblePDEDirac()

◆ assemblePDEDiracWrap()

void speckley::SpeckleyDomain::assemblePDEDiracWrap ( escript::AbstractSystemMatrix * mat,
escript::Data & rhs,
const DataMap & coefs,
Assembler_ptr assembler ) const
private

◆ borrowListOfTagsInUse()

const int * speckley::SpeckleyDomain::borrowListOfTagsInUse ( int fsType) const
virtual

returns a pointer to the list of tags in use for a function space type

Implements escript::AbstractDomain.

References speckley::Elements, m_elementTagsInUse, m_nodeTagsInUse, speckley::Nodes, and speckley::ReducedElements.

◆ borrowSampleReferenceIDs()

const index_t * speckley::SpeckleyDomain::borrowSampleReferenceIDs ( int fsType) const
pure virtual

returns the array of reference numbers for a function space type

Parameters
fsTypeThe function space type

Implements escript::AbstractDomain.

Implemented in speckley::Brick, and speckley::Rectangle.

Referenced by addPoints(), weipa::SpeckleyElements::initFromSpeckley(), and weipa::SpeckleyNodes::initFromSpeckley().

◆ canTag()

bool speckley::SpeckleyDomain::canTag ( int fsType) const
virtual

checks if this domain allows tags for the specified function space type

Implements escript::AbstractDomain.

References speckley::DegreesOfFreedom, speckley::Elements, getDescription(), speckley::Nodes, speckley::Points, and speckley::ReducedElements.

◆ commonFunctionSpace()

bool speckley::SpeckleyDomain::commonFunctionSpace ( const std::vector< int > & fs,
int & resultcode ) const
virtual

given a vector of FunctionSpace type codes, passes back a code which all can be interpolated to

Returns
true if result is valid, false if not

Implements escript::AbstractDomain.

References speckley::DegreesOfFreedom, speckley::Elements, speckley::Nodes, speckley::Points, speckley::ReducedDegreesOfFreedom, speckley::ReducedElements, and speckley::ReducedNodes.

◆ copyData()

template<typename Scalar >
void speckley::SpeckleyDomain::copyData ( escript::Data & out,
const escript::Data & in ) const
protected

◆ createAssembler()

virtual Assembler_ptr speckley::SpeckleyDomain::createAssembler ( const std::string type,
const DataMap & options ) const
inlinevirtual

Reimplemented in speckley::Brick, and speckley::Rectangle.

Referenced by createAssemblerFromPython().

◆ createAssemblerFromPython()

Assembler_ptr speckley::SpeckleyDomain::createAssemblerFromPython ( const std::string type,
const boost::python::list & options ) const

◆ dump()

void speckley::SpeckleyDomain::dump ( const std::string & filename) const
pure virtual

dumps the mesh to a file with the given name

Parameters
filenameThe name of the output file

Implements escript::AbstractDomain.

Implemented in speckley::Brick, and speckley::Rectangle.

Referenced by BOOST_PYTHON_MODULE().

◆ findNode()

virtual dim_t speckley::SpeckleyDomain::findNode ( const double * coords) const
privatepure virtual

finds the node that the given point coordinates belong to

Implemented in speckley::Brick, and speckley::Rectangle.

Referenced by addPoints().

◆ functionSpaceTypeAsString()

string speckley::SpeckleyDomain::functionSpaceTypeAsString ( int fsType) const
virtual

◆ getApproximationOrder()

virtual int speckley::SpeckleyDomain::getApproximationOrder ( int fsType) const
inlinevirtual

returns the approximation order used for a function space

Implements escript::AbstractDomain.

◆ getContinuousFunctionCode()

virtual int speckley::SpeckleyDomain::getContinuousFunctionCode ( ) const
inlinevirtual

returns a continuous FunctionSpace code

Reimplemented from escript::AbstractContinuousDomain.

◆ getDataShape()

pair< int, dim_t > speckley::SpeckleyDomain::getDataShape ( int fsType) const
virtual

◆ getDescription()

virtual std::string speckley::SpeckleyDomain::getDescription ( ) const
pure virtual

◆ getDim()

◆ getDiracDeltaFunctionsCode()

virtual int speckley::SpeckleyDomain::getDiracDeltaFunctionsCode ( ) const
inlinevirtual

returns a DiracDeltaFunctions FunctionSpace code

Reimplemented from escript::AbstractContinuousDomain.

◆ getDofOfNode()

virtual dim_t speckley::SpeckleyDomain::getDofOfNode ( dim_t node) const
protectedpure virtual

Implemented in speckley::Brick, and speckley::Rectangle.

◆ getFunctionCode()

virtual int speckley::SpeckleyDomain::getFunctionCode ( ) const
inlinevirtual

returns a function FunctionSpace code

Reimplemented from escript::AbstractContinuousDomain.

◆ getFunctionOnBoundaryCode()

virtual int speckley::SpeckleyDomain::getFunctionOnBoundaryCode ( ) const
inlinevirtual

returns a function on boundary FunctionSpace code

Reimplemented from escript::AbstractContinuousDomain.

◆ getFunctionOnContactOneCode()

virtual int speckley::SpeckleyDomain::getFunctionOnContactOneCode ( ) const
inlinevirtual

returns a FunctionOnContactOne code

Reimplemented from escript::AbstractContinuousDomain.

◆ getFunctionOnContactZeroCode()

virtual int speckley::SpeckleyDomain::getFunctionOnContactZeroCode ( ) const
inlinevirtual

return a FunctionOnContactZero code

Reimplemented from escript::AbstractContinuousDomain.

◆ getGridParameters()

virtual boost::python::tuple speckley::SpeckleyDomain::getGridParameters ( ) const
pure virtual

returns the tuple (origin, spacing, number_of_elements)

Implemented in speckley::Brick, and speckley::Rectangle.

Referenced by BOOST_PYTHON_MODULE().

◆ getLength()

virtual const double * speckley::SpeckleyDomain::getLength ( ) const
pure virtual

returns the lengths of the domain

Implemented in speckley::Brick, and speckley::Rectangle.

Referenced by speckley::RipleyCoupler::validInterpolation().

◆ getLocalCoordinate()

virtual double speckley::SpeckleyDomain::getLocalCoordinate ( dim_t index,
int dim ) const
pure virtual

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

Implemented in speckley::Brick, and speckley::Rectangle.

Referenced by weipa::SpeckleyNodes::initFromSpeckley(), and speckley::RipleyCoupler::RipleyCoupler().

◆ getMPI()

virtual escript::JMPI speckley::SpeckleyDomain::getMPI ( ) const
inlinevirtual

returns a reference to the MPI information wrapper for this domain

Implements escript::AbstractDomain.

◆ getMPIComm()

MPI_Comm speckley::SpeckleyDomain::getMPIComm ( ) const
inlinevirtual

◆ getMPIRank()

◆ getMPISize()

virtual int speckley::SpeckleyDomain::getMPISize ( ) const
inlinevirtual

returns the number of processors used for this domain

Implements escript::AbstractDomain.

Referenced by BOOST_PYTHON_MODULE(), interpolateOnDomain(), speckley::Brick::ownSample(), speckley::Rectangle::ownSample(), and setToGradient().

◆ getNodeDistribution()

virtual IndexVector speckley::SpeckleyDomain::getNodeDistribution ( ) const
pure virtual

returns the node distribution vector

Implemented in speckley::Brick, and speckley::Rectangle.

Referenced by weipa::SpeckleyNodes::initFromSpeckley().

◆ getNormal()

escript::Data speckley::SpeckleyDomain::getNormal ( ) const
virtual

returns boundary normals at the quadrature point on the face elements

Implements escript::AbstractDomain.

Referenced by BOOST_PYTHON_MODULE().

◆ getNumberOfTagsInUse()

int speckley::SpeckleyDomain::getNumberOfTagsInUse ( int fsType) const
virtual

returns the number of tags in use for a function space type

Implements escript::AbstractDomain.

References speckley::Elements, m_elementTagsInUse, m_nodeTagsInUse, speckley::Nodes, and speckley::ReducedElements.

◆ getNumDataPointsGlobal()

virtual dim_t speckley::SpeckleyDomain::getNumDataPointsGlobal ( ) const
pure virtual

returns the number of data points summed across all MPI processes

Reimplemented from escript::AbstractContinuousDomain.

Implemented in speckley::Brick, and speckley::Rectangle.

Referenced by BOOST_PYTHON_MODULE(), and weipa::SpeckleyNodes::initFromSpeckley().

◆ getNumDOF()

virtual dim_t speckley::SpeckleyDomain::getNumDOF ( ) const
protectedpure virtual

returns the number of degrees of freedom per MPI rank

Implemented in speckley::Brick, and speckley::Rectangle.

Referenced by getDataShape().

◆ getNumElements()

virtual dim_t speckley::SpeckleyDomain::getNumElements ( ) const
protectedpure virtual

returns the number of elements per MPI rank

Implemented in speckley::Brick, and speckley::Rectangle.

Referenced by getDataShape(), Print_Mesh_Info(), and setTags().

◆ getNumElementsPerDim()

virtual const dim_t * speckley::SpeckleyDomain::getNumElementsPerDim ( ) const
pure virtual

returns the number of elements per MPI rank in each dimension

Implemented in speckley::Brick, and speckley::Rectangle.

Referenced by weipa::SpeckleyElements::initFromSpeckley(), and speckley::RipleyCoupler::RipleyCoupler().

◆ getNumFacesPerBoundary()

virtual const dim_t * speckley::SpeckleyDomain::getNumFacesPerBoundary ( ) const
pure virtual

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

Implemented in speckley::Brick, and speckley::Rectangle.

Referenced by weipa::SpeckleyElements::initFromSpeckley(), and speckley::RipleyCoupler::RipleyCoupler().

◆ getNumNodes()

virtual dim_t speckley::SpeckleyDomain::getNumNodes ( ) const
protectedpure virtual

returns the number of nodes per MPI rank

Implemented in speckley::Brick, and speckley::Rectangle.

Referenced by getDataShape(), and setTags().

◆ getNumNodesPerDim()

virtual const dim_t * speckley::SpeckleyDomain::getNumNodesPerDim ( ) const
pure virtual

returns the number of nodes per MPI rank in each dimension

Implemented in speckley::Brick, and speckley::Rectangle.

Referenced by weipa::SpeckleyElements::initFromSpeckley(), and weipa::SpeckleyNodes::initFromSpeckley().

◆ getNumSubdivisionsPerDim()

virtual const int * speckley::SpeckleyDomain::getNumSubdivisionsPerDim ( ) const
pure virtual

returns the number of spatial subdivisions in each dimension

Implemented in speckley::Brick, and speckley::Rectangle.

Referenced by weipa::SpeckleyElements::initFromSpeckley(), and speckley::RipleyCoupler::RipleyCoupler().

◆ getOrder()

int speckley::SpeckleyDomain::getOrder ( ) const
inline

◆ getReducedContinuousFunctionCode()

virtual int speckley::SpeckleyDomain::getReducedContinuousFunctionCode ( ) const
inlinevirtual

returns a continuous on reduced order nodes FunctionSpace code

Reimplemented from escript::AbstractContinuousDomain.

◆ getReducedFunctionCode()

virtual int speckley::SpeckleyDomain::getReducedFunctionCode ( ) const
inlinevirtual

returns a function with reduced integration order FunctionSpace code

Reimplemented from escript::AbstractContinuousDomain.

◆ getReducedFunctionOnBoundaryCode()

virtual int speckley::SpeckleyDomain::getReducedFunctionOnBoundaryCode ( ) const
inlinevirtual

returns a function on boundary with reduced integration order FunctionSpace code

Reimplemented from escript::AbstractContinuousDomain.

◆ getReducedFunctionOnContactOneCode()

virtual int speckley::SpeckleyDomain::getReducedFunctionOnContactOneCode ( ) const
inlinevirtual

returns a FunctionOnContactOne code with reduced integration order

Reimplemented from escript::AbstractContinuousDomain.

◆ getReducedFunctionOnContactZeroCode()

virtual int speckley::SpeckleyDomain::getReducedFunctionOnContactZeroCode ( ) const
inlinevirtual

returns a FunctionOnContactZero code with reduced integration order

Reimplemented from escript::AbstractContinuousDomain.

◆ getReducedSolutionCode()

virtual int speckley::SpeckleyDomain::getReducedSolutionCode ( ) const
inlinevirtual

returns a ReducedSolution FunctionSpace code

Reimplemented from escript::AbstractContinuousDomain.

◆ getSize()

escript::Data speckley::SpeckleyDomain::getSize ( ) const
virtual

returns the element size

Implements escript::AbstractDomain.

References escript::function(), and escript::FunctionSpace::getSize().

Referenced by BOOST_PYTHON_MODULE().

◆ getSolutionCode()

virtual int speckley::SpeckleyDomain::getSolutionCode ( ) const
inlinevirtual

returns a Solution FunctionSpace code

Reimplemented from escript::AbstractContinuousDomain.

◆ getStatus()

virtual StatusType speckley::SpeckleyDomain::getStatus ( ) const
inlinevirtual

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.

Reimplemented from escript::AbstractDomain.

◆ getSystemMatrixTypeId()

int speckley::SpeckleyDomain::getSystemMatrixTypeId ( const boost::python::object & options) const
virtual

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

Parameters
optionsa python object containing the solver, package, preconditioner and symmetry

Reimplemented from escript::AbstractContinuousDomain.

Referenced by BOOST_PYTHON_MODULE().

◆ getTag()

virtual int speckley::SpeckleyDomain::getTag ( const std::string & name) const
inlinevirtual

returns the tag key for tag name

Parameters
nametag name

Implements escript::AbstractDomain.

Referenced by BOOST_PYTHON_MODULE().

◆ getTagFromSampleNo()

int speckley::SpeckleyDomain::getTagFromSampleNo ( int fsType,
dim_t sampleNo ) const
virtual

returns the tag key for the given sample number

Parameters
fsTypeThe function space type
sampleNoThe sample number

Implements escript::AbstractDomain.

References speckley::Elements, m_diracPoints, m_elementTags, m_nodeTags, speckley::Nodes, speckley::Points, and speckley::ReducedElements.

◆ getTransportTypeId()

int speckley::SpeckleyDomain::getTransportTypeId ( int solver,
int preconditioner,
int package,
bool symmetry ) const
virtual

returns the identifier of the transport problem type to be used when a particular solver, preconditioner, package and symmetric matrix is used

Parameters
solver
preconditioner
package
symmetry

Reimplemented from escript::AbstractContinuousDomain.

◆ getX()

escript::Data speckley::SpeckleyDomain::getX ( ) const
virtual

returns locations in the SEM nodes

Implements escript::AbstractDomain.

References escript::continuousFunction(), and escript::FunctionSpace::getX().

Referenced by BOOST_PYTHON_MODULE().

◆ interpolateAcross()

virtual void speckley::SpeckleyDomain::interpolateAcross ( escript::Data & target,
const escript::Data & source ) const
pure virtual

interpolates data given on source onto target where source and target are given on different domains

Implements escript::AbstractDomain.

Implemented in speckley::Brick, and speckley::Rectangle.

◆ interpolateElementsOnNodes()

virtual void speckley::SpeckleyDomain::interpolateElementsOnNodes ( escript::Data & out,
const escript::Data & in ) const
protectedpure virtual

interpolates data on elements in 'in' onto nodes in 'out'

Implemented in speckley::Brick, and speckley::Rectangle.

Referenced by interpolateOnDomain().

◆ interpolateNodesOnElements()

virtual void speckley::SpeckleyDomain::interpolateNodesOnElements ( escript::Data & out,
const escript::Data & in,
bool reduced ) const
protectedpure virtual

interpolates data on nodes in 'in' onto elements in 'out'

Implemented in speckley::Brick, and speckley::Rectangle.

Referenced by interpolateOnDomain().

◆ interpolateOnDomain()

◆ isCellOriented()

bool speckley::SpeckleyDomain::isCellOriented ( int fsType) const
virtual

returns true if data on this domain and given function space type has to be considered as cell centered data

Implements escript::AbstractDomain.

References speckley::DegreesOfFreedom, speckley::Elements, getDescription(), speckley::Nodes, speckley::Points, and speckley::ReducedElements.

◆ isValidFunctionSpaceType()

bool speckley::SpeckleyDomain::isValidFunctionSpaceType ( int fsType) const
virtual

returns true if the argument is a valid function space type for this domain

Reimplemented from escript::AbstractContinuousDomain.

References speckley::DegreesOfFreedom, speckley::Elements, speckley::Nodes, speckley::Points, and speckley::ReducedElements.

Referenced by preferredInterpolationOnDomain(), and probeInterpolationOnDomain().

◆ isValidTagName()

virtual bool speckley::SpeckleyDomain::isValidTagName ( const std::string & name) const
inlinevirtual

returns true if name is a defined tag name

Parameters
nametag name to be checked

Reimplemented from escript::AbstractDomain.

Referenced by BOOST_PYTHON_MODULE().

◆ MPIBarrier()

virtual void speckley::SpeckleyDomain::MPIBarrier ( ) const
inlinevirtual

if compiled for MPI then executes an MPI_Barrier, else does nothing

Implements escript::AbstractDomain.

Referenced by BOOST_PYTHON_MODULE(), speckley::Brick::writeBinaryGridImpl(), and speckley::Rectangle::writeBinaryGridImpl().

◆ multiplyData()

template<typename Scalar >
void speckley::SpeckleyDomain::multiplyData ( escript::Data & out,
const escript::Data & in ) const
protected

◆ newSystemMatrix()

escript::ASM_ptr speckley::SpeckleyDomain::newSystemMatrix ( int row_blocksize,
const escript::FunctionSpace & row_functionspace,
int column_blocksize,
const escript::FunctionSpace & column_functionspace,
int type ) const
virtual

creates a stiffness matrix and initializes it with zeros

Reimplemented from escript::AbstractContinuousDomain.

Referenced by BOOST_PYTHON_MODULE().

◆ newTransportProblem()

escript::ATP_ptr speckley::SpeckleyDomain::newTransportProblem ( int blocksize,
const escript::FunctionSpace & functionspace,
int type ) const
virtual

creates a transport problem

Reimplemented from escript::AbstractContinuousDomain.

◆ onMasterProcessor()

virtual bool speckley::SpeckleyDomain::onMasterProcessor ( ) const
inlinevirtual

returns true if on MPI processor 0, else false

Implements escript::AbstractDomain.

Referenced by BOOST_PYTHON_MODULE().

◆ operator!=()

virtual bool speckley::SpeckleyDomain::operator!= ( const escript::AbstractDomain & other) const
inlinevirtual

inequality operator

Implements escript::AbstractDomain.

◆ operator==()

bool speckley::SpeckleyDomain::operator== ( const escript::AbstractDomain & other) const
virtual

equality operator

Implements escript::AbstractDomain.

Reimplemented in speckley::Brick, and speckley::Rectangle.

References m_elementTags, m_nodeTags, and m_tagMap.

◆ ownSample()

virtual bool speckley::SpeckleyDomain::ownSample ( int fsType,
index_t id ) const
pure virtual

returns true if this rank owns the sample id on given function space

Implements escript::AbstractDomain.

Implemented in speckley::Brick, and speckley::Rectangle.

◆ preferredInterpolationOnDomain()

signed char speckley::SpeckleyDomain::preferredInterpolationOnDomain ( int fsType_source,
int fsType_target ) const
virtual

Preferred direction of interpolation. If you really need to test for a particular direction, then use probeInterpolation.

Returns
0 for not possible, 1 for possible and preferred, -1 other direction preferred (does not mean this direction is possible)

Implements escript::AbstractDomain.

References speckley::DegreesOfFreedom, speckley::Elements, getDescription(), isValidFunctionSpaceType(), speckley::Nodes, speckley::Points, speckley::ReducedDegreesOfFreedom, speckley::ReducedElements, and speckley::ReducedNodes.

◆ Print_Mesh_Info()

void speckley::SpeckleyDomain::Print_Mesh_Info ( bool full = false) const
virtual

writes information about the mesh to standard output

Parameters
fullwhether to print additional data

Reimplemented from escript::AbstractContinuousDomain.

Reimplemented in speckley::Brick, and speckley::Rectangle.

References getDescription(), getNumElements(), m_mpiInfo, m_numDim, and m_tagMap.

Referenced by BOOST_PYTHON_MODULE(), speckley::Brick::Print_Mesh_Info(), and speckley::Rectangle::Print_Mesh_Info().

◆ probeInterpolationAcross()

virtual bool speckley::SpeckleyDomain::probeInterpolationAcross ( int ,
const escript::AbstractDomain & ,
int  ) const
pure virtual

determines whether interpolation from source to target is possible

Implements escript::AbstractDomain.

Implemented in speckley::Brick, and speckley::Rectangle.

◆ probeInterpolationOnDomain()

bool speckley::SpeckleyDomain::probeInterpolationOnDomain ( int fsType_source,
int fsType_target ) const
virtual

◆ readBinaryGrid()

virtual void speckley::SpeckleyDomain::readBinaryGrid ( escript::Data & out,
std::string filename,
const ReaderParameters & params ) const
pure virtual

reads grid data from a raw binary file into a Data object

Implemented in speckley::Brick, and speckley::Rectangle.

Referenced by speckley::readBinaryGrid().

◆ readBinaryGridFromZipped()

virtual void speckley::SpeckleyDomain::readBinaryGridFromZipped ( escript::Data & out,
std::string filename,
const ReaderParameters & params ) const
pure virtual

reads grid data from a compressed raw binary file into a Data object

Implemented in speckley::Brick, and speckley::Rectangle.

Referenced by speckley::readBinaryGridFromZipped().

◆ readNcGrid()

virtual void speckley::SpeckleyDomain::readNcGrid ( escript::Data & out,
std::string filename,
std::string varname,
const ReaderParameters & params ) const
pure virtual

reads grid data from a netCDF file into a Data object

Implemented in speckley::Brick, and speckley::Rectangle.

Referenced by speckley::readNcGrid().

◆ reduceElements()

virtual void speckley::SpeckleyDomain::reduceElements ( escript::Data & out,
const escript::Data & in ) const
protectedpure virtual

interpolates from Element -> ReducedElement

Implemented in speckley::Brick, and speckley::Rectangle.

Referenced by interpolateOnDomain().

◆ setNewX()

void speckley::SpeckleyDomain::setNewX ( const escript::Data & arg)
virtual

assigns new location to the domain.

Note
This is not supported in Speckley

Reimplemented from escript::AbstractContinuousDomain.

◆ setTagMap()

virtual void speckley::SpeckleyDomain::setTagMap ( const std::string & name,
int tag )
inlinevirtual

sets a map from a clear tag name to a tag key

Parameters
nametag name
tagtag key

Implements escript::AbstractDomain.

Referenced by BOOST_PYTHON_MODULE(), speckley::Brick::Brick(), and speckley::Rectangle::Rectangle().

◆ setTags()

void speckley::SpeckleyDomain::setTags ( int fsType,
int newTag,
const escript::Data & mask ) const
virtual

assigns new tag newTag to all samples of given function space with a positive value of mask for any of its sample points

Implements escript::AbstractDomain.

References speckley::Elements, getNumElements(), getNumNodes(), escript::Data::getSampleDataRO(), m_elementTags, m_nodeTags, speckley::Nodes, and updateTagsInUse().

◆ setToGradient()

void speckley::SpeckleyDomain::setToGradient ( escript::Data & out,
const escript::Data & in ) const
virtual

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.

Implements escript::AbstractDomain.

References assembleGradient(), escript::continuousFunction(), speckley::DegreesOfFreedom, speckley::Elements, functionSpaceTypeAsString(), escript::Data::getFunctionSpace(), getMPISize(), escript::FunctionSpace::getTypeCode(), escript::Data::isComplex(), speckley::Nodes, and speckley::ReducedElements.

◆ setToIntegrals() [1/2]

void speckley::SpeckleyDomain::setToIntegrals ( std::vector< cplx_t > & integrals,
const escript::Data & arg ) const
virtual

◆ setToIntegrals() [2/2]

void speckley::SpeckleyDomain::setToIntegrals ( std::vector< real_t > & integrals,
const escript::Data & arg ) const
virtual

copies the integrals of the function defined by arg into integrals. arg has to be defined on this domain.

Reimplemented from escript::AbstractContinuousDomain.

References setToIntegralsWorker().

◆ setToIntegralsWorker()

template<typename Scalar >
void speckley::SpeckleyDomain::setToIntegralsWorker ( std::vector< Scalar > & integrals,
const escript::Data & arg ) const
private

◆ setToNormal()

virtual void speckley::SpeckleyDomain::setToNormal ( escript::Data & out) const
pure 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 escript::AbstractDomain.

Implemented in speckley::Brick, and speckley::Rectangle.

◆ setToSize()

virtual void speckley::SpeckleyDomain::setToSize ( escript::Data & out) const
pure virtual

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.

Implements escript::AbstractDomain.

Implemented in speckley::Brick, and speckley::Rectangle.

◆ setToX()

void speckley::SpeckleyDomain::setToX ( escript::Data & arg) const
virtual

◆ showTagNames()

string speckley::SpeckleyDomain::showTagNames ( ) const
virtual

returns all tag names in a single string separated by commas

Implements escript::AbstractDomain.

References m_tagMap.

Referenced by BOOST_PYTHON_MODULE().

◆ supportsContactElements()

virtual bool speckley::SpeckleyDomain::supportsContactElements ( ) const
inlinevirtual

returns true if this domain supports contact elements, false otherwise

Implements escript::AbstractDomain.

◆ supportsFilter()

bool speckley::SpeckleyDomain::supportsFilter ( const boost::python::tuple & t) const
virtual

returns true if this domain can handle the specified tuple of filter options.

Reimplemented from escript::AbstractDomain.

◆ updateTagsInUse()

◆ write()

virtual void speckley::SpeckleyDomain::write ( const std::string & filename) const
pure virtual

writes the current mesh to a file with the given name

Parameters
filenameThe name of the file to write to

Implements escript::AbstractDomain.

Implemented in speckley::Brick, and speckley::Rectangle.

◆ writeBinaryGrid()

virtual void speckley::SpeckleyDomain::writeBinaryGrid ( const escript::Data & in,
std::string filename,
int byteOrder,
int dataType ) const
pure virtual

writes a Data object to a file in raw binary format

Implemented in speckley::Brick, and speckley::Rectangle.

Referenced by BOOST_PYTHON_MODULE().

Member Data Documentation

◆ assembler_type

assembler_t speckley::SpeckleyDomain::assembler_type
protected

Referenced by SpeckleyDomain().

◆ m_diracPointNodeIDs

IndexVector speckley::SpeckleyDomain::m_diracPointNodeIDs
protected

◆ m_diracPoints

std::vector<DiracPoint> speckley::SpeckleyDomain::m_diracPoints
protected

◆ m_elementTags

std::vector<int> speckley::SpeckleyDomain::m_elementTags
mutableprotected

◆ m_elementTagsInUse

std::vector<int> speckley::SpeckleyDomain::m_elementTagsInUse
protected

◆ m_mpiInfo

◆ m_nodeTags

std::vector<int> speckley::SpeckleyDomain::m_nodeTags
mutableprotected

◆ m_nodeTagsInUse

std::vector<int> speckley::SpeckleyDomain::m_nodeTagsInUse
protected

◆ m_numDim

◆ m_order

◆ m_status

StatusType speckley::SpeckleyDomain::m_status
protected

◆ m_tagMap

TagMap speckley::SpeckleyDomain::m_tagMap
protected

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