PlasCom2  1.0
XPACC Multi-physics simluation application
parallel_blockstructured Class Reference

Detailed Description

Definition at line 387 of file Grid.H.

#include <Grid.H>

Public Types

typedef halo HaloType
 

Public Member Functions

int SetupThreads (std::vector< int > &numThreadPartitions)
 
 parallel_blockstructured ()
 
int NumberOfThreads () const
 
void SetNumThreads (int numThreads)
 
std::vector< pcpp::IndexIntervalType > & ThreadPartitionIntervals ()
 
const std::vector< pcpp::IndexIntervalType > & ThreadPartitionIntervals () const
 
std::vector< pcpp::IndexIntervalType > & ThreadPartitionBufferIntervals ()
 
const std::vector< pcpp::IndexIntervalType > & ThreadPartitionBufferIntervals () const
 
std::vector< pcpp::IndexIntervalType > & ThreadBufferIntervals ()
 
const std::vector< pcpp::IndexIntervalType > & ThreadBufferIntervals () const
 
int Dimension () const
 
size_t BufferSize () const
 
size_t PartitionSize () const
 
pbsintervalsIntervals ()
 
const pbsintervalsIntervals () const
 
void SetDecompSizes (const std::vector< int > &inDecomp)
 
const std::vector< int > & DecompSizes () const
 
std::vector< int > & DecompSizes ()
 
void SetGridSizes (const std::vector< size_t > &inSize)
 
const std::vector< size_t > & BufferSizes () const
 
std::vector< size_t > & BufferSizes ()
 
const std::vector< size_t > & GridSizes () const
 
std::vector< size_t > & GridSizes ()
 
void SetPartitionSizes (const std::vector< size_t > &inPartSize)
 
const std::vector< size_t > & PartitionSizes () const
 
void SetDimensionExtensions (const std::vector< size_t > &inExtensions)
 
void SetPartitionInterval (const pcpp::IndexIntervalType &inInterval)
 
pcpp::IndexIntervalTypePartitionInterval ()
 
const pcpp::IndexIntervalTypePartitionInterval () const
 
std::vector< double > & CoordinateData ()
 
const std::vector< double > & CoordinateData () const
 
const double * CoordinateData (int inDim) const
 
double * CoordinateData (int inDim)
 
int ExchangeCoordinates ()
 
pcpp::IndexIntervalTypePartitionBufferInterval ()
 
const pcpp::IndexIntervalTypePartitionBufferInterval () const
 
int Finalize (bool allocateCoordinateData=false)
 
void AllocateCoordinateData ()
 
const std::vector< double > & PhysicalExtent () const
 
std::vector< double > & PhysicalExtent ()
 
void SetPhysicalExtent (const std::vector< double > &inExtent)
 
const std::vector< double > & DX () const
 
std::vector< double > & DX ()
 
void SetGridSpacings (const std::vector< double > &inSpacing)
 
void SetHalo (halo &inHalo)
 
HaloTypeHalo ()
 
int GenerateCoordinates (std::ostream &)
 
int GenerateCoordinates (int(*)(const std::vector< size_t > &, std::vector< double > &), std::ostream &)
 
int GenerateGrid (int(*)(const std::vector< int > &, const std::vector< double > &, const std::vector< size_t > &, const std::vector< size_t > &, std::vector< double > &), std::ostream &)
 
const std::vector< subregion > & SubRegions () const
 
std::vector< subregion > & SubRegions ()
 
int GetRegionIndex (const std::string &regionName) const
 
std::vector< bool > & PeriodicDirs ()
 
const std::vector< bool > & PeriodicDirs () const
 
std::vector< int > & DecompDirs ()
 
const std::vector< int > & DecompDirs () const
 
void SetDecompDirs (const std::vector< int > &inDecomp)
 
void SetPeriodicDirs (const std::vector< bool > &inPeriodic)
 
void SetPeriodicLengths (const std::vector< double > &inLengths)
 
std::vector< int > & ThreadDecompDirs ()
 
const std::vector< int > & ThreadDecompDirs () const
 
void SetThreadDecompDirs (const std::vector< int > &inThread)
 
void SetType (int inType)
 
int Type () const
 
void SetScaleFactor (const std::vector< double > &inScale)
 
int ParallelSetup (fixtures::CommunicatorType &inComm, pcpp::ParallelTopologyInfoType &cartInfo, int haloDepth, std::ostream &messageStream)
 Perform cartesian communicator initialization for a grid. More...
 
std::vector< int > & FlagData ()
 
const std::vector< int > & FlagData () const
 
void DestroyFlags ()
 
size_t FlagMask (int *iMask, int flagValue=0, int flagBit=1) const
 
std::vector< double > & Metric ()
 
std::vector< double > Metric () const
 
std::vector< double > & Jacobian ()
 
std::vector< double > Jacobian () const
 
std::vector< double > & JacobianMatrix ()
 
std::vector< double > JacobianMatrix () const
 
int ComputeUniformRectangularMetrics (std::ostream &messageStream)
 
int ComputeRectilinearMetrics (std::ostream &messageStream)
 
int ComputeCurvilinearMetrics2D (std::ostream &messageStream)
 
int ComputeCurvilinearMetrics3D (std::ostream &messageStream)
 
int CurvilinearMetrics (std::ostream &messageStream)
 
int ComputeMetrics (std::ostream &messageStream)
 
int ComputeMetricIdentities (std::vector< double > &identityData, std::ostream &messageStream)
 
int SetupDifferentialOperator (plascom2::operators::stencilset *inStencilSet, int *inStencilConnectivity)
 
int ExchangeNodalData (int numComponents, double *dataBuffer)
 
int ExchangeJacobianMatrix (std::ostream &messageStream)
 
int GradIJK (int numComponents, double *sourceBuffer, double *targetBuffer, std::ostream &messageStream, bool exchange)
 
int ComputeJacobianMatrix (std::ostream &messageStream)
 Calculates the regular/naive Jacobian matrix d(xyz)/d(ijk) More...
 
int ComputeJacobianMatrix2 (std::ostream &messageStream)
 Calculates the gradient of the regular/naive J^-1 d^2(xyz)/d(ijk)^2. More...
 
std::vector< double > & GridGenerationParameters ()
 
const std::vector< double > & GridGenerationParameters () const
 
void SetGridGenerationParameters (const std::vector< double > &inParams)
 
std::vector< int > & GridGenerationOptions ()
 
const std::vector< int > & GridGenerationOptions () const
 
void SetGridGenerationOptions (const std::vector< int > &inOptions)
 
- Public Member Functions inherited from parallel_base
virtual int ConfigureGrid (fixtures::ConfigurationType &inConfig, std::ostream &messageStream)
 
virtual int Configure (fixtures::ConfigurationType &inConfig)
 
virtual std::string ReportConfiguration ()
 
fixtures::CommunicatorTypeCommunicator () const
 
size_t NumGlobalPoints ()
 
size_t NumLocalPoints ()
 
- Public Member Functions inherited from base
int NumDim () const
 
size_t NumPoints () const
 
int Dimension () const
 

Protected Attributes

int gridType
 GridType. More...
 
size_t numPointsBuffer
 Number of points in the buffer. More...
 
size_t numPointsPartition
 Number of points in the partition. More...
 
pbsintervals partitionIntervals
 The relevant partition intervals. More...
 
std::vector< size_t > dimExtensions
 Number of "halo/ghost" points in each (+/-) of the 2*numDim directions. More...
 
pcpp::IndexIntervalType globalBufferInterval
 The local buffer interval wrt the global grid size [yet unused]. More...
 
std::vector< double > gridCoordinates
 The coordinate buffer. More...
 
TopoType gridTopoType
 The topology type. More...
 
std::vector< double > gridMetric
 Grid metrics (sizes depend on gridTopoType) More...
 
std::vector< double > gridJacobian
 
std::vector< double > jacobianMatrix
 
std::vector< double > jacobianMatrix2
 
std::vector< double > gridGenParams
 
std::vector< int > gridGenOptions
 
std::vector< int > flagData
 
std::vector< double > physicalExtent
 Physical grid extent (when applicable) More...
 
std::vector< double > dX
 Grid spacing data structure (size depends on gridTopoType) More...
 
std::vector< double > scaleFactor
 Grid scaling factor. More...
 
plascom2::operators::stencilsetstencilSet
 Differential operator. More...
 
int * stencilConnectivity
 
halo gridHalo
 Halo object for communicating data with grid "neighbors". More...
 
halohaloPtr
 
std::vector< bool > periodicDirs
 
std::vector< double > periodicLengths
 
std::vector< int > decompDirs
 
std::vector< int > threadDecompDirs
 
int xyzMessageId
 
int metricMessageId
 
std::vector< subregionsubRegions
 Sub-regions and boundaries. More...
 
int errorState
 
- Protected Attributes inherited from parallel_base
fixtures::CommunicatorType gridCommunicator
 
size_t numGlobalPoints
 
size_t numLocalPoints
 
- Protected Attributes inherited from base
fixtures::ConfigurationType gridConfig
 
size_t numPoints
 
int numDim
 
Inheritance diagram for parallel_blockstructured:
Collaboration diagram for parallel_blockstructured:

Member Typedef Documentation

◆ HaloType

typedef halo HaloType

Definition at line 392 of file Grid.H.

Constructor & Destructor Documentation

◆ parallel_blockstructured()

Definition at line 398 of file Grid.H.

Member Function Documentation

◆ AllocateCoordinateData()

void AllocateCoordinateData ( )
inline

◆ BufferSize()

size_t BufferSize ( ) const
inline

Definition at line 430 of file Grid.H.

References numPointsBuffer.

Referenced by parallel_blockstructured::ComputeCurvilinearMetrics2D(), parallel_blockstructured::ComputeCurvilinearMetrics3D(), parallel_blockstructured::ComputeJacobianMatrix(), parallel_blockstructured::ComputeJacobianMatrix2(), parallel_blockstructured::ComputeMetricIdentities(), parallel_blockstructured::ComputeRectilinearMetrics(), parallel_blockstructured::ComputeUniformRectangularMetrics(), parallel_blockstructured::CurvilinearMetrics(), parallel_blockstructured::ExchangeCoordinates(), parallel_blockstructured::ExchangeJacobianMatrix(), testfixtures::viscid::GeneratePoiseuilleExact(), testfixtures::viscid::GenerateViscidShockExact(), parallel_blockstructured::GradIJK(), TestEulerRHS(), TestEulerRHS2(), TestGrid_CurvilinearMetric(), TestGrid_CurvilinearVGWavy(), TestGrid_PBS_IntegratedHalo(), TestGrid_RectilinearMetric(), TestHDF5PBSGridIO(), TestIntegrated_PFCurvilinear2DX(), TestIntegrated_PFCurvilinear2DY(), TestIntegrated_PFCurvilinear3DZ(), TestIntegrated_PFRectilinear2DX(), TestIntegrated_PFRectilinear2DY(), TestIntegrated_PFRectilinear3DZ(), TestIntegrated_Poiseuille2DX(), TestIntegrated_Poiseuille2DY(), TestIntegrated_Poiseuille3DZ(), TestIntegrated_ViscousShock2DX(), TestIntegrated_ViscousShock2DY(), TestIntegrated_ViscousShock3DZ(), TestIntegrated_VSCurvilinear2DX(), TestIntegrated_VSCurvilinear2DY(), TestIntegrated_VSCurvilinear3DZ(), TestIntegrated_VSRectilinear2DX(), TestIntegrated_VSRectilinear2DY(), TestIntegrated_VSRectilinear3DZ(), TestMaxwellRHS(), TestMaxwellRHSTimeIntegrate(), TestPlasCom2Output(), TestVelocityGradient(), TestVelocityGradientPeriodic(), TestViscidRHS(), TestWENO_ApplyWENO(), and TestWENO_RHS().

Here is the caller graph for this function:

◆ BufferSizes() [1/2]

◆ BufferSizes() [2/2]

std::vector<size_t>& BufferSizes ( )
inline

Definition at line 464 of file Grid.H.

◆ ComputeCurvilinearMetrics2D()

◆ ComputeCurvilinearMetrics3D()

◆ ComputeJacobianMatrix()

◆ ComputeJacobianMatrix2()

int ComputeJacobianMatrix2 ( std::ostream &  messageStream)

Calculates the gradient of the regular/naive J^-1 d^2(xyz)/d(ijk)^2.

This routine computes the Jacobian matrix d^2(xyz)/d(ijk)^2 and stuffs it into a native datastructure (jacobianMatrix2). It is used in full grid metrics

Definition at line 946 of file Grid.C.

References parallel_blockstructured::BufferSize(), parallel_blockstructured::GradIJK(), parallel_blockstructured::jacobianMatrix, parallel_blockstructured::jacobianMatrix2, numComponents, base::numDim, pbsintervals::numDim, parallel_blockstructured::numPointsBuffer, and parallel_blockstructured::partitionIntervals.

Referenced by parallel_blockstructured::ComputeCurvilinearMetrics3D().

Here is the call graph for this function:
Here is the caller graph for this function:

◆ ComputeMetricIdentities()

◆ ComputeMetrics()

◆ ComputeRectilinearMetrics()

◆ ComputeUniformRectangularMetrics()

◆ CoordinateData() [1/4]

◆ CoordinateData() [2/4]

const std::vector<double>& CoordinateData ( ) const
inline

Definition at line 504 of file Grid.H.

◆ CoordinateData() [3/4]

const double* CoordinateData ( int  inDim) const
inline

Definition at line 506 of file Grid.H.

References numPointsBuffer.

◆ CoordinateData() [4/4]

double* CoordinateData ( int  inDim)
inline

Definition at line 511 of file Grid.H.

References numPointsBuffer.

◆ CurvilinearMetrics()

◆ DecompDirs() [1/2]

std::vector<int>& DecompDirs ( )
inline

Definition at line 580 of file Grid.H.

◆ DecompDirs() [2/2]

const std::vector<int>& DecompDirs ( ) const
inline

Definition at line 582 of file Grid.H.

◆ DecompSizes() [1/2]

const std::vector<int>& DecompSizes ( ) const
inline

Definition at line 442 of file Grid.H.

◆ DecompSizes() [2/2]

std::vector<int>& DecompSizes ( )
inline

Definition at line 447 of file Grid.H.

◆ DestroyFlags()

void DestroyFlags ( )
inline

Definition at line 620 of file Grid.H.

◆ Dimension()

◆ DX() [1/2]

const std::vector<double>& DX ( ) const
inline

◆ DX() [2/2]

std::vector<double>& DX ( )
inline

Definition at line 539 of file Grid.H.

◆ ExchangeCoordinates()

◆ ExchangeJacobianMatrix()

int ExchangeJacobianMatrix ( std::ostream &  messageStream)

◆ ExchangeNodalData()

◆ Finalize()

◆ FlagData() [1/2]

std::vector<int>& FlagData ( )
inline

Definition at line 607 of file Grid.H.

References plascom2::operators::sbp::BufferSize().

Here is the call graph for this function:

◆ FlagData() [2/2]

const std::vector<int>& FlagData ( ) const
inline

Definition at line 615 of file Grid.H.

◆ FlagMask()

size_t FlagMask ( int *  iMask,
int  flagValue = 0,
int  flagBit = 1 
) const

◆ GenerateCoordinates() [1/2]

◆ GenerateCoordinates() [2/2]

int GenerateCoordinates ( int(*)(const std::vector< size_t > &, std::vector< double > &)  ,
std::ostream &   
)

◆ GenerateGrid()

◆ GetRegionIndex()

int GetRegionIndex ( const std::string &  regionName) const
inline

Definition at line 561 of file Grid.H.

◆ GradIJK()

◆ GridGenerationOptions() [1/2]

std::vector<int>& GridGenerationOptions ( )
inline

Definition at line 649 of file Grid.H.

Referenced by parallel_blockstructured::GenerateGrid().

Here is the caller graph for this function:

◆ GridGenerationOptions() [2/2]

const std::vector<int>& GridGenerationOptions ( ) const
inline

Definition at line 651 of file Grid.H.

◆ GridGenerationParameters() [1/2]

std::vector<double>& GridGenerationParameters ( )
inline

Definition at line 643 of file Grid.H.

Referenced by parallel_blockstructured::GenerateGrid().

Here is the caller graph for this function:

◆ GridGenerationParameters() [2/2]

const std::vector<double>& GridGenerationParameters ( ) const
inline

Definition at line 645 of file Grid.H.

◆ GridSizes() [1/2]

◆ GridSizes() [2/2]

std::vector<size_t>& GridSizes ( )
inline

Definition at line 474 of file Grid.H.

◆ Halo()

◆ Intervals() [1/2]

pbsintervals& Intervals ( )
inline

Definition at line 434 of file Grid.H.

◆ Intervals() [2/2]

const pbsintervals& Intervals ( ) const
inline

Definition at line 435 of file Grid.H.

◆ Jacobian() [1/2]

std::vector<double>& Jacobian ( )
inline

Definition at line 624 of file Grid.H.

References gridJacobian.

Referenced by TestGrid_CartesianMetric(), TestGrid_CurvilinearMetric(), and TestGrid_RectilinearMetric().

Here is the caller graph for this function:

◆ Jacobian() [2/2]

std::vector<double> Jacobian ( ) const
inline

Definition at line 625 of file Grid.H.

References gridJacobian.

◆ JacobianMatrix() [1/2]

std::vector<double>& JacobianMatrix ( )
inline

Definition at line 626 of file Grid.H.

Referenced by TestGrid_CurvilinearMetric().

Here is the caller graph for this function:

◆ JacobianMatrix() [2/2]

std::vector<double> JacobianMatrix ( ) const
inline

Definition at line 627 of file Grid.H.

References numComponents.

◆ Metric() [1/2]

std::vector<double>& Metric ( )
inline

Definition at line 622 of file Grid.H.

References gridMetric.

Referenced by TestGrid_CartesianMetric(), TestGrid_CurvilinearMetric(), and TestGrid_RectilinearMetric().

Here is the caller graph for this function:

◆ Metric() [2/2]

std::vector<double> Metric ( ) const
inline

Definition at line 623 of file Grid.H.

References gridMetric.

◆ NumberOfThreads()

int NumberOfThreads ( ) const
inline

Definition at line 405 of file Grid.H.

◆ ParallelSetup()

int ParallelSetup ( fixtures::CommunicatorType inComm,
pcpp::ParallelTopologyInfoType cartInfo,
int  haloDepth,
std::ostream &  messageStream 
)

Perform cartesian communicator initialization for a grid.

To be used after global grid sizes are initialized. inComm fixtures::CommunicatorType should be a communicator group including only endpoints that will contain part of this grid cartInfo pcpp::ParallelTopologyInfoType indicating how the parallel topology should be set up. Can contain optional user guidance for grid partitioning. haloDepth Used to determine the uniform halo depth to use for communication with neighboring partitions. messageStream std::ostream object to contain any messgaes produced by this routine.

Definition at line 22 of file Grid.C.

References bufferSizes, parallel_blockstructured::BufferSizes(), CommunicatorObject::CartCoordinates(), CommunicatorObject::CartDimensions(), pcpp::report::CartesianSetup(), parallel_base::Communicator(), halo::CreateLocalHaloExtents(), halo::CreateRemoteHaloExtents(), halo::CreateSimpleRecvIndices(), halo::CreateSimpleSendIndices(), apptools::DumpContents(), parallel_blockstructured::Finalize(), gridSizes, pbsintervals::gridSizes, parallel_blockstructured::GridSizes(), parallel_blockstructured::Halo(), sizeextent::InitSimple(), paralleltopologyinfo::isPeriodic, base::numDim, parallel_blockstructured::PartitionBufferInterval(), pcpp::util::PartitionCartesianInterval(), parallel_blockstructured::PartitionInterval(), parallel_blockstructured::partitionIntervals, parallel_blockstructured::PeriodicDirs(), parallel_blockstructured::periodicDirs, parallel_blockstructured::SetDimensionExtensions(), halo::SetGridInterval(), halo::SetLocalBufferSizes(), halo::SetLocalHaloExtents(), halo::SetLocalPartitionExtent(), halo::SetNeighbors(), halo::SetPartitionInterval(), halo::SetRemoteHaloExtents(), and pcpp::comm::SetupCartesianTopology().

Referenced by TestGrid_CartesianMetric(), TestGrid_CurvilinearMetric(), TestGrid_CurvilinearVGWavy(), TestGrid_RectilinearMetric(), TestHDF5GridIO(), TestHDF5PBSGridIO(), TestPlasCom2Input(), and TestPlasCom2Output().

Here is the call graph for this function:
Here is the caller graph for this function:

◆ PartitionBufferInterval() [1/2]

pcpp::IndexIntervalType& PartitionBufferInterval ( )
inline

◆ PartitionBufferInterval() [2/2]

const pcpp::IndexIntervalType& PartitionBufferInterval ( ) const
inline

Definition at line 520 of file Grid.H.

◆ PartitionInterval() [1/2]

◆ PartitionInterval() [2/2]

const pcpp::IndexIntervalType& PartitionInterval ( ) const
inline

Definition at line 501 of file Grid.H.

◆ PartitionSize()

size_t PartitionSize ( ) const
inline

Definition at line 432 of file Grid.H.

◆ PartitionSizes()

const std::vector<size_t>& PartitionSizes ( ) const
inline

Definition at line 487 of file Grid.H.

Referenced by TestHDF5GridIO().

Here is the caller graph for this function:

◆ PeriodicDirs() [1/2]

std::vector<bool>& PeriodicDirs ( )
inline

Definition at line 576 of file Grid.H.

Referenced by parallel_blockstructured::ParallelSetup().

Here is the caller graph for this function:

◆ PeriodicDirs() [2/2]

const std::vector<bool>& PeriodicDirs ( ) const
inline

Definition at line 578 of file Grid.H.

◆ PhysicalExtent() [1/2]

const std::vector<double>& PhysicalExtent ( ) const
inline

◆ PhysicalExtent() [2/2]

std::vector<double>& PhysicalExtent ( )
inline

Definition at line 534 of file Grid.H.

◆ SetDecompDirs()

void SetDecompDirs ( const std::vector< int > &  inDecomp)
inline

Definition at line 584 of file Grid.H.

◆ SetDecompSizes()

void SetDecompSizes ( const std::vector< int > &  inDecomp)
inline

Definition at line 437 of file Grid.H.

◆ SetDimensionExtensions()

void SetDimensionExtensions ( const std::vector< size_t > &  inExtensions)
inline

Definition at line 492 of file Grid.H.

Referenced by parallel_blockstructured::ParallelSetup(), TestGrid_PBS_IntegratedHalo(), and TestMaxwellRHS().

Here is the caller graph for this function:

◆ SetGridGenerationOptions()

void SetGridGenerationOptions ( const std::vector< int > &  inOptions)
inline

Definition at line 653 of file Grid.H.

◆ SetGridGenerationParameters()

void SetGridGenerationParameters ( const std::vector< double > &  inParams)
inline

Definition at line 647 of file Grid.H.

◆ SetGridSizes()

◆ SetGridSpacings()

void SetGridSpacings ( const std::vector< double > &  inSpacing)
inline

Definition at line 540 of file Grid.H.

Referenced by TestEOS_ComputeBuffers(), TestEulerKernels(), TestHDF5GridIO(), TestMaxwellRHS(), TestViscidKernels(), and TestViscidKernelsMetrics().

Here is the caller graph for this function:

◆ SetHalo()

void SetHalo ( halo inHalo)
inline

Definition at line 543 of file Grid.H.

◆ SetNumThreads()

◆ SetPartitionInterval()

void SetPartitionInterval ( const pcpp::IndexIntervalType inInterval)
inline

Definition at line 497 of file Grid.H.

◆ SetPartitionSizes()

void SetPartitionSizes ( const std::vector< size_t > &  inPartSize)
inline

Definition at line 480 of file Grid.H.

◆ SetPeriodicDirs()

void SetPeriodicDirs ( const std::vector< bool > &  inPeriodic)
inline

Definition at line 586 of file Grid.H.

Referenced by TestVelocityGradient(), and TestVelocityGradientPeriodic().

Here is the caller graph for this function:

◆ SetPeriodicLengths()

void SetPeriodicLengths ( const std::vector< double > &  inLengths)
inline

Definition at line 588 of file Grid.H.

Referenced by TestGrid_CurvilinearVGWavy().

Here is the caller graph for this function:

◆ SetPhysicalExtent()

void SetPhysicalExtent ( const std::vector< double > &  inExtent)
inline

Definition at line 535 of file Grid.H.

Referenced by TestGrid_CartesianMetric(), TestMaxwellRHSTimeIntegrate(), TestVelocityGradient(), and TestVelocityGradientPeriodic().

Here is the caller graph for this function:

◆ SetScaleFactor()

void SetScaleFactor ( const std::vector< double > &  inScale)
inline

Definition at line 602 of file Grid.H.

◆ SetThreadDecompDirs()

void SetThreadDecompDirs ( const std::vector< int > &  inThread)
inline

Definition at line 594 of file Grid.H.

◆ SetType()

void SetType ( int  inType)
inline

Definition at line 596 of file Grid.H.

References gridType.

Referenced by TestGrid_CurvilinearMetric(), TestGrid_CurvilinearVGWavy(), TestGrid_RectilinearMetric(), and TestPlasCom2Output().

Here is the caller graph for this function:

◆ SetupDifferentialOperator()

int SetupDifferentialOperator ( plascom2::operators::stencilset inStencilSet,
int *  inStencilConnectivity 
)

Definition at line 1619 of file Grid.C.

References parallel_blockstructured::stencilConnectivity, and parallel_blockstructured::stencilSet.

Referenced by TestGrid_CurvilinearMetric(), TestGrid_CurvilinearVGWavy(), and TestGrid_RectilinearMetric().

Here is the caller graph for this function:

◆ SetupThreads()

◆ SubRegions() [1/2]

const std::vector<subregion>& SubRegions ( ) const
inline

Definition at line 555 of file Grid.H.

◆ SubRegions() [2/2]

std::vector<subregion>& SubRegions ( )
inline

Definition at line 558 of file Grid.H.

◆ ThreadBufferIntervals() [1/2]

std::vector<pcpp::IndexIntervalType>& ThreadBufferIntervals ( )
inline

Definition at line 422 of file Grid.H.

◆ ThreadBufferIntervals() [2/2]

const std::vector<pcpp::IndexIntervalType>& ThreadBufferIntervals ( ) const
inline

Definition at line 425 of file Grid.H.

◆ ThreadDecompDirs() [1/2]

std::vector<int>& ThreadDecompDirs ( )
inline

Definition at line 590 of file Grid.H.

◆ ThreadDecompDirs() [2/2]

const std::vector<int>& ThreadDecompDirs ( ) const
inline

Definition at line 592 of file Grid.H.

◆ ThreadPartitionBufferIntervals() [1/2]

std::vector<pcpp::IndexIntervalType>& ThreadPartitionBufferIntervals ( )
inline

Definition at line 416 of file Grid.H.

◆ ThreadPartitionBufferIntervals() [2/2]

const std::vector<pcpp::IndexIntervalType>& ThreadPartitionBufferIntervals ( ) const
inline

Definition at line 419 of file Grid.H.

◆ ThreadPartitionIntervals() [1/2]

std::vector<pcpp::IndexIntervalType>& ThreadPartitionIntervals ( )
inline

Definition at line 410 of file Grid.H.

◆ ThreadPartitionIntervals() [2/2]

const std::vector<pcpp::IndexIntervalType>& ThreadPartitionIntervals ( ) const
inline

Definition at line 413 of file Grid.H.

◆ Type()

int Type ( ) const
inline

Definition at line 600 of file Grid.H.

References gridType.

Member Data Documentation

◆ decompDirs

std::vector<int> decompDirs
protected

Definition at line 698 of file Grid.H.

◆ dimExtensions

std::vector<size_t> dimExtensions
protected

Number of "halo/ghost" points in each (+/-) of the 2*numDim directions.

Definition at line 667 of file Grid.H.

Referenced by parallel_blockstructured::Finalize().

◆ dX

std::vector<double> dX
protected

Grid spacing data structure (size depends on gridTopoType)

Definition at line 686 of file Grid.H.

Referenced by parallel_blockstructured::ComputeUniformRectangularMetrics(), and parallel_blockstructured::GenerateCoordinates().

◆ errorState

int errorState
protected

Definition at line 706 of file Grid.H.

Referenced by parallel_blockstructured::SetupThreads().

◆ flagData

std::vector<int> flagData
protected

Definition at line 681 of file Grid.H.

Referenced by parallel_blockstructured::FlagMask().

◆ globalBufferInterval

pcpp::IndexIntervalType globalBufferInterval
protected

The local buffer interval wrt the global grid size [yet unused].

Definition at line 669 of file Grid.H.

◆ gridCoordinates

◆ gridGenOptions

std::vector<int> gridGenOptions
protected

Definition at line 680 of file Grid.H.

◆ gridGenParams

std::vector<double> gridGenParams
protected

Definition at line 679 of file Grid.H.

◆ gridHalo

halo gridHalo
protected

Halo object for communicating data with grid "neighbors".

Definition at line 694 of file Grid.H.

◆ gridJacobian

◆ gridMetric

◆ gridTopoType

TopoType gridTopoType
protected

The topology type.

Definition at line 673 of file Grid.H.

◆ gridType

◆ haloPtr

halo* haloPtr
protected

Definition at line 695 of file Grid.H.

◆ jacobianMatrix

◆ jacobianMatrix2

◆ metricMessageId

int metricMessageId
protected

Definition at line 701 of file Grid.H.

◆ numPointsBuffer

◆ numPointsPartition

size_t numPointsPartition
protected

Number of points in the partition.

Definition at line 663 of file Grid.H.

Referenced by parallel_blockstructured::Finalize().

◆ partitionIntervals

◆ periodicDirs

std::vector<bool> periodicDirs
protected

◆ periodicLengths

std::vector<double> periodicLengths
protected

◆ physicalExtent

std::vector<double> physicalExtent
protected

Physical grid extent (when applicable)

Definition at line 684 of file Grid.H.

Referenced by parallel_blockstructured::GenerateCoordinates().

◆ scaleFactor

std::vector<double> scaleFactor
protected

Grid scaling factor.

Definition at line 688 of file Grid.H.

Referenced by parallel_blockstructured::GenerateCoordinates().

◆ stencilConnectivity

◆ stencilSet

◆ subRegions

std::vector<subregion> subRegions
protected

◆ threadDecompDirs

std::vector<int> threadDecompDirs
protected

Definition at line 699 of file Grid.H.

Referenced by parallel_blockstructured::SetupThreads().

◆ xyzMessageId

int xyzMessageId
protected

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