#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 |
pbsintervals & | Intervals () |
const pbsintervals & | Intervals () 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::IndexIntervalType & | PartitionInterval () |
const pcpp::IndexIntervalType & | PartitionInterval () const |
std::vector< double > & | CoordinateData () |
const std::vector< double > & | CoordinateData () const |
const double * | CoordinateData (int inDim) const |
double * | CoordinateData (int inDim) |
int | ExchangeCoordinates () |
pcpp::IndexIntervalType & | PartitionBufferInterval () |
const pcpp::IndexIntervalType & | PartitionBufferInterval () 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) |
HaloType & | Halo () |
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 ®ionName) 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) |
![]() | |
virtual int | ConfigureGrid (fixtures::ConfigurationType &inConfig, std::ostream &messageStream) |
virtual int | Configure (fixtures::ConfigurationType &inConfig) |
virtual std::string | ReportConfiguration () |
fixtures::CommunicatorType & | Communicator () const |
size_t | NumGlobalPoints () |
size_t | NumLocalPoints () |
![]() | |
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::stencilset * | stencilSet |
Differential operator. More... | |
int * | stencilConnectivity |
halo | gridHalo |
Halo object for communicating data with grid "neighbors". More... | |
halo * | haloPtr |
std::vector< bool > | periodicDirs |
std::vector< double > | periodicLengths |
std::vector< int > | decompDirs |
std::vector< int > | threadDecompDirs |
int | xyzMessageId |
int | metricMessageId |
std::vector< subregion > | subRegions |
Sub-regions and boundaries. More... | |
int | errorState |
![]() | |
fixtures::CommunicatorType | gridCommunicator |
size_t | numGlobalPoints |
size_t | numLocalPoints |
![]() | |
fixtures::ConfigurationType | gridConfig |
size_t | numPoints |
int | numDim |
|
inline |
|
inline |
Definition at line 524 of file Grid.H.
References numPointsBuffer.
Referenced by parallel_blockstructured::Finalize(), parallel_blockstructured::GenerateCoordinates(), parallel_blockstructured::GenerateGrid(), TestHDF5PBSGridIO(), and TestHDF5Read2DBlockStructuredGrid().
|
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().
|
inline |
Definition at line 459 of file Grid.H.
Referenced by parallel_blockstructured::ComputeCurvilinearMetrics2D(), parallel_blockstructured::ComputeCurvilinearMetrics3D(), parallel_blockstructured::ComputeJacobianMatrix(), parallel_blockstructured::ComputeMetricIdentities(), parallel_blockstructured::ComputeMetrics(), parallel_blockstructured::ComputeRectilinearMetrics(), parallel_blockstructured::ComputeUniformRectangularMetrics(), parallel_blockstructured::CurvilinearMetrics(), parallel_blockstructured::ExchangeCoordinates(), parallel_blockstructured::FlagMask(), parallel_blockstructured::GenerateCoordinates(), parallel_blockstructured::GenerateGrid(), testfixtures::viscid::GeneratePoiseuilleExact(), testfixtures::viscid::GenerateViscidShockExact(), parallel_blockstructured::GradIJK(), parallel_blockstructured::ParallelSetup(), plascom2::io::hdf5::ReadSingle(), plascom2::io::hdf5::ReadSingleState(), application::RunPlasCom2(), parallel_blockstructured::SetupThreads(), TestGrid_CurvilinearMetric(), TestGrid_CurvilinearVGWavy(), TestGrid_PBS_IntegratedHalo(), TestGrid_RectilinearMetric(), TestHDF5PBSGridIO(), TestMaxwellRHSTimeIntegrate(), TestPlasCom2Output(), TestVelocityGradient(), TestVelocityGradientPeriodic(), TestWENO_ApplyWENO(), and TestWENO_RHS().
int ComputeCurvilinearMetrics2D | ( | std::ostream & | messageStream | ) |
Definition at line 569 of file Grid.C.
References operators::applyoperator(), parallel_blockstructured::BufferSize(), bufferSizes, parallel_blockstructured::BufferSizes(), parallel_blockstructured::CoordinateData(), FC_MODULE(), sizeextent::Flatten(), parallel_blockstructured::gridCoordinates, parallel_blockstructured::gridJacobian, parallel_blockstructured::gridMetric, gridSizes, parallel_blockstructured::GridSizes(), sizeextent::NNodes(), base::numDim, pbsintervals::numDim, parallel_blockstructured::numPointsBuffer, numStencils, stencilset::numStencils, stencilset::numValues, parallel_blockstructured::PartitionBufferInterval(), parallel_blockstructured::PartitionInterval(), parallel_blockstructured::partitionIntervals, parallel_blockstructured::stencilConnectivity, stencilOffsets, stencilset::stencilOffsets, parallel_blockstructured::stencilSet, stencilSizes, stencilset::stencilSizes, stencilStarts, stencilset::stencilStarts, stencilWeights, stencilset::stencilWeights, operators::xax(), operators::yaxm1(), yaxpy(), and operators::zxy().
Referenced by parallel_blockstructured::ComputeMetrics().
int ComputeCurvilinearMetrics3D | ( | std::ostream & | messageStream | ) |
5 7 1 4 6 2 3 // met[0] = y_eta_zeta*z + y_eta*z_zeta - y_zeta_eta*z - y_zeta*z_eta;
Definition at line 966 of file Grid.C.
References parallel_blockstructured::BufferSize(), bufferSizes, parallel_blockstructured::BufferSizes(), parallel_blockstructured::ComputeJacobianMatrix(), parallel_blockstructured::ComputeJacobianMatrix2(), operators::determinant3x3(), parallel_blockstructured::ExchangeJacobianMatrix(), FC_MODULE(), sizeextent::Flatten(), parallel_blockstructured::gridCoordinates, parallel_blockstructured::gridJacobian, parallel_blockstructured::gridMetric, gridSizes, parallel_blockstructured::GridSizes(), parallel_blockstructured::jacobianMatrix, parallel_blockstructured::jacobianMatrix2, operators::metricsum4(), sizeextent::NNodes(), base::numDim, parallel_blockstructured::numPointsBuffer, parallel_blockstructured::PartitionBufferInterval(), parallel_blockstructured::PartitionInterval(), and operators::yaxm1().
int ComputeJacobianMatrix | ( | std::ostream & | messageStream | ) |
Calculates the regular/naive Jacobian matrix d(xyz)/d(ijk)
This routine computes the Jacobian matrix d(xyz)/d(ijk) and stuffs it into a native datastructure. It is used in full grid metrics
Definition at line 916 of file Grid.C.
References parallel_blockstructured::BufferSize(), bufferSizes, parallel_blockstructured::BufferSizes(), parallel_blockstructured::CoordinateData(), parallel_blockstructured::GradIJK(), parallel_blockstructured::gridCoordinates, gridSizes, parallel_blockstructured::GridSizes(), parallel_blockstructured::jacobianMatrix, base::numDim, pbsintervals::numDim, parallel_blockstructured::numPointsBuffer, parallel_blockstructured::PartitionBufferInterval(), parallel_blockstructured::PartitionInterval(), and parallel_blockstructured::partitionIntervals.
Referenced by parallel_blockstructured::ComputeCurvilinearMetrics3D(), parallel_blockstructured::CurvilinearMetrics(), TestGrid_CurvilinearMetric(), and TestGrid_CurvilinearVGWavy().
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().
int ComputeMetricIdentities | ( | std::vector< double > & | identityData, |
std::ostream & | messageStream | ||
) |
Definition at line 737 of file Grid.C.
References a, operators::applyoperator(), parallel_blockstructured::BufferSize(), bufferSizes, parallel_blockstructured::BufferSizes(), simulation::grid::CURVILINEAR, parallel_blockstructured::Dimension(), parallel_blockstructured::ExchangeNodalData(), FC_MODULE(), sizeextent::Flatten(), parallel_blockstructured::gridMetric, gridSizes, parallel_blockstructured::GridSizes(), parallel_blockstructured::gridType, base::numDim, parallel_blockstructured::numPointsBuffer, numStencils, stencilset::numStencils, stencilset::numValues, parallel_blockstructured::PartitionBufferInterval(), parallel_blockstructured::PartitionInterval(), parallel_blockstructured::stencilConnectivity, stencilOffsets, stencilset::stencilOffsets, parallel_blockstructured::stencilSet, stencilSizes, stencilset::stencilSizes, stencilStarts, stencilset::stencilStarts, stencilWeights, stencilset::stencilWeights, and yaxpy().
Referenced by TestGrid_CurvilinearMetric(), and TestGrid_CurvilinearVGWavy().
int ComputeMetrics | ( | std::ostream & | messageStream | ) |
Definition at line 519 of file Grid.C.
References bufferSizes, parallel_blockstructured::BufferSizes(), simulation::grid::CARTESIAN, parallel_blockstructured::ComputeCurvilinearMetrics2D(), parallel_blockstructured::ComputeRectilinearMetrics(), parallel_blockstructured::ComputeUniformRectangularMetrics(), parallel_blockstructured::CurvilinearMetrics(), gridSizes, parallel_blockstructured::GridSizes(), parallel_blockstructured::gridType, sizeextent::NNodes(), base::numDim, parallel_blockstructured::PartitionBufferInterval(), parallel_blockstructured::PartitionInterval(), simulation::grid::RECTILINEAR, parallel_blockstructured::stencilConnectivity, parallel_blockstructured::stencilSet, and simulation::grid::UNIRECT.
Referenced by TestGrid_CartesianMetric(), TestGrid_CurvilinearMetric(), TestGrid_CurvilinearVGWavy(), and TestGrid_RectilinearMetric().
int ComputeRectilinearMetrics | ( | std::ostream & | messageStream | ) |
Definition at line 328 of file Grid.C.
References operators::applyoperator(), parallel_blockstructured::BufferSize(), bufferSizes, parallel_blockstructured::BufferSizes(), FC_MODULE(), sizeextent::Flatten(), parallel_blockstructured::gridCoordinates, parallel_blockstructured::gridJacobian, parallel_blockstructured::gridMetric, gridSizes, parallel_blockstructured::GridSizes(), base::numDim, parallel_blockstructured::numPointsBuffer, numStencils, stencilset::numStencils, stencilset::numValues, parallel_blockstructured::PartitionBufferInterval(), parallel_blockstructured::PartitionInterval(), parallel_blockstructured::stencilConnectivity, stencilOffsets, stencilset::stencilOffsets, parallel_blockstructured::stencilSet, stencilSizes, stencilset::stencilSizes, stencilStarts, stencilset::stencilStarts, stencilWeights, stencilset::stencilWeights, operators::yaxm1(), operators::yxy(), and operators::zxy().
Referenced by parallel_blockstructured::ComputeMetrics().
int ComputeUniformRectangularMetrics | ( | std::ostream & | messageStream | ) |
Definition at line 252 of file Grid.C.
References bufferInterval, parallel_blockstructured::BufferSize(), bufferSizes, parallel_blockstructured::BufferSizes(), parallel_blockstructured::CoordinateData(), parallel_blockstructured::Dimension(), apptools::DumpContents(), parallel_blockstructured::dX, sizeextent::GetFlatIndices(), parallel_blockstructured::gridCoordinates, parallel_blockstructured::gridJacobian, parallel_blockstructured::gridMetric, gridSizes, parallel_blockstructured::GridSizes(), sizeextent::InitSimple(), base::numDim, parallel_blockstructured::numPointsBuffer, parallel_blockstructured::PartitionBufferInterval(), and parallel_blockstructured::PartitionInterval().
Referenced by parallel_blockstructured::ComputeMetrics().
|
inline |
Definition at line 503 of file Grid.H.
Referenced by parallel_blockstructured::ComputeCurvilinearMetrics2D(), parallel_blockstructured::ComputeJacobianMatrix(), parallel_blockstructured::ComputeUniformRectangularMetrics(), testfixtures::viscid::GeneratePoiseuilleExact(), testfixtures::viscid::GenerateViscidShockExact(), plascom2::util::PC2Compare(), TestGrid_CurvilinearMetric(), TestGrid_CurvilinearVGWavy(), TestHDF5GridIO(), TestHDF5PBSGridIO(), TestPlasCom2Output(), TestWENO_ApplyWENO(), and TestWENO_RHS().
|
inline |
Definition at line 506 of file Grid.H.
References numPointsBuffer.
|
inline |
Definition at line 511 of file Grid.H.
References numPointsBuffer.
int CurvilinearMetrics | ( | std::ostream & | messageStream | ) |
Definition at line 1205 of file Grid.C.
References operators::applyoperator(), bufferInterval, parallel_blockstructured::BufferSize(), bufferSizes, parallel_blockstructured::BufferSizes(), parallel_blockstructured::ComputeJacobianMatrix(), operators::determinant3x3(), parallel_blockstructured::ExchangeJacobianMatrix(), FC_MODULE(), sizeextent::Flatten(), parallel_blockstructured::gridCoordinates, parallel_blockstructured::gridJacobian, parallel_blockstructured::gridMetric, gridSizes, parallel_blockstructured::GridSizes(), sizeextent::InitSimple(), parallel_blockstructured::jacobianMatrix, parallel_blockstructured::jacobianMatrix2, sizeextent::NNodes(), base::numDim, parallel_blockstructured::numPointsBuffer, numStencils, stencilset::numStencils, stencilset::numValues, parallel_blockstructured::PartitionBufferInterval(), parallel_blockstructured::PartitionInterval(), parallel_blockstructured::stencilConnectivity, stencilOffsets, stencilset::stencilOffsets, parallel_blockstructured::stencilSet, stencilSizes, stencilset::stencilSizes, stencilStarts, stencilset::stencilStarts, stencilWeights, stencilset::stencilWeights, operators::yaxm1(), yaxpy(), and operators::zxy().
Referenced by parallel_blockstructured::ComputeMetrics().
|
inline |
Definition at line 428 of file Grid.H.
Referenced by parallel_blockstructured::ComputeMetricIdentities(), parallel_blockstructured::ComputeUniformRectangularMetrics(), parallel_blockstructured::ExchangeCoordinates(), parallel_blockstructured::ExchangeJacobianMatrix(), and parallel_blockstructured::SetupThreads().
|
inline |
Definition at line 538 of file Grid.H.
Referenced by testfixtures::viscid::GeneratePoiseuilleExact(), testfixtures::viscid::GenerateViscidShockExact(), TestPlasCom2Output(), TestVelocityGradient(), and TestVelocityGradientPeriodic().
int ExchangeCoordinates | ( | ) |
Definition at line 2075 of file Grid.C.
References bufferInterval, parallel_blockstructured::BufferSize(), bufferSizes, parallel_blockstructured::BufferSizes(), CommunicatorObject::CartNeighbors(), parallel_base::Communicator(), halo::CreateMessageBuffers(), halo::DestroyMessageBuffer(), parallel_blockstructured::Dimension(), sizeextent::GetFlatIndices(), parallel_blockstructured::gridCoordinates, gridSizes, parallel_blockstructured::GridSizes(), parallel_blockstructured::Halo(), sizeextent::InitSimple(), base::numDim, parallel_blockstructured::numPointsBuffer, halo::PackMessageBuffers(), parallel_blockstructured::PartitionBufferInterval(), parallel_blockstructured::PartitionInterval(), parallel_blockstructured::periodicDirs, parallel_blockstructured::periodicLengths, halo::ReceiveMessage(), halo::SendMessage(), halo::UnPackMessageBuffers(), and parallel_blockstructured::xyzMessageId.
Referenced by TestGrid_CurvilinearMetric(), TestGrid_CurvilinearVGWavy(), TestGrid_RectilinearMetric(), and TestHDF5PBSGridIO().
int ExchangeJacobianMatrix | ( | std::ostream & | messageStream | ) |
Definition at line 2159 of file Grid.C.
References parallel_blockstructured::BufferSize(), parallel_blockstructured::Dimension(), parallel_blockstructured::ExchangeNodalData(), parallel_blockstructured::jacobianMatrix, numComponents, base::numDim, and parallel_blockstructured::numPointsBuffer.
Referenced by parallel_blockstructured::ComputeCurvilinearMetrics3D(), and parallel_blockstructured::CurvilinearMetrics().
int ExchangeNodalData | ( | int | numComponents, |
double * | dataBuffer | ||
) |
Definition at line 818 of file Grid.C.
References CommunicatorObject::CartNeighbors(), parallel_base::Communicator(), halo::CreateMessageBuffers(), halo::DestroyMessageBuffer(), parallel_blockstructured::Halo(), halo::PackMessageBuffers(), halo::ReceiveMessage(), halo::SendMessage(), halo::UnPackMessageBuffers(), and parallel_blockstructured::xyzMessageId.
Referenced by parallel_blockstructured::ComputeMetricIdentities(), parallel_blockstructured::ExchangeJacobianMatrix(), and parallel_blockstructured::GradIJK().
int Finalize | ( | bool | allocateCoordinateData = false | ) |
Definition at line 2318 of file Grid.C.
References parallel_blockstructured::AllocateCoordinateData(), bufferInterval, pbsintervals::bufferSizes, parallel_blockstructured::dimExtensions, sizeextent::GetFlatIndices(), pbsintervals::gridSizes, sizeextent::InitSimple(), sizeextent::NNodes(), base::numDim, parallel_blockstructured::numPointsBuffer, parallel_blockstructured::numPointsPartition, sizeextent::Overlap(), subregion::partitionBufferIndices, pbsintervals::partitionBufferInterval, pbsintervals::partitionInterval, parallel_blockstructured::partitionIntervals, pbsintervals::partitionSizes, subregion::regionInterval, subregion::regionPartitionBufferInterval, subregion::regionPartitionInterval, parallel_blockstructured::SetNumThreads(), parallel_blockstructured::subRegions, and sizeextent::Sync().
Referenced by parallel_blockstructured::ParallelSetup(), plascom2::io::hdf5::ReadSingle(), plascom2::io::hdf5::ReadSingleState(), TestEOS_ComputeBuffers(), TestEulerKernels(), TestGrid_PBS_IntegratedHalo(), TestHDF5Read2DBlockStructuredGrid(), TestMaxwellRHS(), TestViscidKernels(), and TestViscidKernelsMetrics().
|
inline |
Definition at line 607 of file Grid.H.
References plascom2::operators::sbp::BufferSize().
size_t FlagMask | ( | int * | iMask, |
int | flagValue = 0 , |
||
int | flagBit = 1 |
||
) | const |
Definition at line 1794 of file Grid.C.
References bufferInterval, bufferSizes, parallel_blockstructured::BufferSizes(), parallel_blockstructured::flagData, sizeextent::GetFlatIndices(), sizeextent::InitSimple(), sizeextent::NNodes(), and parallel_blockstructured::PartitionBufferInterval().
int GenerateCoordinates | ( | std::ostream & | messageStream | ) |
Definition at line 1628 of file Grid.C.
References parallel_blockstructured::AllocateCoordinateData(), bufferSizes, parallel_blockstructured::BufferSizes(), simulation::grid::CARTESIAN, apptools::DumpContents(), parallel_blockstructured::dX, parallel_blockstructured::gridCoordinates, gridSizes, parallel_blockstructured::GridSizes(), parallel_blockstructured::gridType, sizeextent::NNodes(), base::numDim, parallel_blockstructured::numPointsBuffer, parallel_blockstructured::PartitionBufferInterval(), parallel_blockstructured::PartitionInterval(), parallel_blockstructured::periodicDirs, parallel_blockstructured::periodicLengths, parallel_blockstructured::PhysicalExtent(), parallel_blockstructured::physicalExtent, parallel_blockstructured::scaleFactor, and simulation::grid::UNIRECT.
Referenced by parallel_blockstructured::GenerateGrid(), TestGrid_CartesianMetric(), TestGrid_CurvilinearMetric(), TestGrid_CurvilinearVGWavy(), TestGrid_RectilinearMetric(), TestHDF5GridIO(), TestPlasCom2Output(), TestWENO_ApplyWENO(), and TestWENO_RHS().
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 > &) | GridGeneratorFunction, |
std::ostream & | messageStream | ||
) |
Definition at line 1822 of file Grid.C.
References parallel_blockstructured::AllocateCoordinateData(), bufferSizes, parallel_blockstructured::BufferSizes(), parallel_blockstructured::GenerateCoordinates(), parallel_blockstructured::gridCoordinates, parallel_blockstructured::GridGenerationOptions(), parallel_blockstructured::GridGenerationParameters(), gridSizes, parallel_blockstructured::GridSizes(), sizeextent::NNodes(), base::numDim, parallel_blockstructured::numPointsBuffer, parallel_blockstructured::PartitionBufferInterval(), parallel_blockstructured::PartitionInterval(), and parallel_blockstructured::PhysicalExtent().
|
inline |
int GradIJK | ( | int | numComponents, |
double * | sourceBuffer, | ||
double * | targetBuffer, | ||
std::ostream & | messageStream, | ||
bool | exchange = false |
||
) |
Definition at line 844 of file Grid.C.
References operators::applyoperator(), parallel_blockstructured::BufferSize(), bufferSizes, parallel_blockstructured::BufferSizes(), parallel_blockstructured::ExchangeNodalData(), FC_MODULE(), sizeextent::Flatten(), gridSizes, parallel_blockstructured::GridSizes(), numComponents, base::numDim, pbsintervals::numDim, parallel_blockstructured::numPointsBuffer, numStencils, stencilset::numStencils, stencilset::numValues, parallel_blockstructured::PartitionBufferInterval(), parallel_blockstructured::PartitionInterval(), parallel_blockstructured::partitionIntervals, parallel_blockstructured::stencilConnectivity, stencilOffsets, stencilset::stencilOffsets, parallel_blockstructured::stencilSet, stencilSizes, stencilset::stencilSizes, stencilStarts, stencilset::stencilStarts, stencilWeights, and stencilset::stencilWeights.
Referenced by parallel_blockstructured::ComputeJacobianMatrix(), and parallel_blockstructured::ComputeJacobianMatrix2().
|
inline |
Definition at line 649 of file Grid.H.
Referenced by parallel_blockstructured::GenerateGrid().
|
inline |
|
inline |
Definition at line 643 of file Grid.H.
Referenced by parallel_blockstructured::GenerateGrid().
|
inline |
|
inline |
Definition at line 469 of file Grid.H.
Referenced by parallel_blockstructured::ComputeCurvilinearMetrics2D(), parallel_blockstructured::ComputeCurvilinearMetrics3D(), parallel_blockstructured::ComputeJacobianMatrix(), parallel_blockstructured::ComputeMetricIdentities(), parallel_blockstructured::ComputeMetrics(), parallel_blockstructured::ComputeRectilinearMetrics(), parallel_blockstructured::ComputeUniformRectangularMetrics(), parallel_blockstructured::CurvilinearMetrics(), parallel_blockstructured::ExchangeCoordinates(), parallel_blockstructured::GenerateCoordinates(), parallel_blockstructured::GenerateGrid(), testfixtures::viscid::GeneratePoiseuilleExact(), testfixtures::viscid::GenerateViscidShockExact(), parallel_blockstructured::GradIJK(), parallel_blockstructured::ParallelSetup(), application::RunPlasCom2(), TestEOS_ComputeBuffers(), TestEulerKernels(), TestGrid_CurvilinearMetric(), TestGrid_CurvilinearVGWavy(), TestGrid_RectilinearMetric(), TestHDF5GridIO(), TestViscidKernels(), and TestViscidKernelsMetrics().
|
inline |
Definition at line 544 of file Grid.H.
References plascom2::GenerateGrid().
Referenced by parallel_blockstructured::ExchangeCoordinates(), parallel_blockstructured::ExchangeNodalData(), parallel_blockstructured::ParallelSetup(), application::RunPlasCom2(), TestEulerRHS(), TestEulerRHS2(), TestHDF5PBSGridIO(), TestMaxwellRHS(), TestMaxwellRHSTimeIntegrate(), TestPlasCom2Output(), TestVelocityGradient(), TestVelocityGradientPeriodic(), TestViscidRHS(), TestWENO_ApplyWENO(), and TestWENO_RHS().
|
inline |
|
inline |
|
inline |
Definition at line 624 of file Grid.H.
References gridJacobian.
Referenced by TestGrid_CartesianMetric(), TestGrid_CurvilinearMetric(), and TestGrid_RectilinearMetric().
|
inline |
Definition at line 625 of file Grid.H.
References gridJacobian.
|
inline |
Definition at line 626 of file Grid.H.
Referenced by TestGrid_CurvilinearMetric().
|
inline |
Definition at line 627 of file Grid.H.
References numComponents.
|
inline |
Definition at line 622 of file Grid.H.
References gridMetric.
Referenced by TestGrid_CartesianMetric(), TestGrid_CurvilinearMetric(), and TestGrid_RectilinearMetric().
|
inline |
Definition at line 623 of file Grid.H.
References gridMetric.
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().
|
inline |
Definition at line 519 of file Grid.H.
Referenced by parallel_blockstructured::ComputeCurvilinearMetrics2D(), parallel_blockstructured::ComputeCurvilinearMetrics3D(), parallel_blockstructured::ComputeJacobianMatrix(), parallel_blockstructured::ComputeMetricIdentities(), parallel_blockstructured::ComputeMetrics(), parallel_blockstructured::ComputeRectilinearMetrics(), parallel_blockstructured::ComputeUniformRectangularMetrics(), parallel_blockstructured::CurvilinearMetrics(), parallel_blockstructured::ExchangeCoordinates(), parallel_blockstructured::FlagMask(), parallel_blockstructured::GenerateCoordinates(), parallel_blockstructured::GenerateGrid(), testfixtures::viscid::GeneratePoiseuilleExact(), testfixtures::viscid::GenerateViscidShockExact(), parallel_blockstructured::GradIJK(), parallel_blockstructured::ParallelSetup(), plascom2::io::hdf5::ReadSingle(), plascom2::io::hdf5::ReadSingleState(), application::RunPlasCom2(), parallel_blockstructured::SetupThreads(), TestEOS_ComputeBuffers(), TestEulerKernels(), TestEulerRHS(), TestEulerRHS2(), TestGrid_CurvilinearMetric(), TestGrid_CurvilinearVGWavy(), TestGrid_PBS_IntegratedHalo(), TestGrid_RectilinearMetric(), TestHDF5PBSGridIO(), TestMaxwellRHS(), TestMaxwellRHSTimeIntegrate(), TestPlasCom2Output(), TestVelocityGradient(), TestVelocityGradientPeriodic(), TestViscidKernels(), TestViscidKernelsMetrics(), TestViscidRHS(), TestWENO_ApplyWENO(), and TestWENO_RHS().
|
inline |
|
inline |
Definition at line 500 of file Grid.H.
Referenced by parallel_blockstructured::ComputeCurvilinearMetrics2D(), parallel_blockstructured::ComputeCurvilinearMetrics3D(), parallel_blockstructured::ComputeJacobianMatrix(), parallel_blockstructured::ComputeMetricIdentities(), parallel_blockstructured::ComputeMetrics(), parallel_blockstructured::ComputeRectilinearMetrics(), parallel_blockstructured::ComputeUniformRectangularMetrics(), parallel_blockstructured::CurvilinearMetrics(), parallel_blockstructured::ExchangeCoordinates(), parallel_blockstructured::GenerateCoordinates(), parallel_blockstructured::GenerateGrid(), testfixtures::viscid::GeneratePoiseuilleExact(), testfixtures::viscid::GenerateViscidShockExact(), parallel_blockstructured::GradIJK(), parallel_blockstructured::ParallelSetup(), plascom2::io::hdf5::ReadSingle(), plascom2::io::hdf5::ReadSingleState(), application::RunPlasCom2(), parallel_blockstructured::SetupThreads(), TestGrid_CurvilinearMetric(), TestGrid_CurvilinearVGWavy(), TestGrid_PBS_IntegratedHalo(), TestGrid_RectilinearMetric(), TestHDF5GridIO(), TestHDF5PBSGridIO(), TestHDF5Read2DBlockStructuredGrid(), TestMaxwellRHS(), TestMaxwellRHSTimeIntegrate(), TestPlasCom2Output(), TestVelocityGradient(), TestVelocityGradientPeriodic(), TestWENO_ApplyWENO(), and TestWENO_RHS().
|
inline |
|
inline |
Definition at line 487 of file Grid.H.
Referenced by TestHDF5GridIO().
|
inline |
Definition at line 576 of file Grid.H.
Referenced by parallel_blockstructured::ParallelSetup().
|
inline |
Definition at line 533 of file Grid.H.
Referenced by parallel_blockstructured::GenerateCoordinates(), parallel_blockstructured::GenerateGrid(), testfixtures::viscid::GeneratePoiseuilleExact(), TestEOS_ComputeBuffers(), TestEulerKernels(), TestHDF5GridIO(), TestViscidKernels(), and TestViscidKernelsMetrics().
|
inline |
|
inline |
|
inline |
Definition at line 492 of file Grid.H.
Referenced by parallel_blockstructured::ParallelSetup(), TestGrid_PBS_IntegratedHalo(), and TestMaxwellRHS().
|
inline |
|
inline |
|
inline |
Definition at line 452 of file Grid.H.
Referenced by plascom2::io::hdf5::ReadSingle(), plascom2::io::hdf5::ReadSingleState(), TestGrid_CartesianMetric(), TestGrid_CurvilinearMetric(), TestGrid_CurvilinearVGWavy(), TestGrid_PBS_IntegratedHalo(), TestGrid_RectilinearMetric(), TestHDF5PBSGridIO(), TestHDF5Read2DBlockStructuredGrid(), TestMaxwellRHS(), TestMaxwellRHSTimeIntegrate(), TestPlasCom2Input(), TestPlasCom2Output(), TestVelocityGradient(), and TestVelocityGradientPeriodic().
|
inline |
Definition at line 540 of file Grid.H.
Referenced by TestEOS_ComputeBuffers(), TestEulerKernels(), TestHDF5GridIO(), TestMaxwellRHS(), TestViscidKernels(), and TestViscidKernelsMetrics().
void SetNumThreads | ( | int | numThreads | ) |
Definition at line 2291 of file Grid.C.
References pbsintervals::bufferSizes, subregion::partitionBufferIndices, pbsintervals::partitionBufferInterval, parallel_blockstructured::partitionIntervals, subregion::regionPartitionBufferInterval, subregion::regionPartitionInterval, parallel_blockstructured::subRegions, pbsintervals::threadBufferIntervals, subregion::threadPartitionBufferIndices, subregion::threadPartitionBufferIntervals, pbsintervals::threadPartitionBufferIntervals, subregion::threadPartitionIntervals, and pbsintervals::threadPartitionIntervals.
Referenced by parallel_blockstructured::Finalize(), parallel_blockstructured::SetupThreads(), TestEulerRHS2(), and TestViscidRHS().
|
inline |
|
inline |
|
inline |
Definition at line 586 of file Grid.H.
Referenced by TestVelocityGradient(), and TestVelocityGradientPeriodic().
|
inline |
Definition at line 588 of file Grid.H.
Referenced by TestGrid_CurvilinearVGWavy().
|
inline |
Definition at line 535 of file Grid.H.
Referenced by TestGrid_CartesianMetric(), TestMaxwellRHSTimeIntegrate(), TestVelocityGradient(), and TestVelocityGradientPeriodic().
|
inline |
|
inline |
|
inline |
Definition at line 596 of file Grid.H.
References gridType.
Referenced by TestGrid_CurvilinearMetric(), TestGrid_CurvilinearVGWavy(), TestGrid_RectilinearMetric(), and TestPlasCom2Output().
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().
int SetupThreads | ( | std::vector< int > & | numThreadPartitions | ) |
Definition at line 2174 of file Grid.C.
References bufferInterval, bufferSizes, pbsintervals::bufferSizes, parallel_blockstructured::BufferSizes(), parallel_blockstructured::Dimension(), parallel_blockstructured::errorState, sizeextent::GetFlatIndices(), sizeextent::InitSimple(), sizeextent::NNodes(), base::numDim, sizeextent::Overlap(), parallel_blockstructured::PartitionBufferInterval(), parallel_blockstructured::PartitionInterval(), parallel_blockstructured::partitionIntervals, subregion::regionInterval, parallel_blockstructured::SetNumThreads(), pcpp::util::SimplePartitionInterval(), parallel_blockstructured::subRegions, sizeextent::Sync(), pbsintervals::threadBufferIntervals, parallel_blockstructured::threadDecompDirs, subregion::threadPartitionBufferIndices, subregion::threadPartitionBufferIntervals, pbsintervals::threadPartitionBufferIntervals, subregion::threadPartitionIntervals, and pbsintervals::threadPartitionIntervals.
Referenced by TestVelocityGradient(), TestVelocityGradientPeriodic(), TestWENO_ApplyWENO(), and TestWENO_RHS().
|
inline |
|
inline |
|
inline |
|
inline |
|
inline |
|
inline |
|
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().
|
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().
|
protected |
Definition at line 706 of file Grid.H.
Referenced by parallel_blockstructured::SetupThreads().
|
protected |
Definition at line 681 of file Grid.H.
Referenced by parallel_blockstructured::FlagMask().
|
protected |
|
protected |
The coordinate buffer.
Definition at line 671 of file Grid.H.
Referenced by parallel_blockstructured::ComputeCurvilinearMetrics2D(), parallel_blockstructured::ComputeCurvilinearMetrics3D(), parallel_blockstructured::ComputeJacobianMatrix(), parallel_blockstructured::ComputeRectilinearMetrics(), parallel_blockstructured::ComputeUniformRectangularMetrics(), parallel_blockstructured::CurvilinearMetrics(), parallel_blockstructured::ExchangeCoordinates(), parallel_blockstructured::GenerateCoordinates(), and parallel_blockstructured::GenerateGrid().
|
protected |
|
protected |
Definition at line 676 of file Grid.H.
Referenced by parallel_blockstructured::ComputeCurvilinearMetrics2D(), parallel_blockstructured::ComputeCurvilinearMetrics3D(), parallel_blockstructured::ComputeRectilinearMetrics(), parallel_blockstructured::ComputeUniformRectangularMetrics(), and parallel_blockstructured::CurvilinearMetrics().
|
protected |
Grid metrics (sizes depend on gridTopoType)
Definition at line 675 of file Grid.H.
Referenced by parallel_blockstructured::ComputeCurvilinearMetrics2D(), parallel_blockstructured::ComputeCurvilinearMetrics3D(), parallel_blockstructured::ComputeMetricIdentities(), parallel_blockstructured::ComputeRectilinearMetrics(), parallel_blockstructured::ComputeUniformRectangularMetrics(), and parallel_blockstructured::CurvilinearMetrics().
|
protected |
GridType.
Definition at line 654 of file Grid.H.
Referenced by parallel_blockstructured::ComputeMetricIdentities(), parallel_blockstructured::ComputeMetrics(), and parallel_blockstructured::GenerateCoordinates().
|
protected |
Definition at line 677 of file Grid.H.
Referenced by parallel_blockstructured::ComputeCurvilinearMetrics3D(), parallel_blockstructured::ComputeJacobianMatrix(), parallel_blockstructured::ComputeJacobianMatrix2(), parallel_blockstructured::CurvilinearMetrics(), and parallel_blockstructured::ExchangeJacobianMatrix().
|
protected |
Definition at line 678 of file Grid.H.
Referenced by parallel_blockstructured::ComputeCurvilinearMetrics3D(), parallel_blockstructured::ComputeJacobianMatrix2(), and parallel_blockstructured::CurvilinearMetrics().
|
protected |
Number of points in the buffer.
Definition at line 661 of file Grid.H.
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(), parallel_blockstructured::Finalize(), parallel_blockstructured::GenerateCoordinates(), parallel_blockstructured::GenerateGrid(), parallel_blockstructured::GradIJK(), halo::PackMessageBuffers(), halo::SetLocalBufferSizes(), and halo::UnPackMessageBuffers().
|
protected |
Number of points in the partition.
Definition at line 663 of file Grid.H.
Referenced by parallel_blockstructured::Finalize().
|
protected |
The relevant partition intervals.
Definition at line 665 of file Grid.H.
Referenced by parallel_blockstructured::ComputeCurvilinearMetrics2D(), parallel_blockstructured::ComputeJacobianMatrix(), parallel_blockstructured::ComputeJacobianMatrix2(), parallel_blockstructured::Finalize(), parallel_blockstructured::GradIJK(), parallel_blockstructured::ParallelSetup(), parallel_blockstructured::SetNumThreads(), and parallel_blockstructured::SetupThreads().
|
protected |
Definition at line 696 of file Grid.H.
Referenced by parallel_blockstructured::ExchangeCoordinates(), parallel_blockstructured::GenerateCoordinates(), and parallel_blockstructured::ParallelSetup().
|
protected |
Definition at line 697 of file Grid.H.
Referenced by parallel_blockstructured::ExchangeCoordinates(), and parallel_blockstructured::GenerateCoordinates().
|
protected |
Physical grid extent (when applicable)
Definition at line 684 of file Grid.H.
Referenced by parallel_blockstructured::GenerateCoordinates().
|
protected |
Grid scaling factor.
Definition at line 688 of file Grid.H.
Referenced by parallel_blockstructured::GenerateCoordinates().
|
protected |
Definition at line 691 of file Grid.H.
Referenced by parallel_blockstructured::ComputeCurvilinearMetrics2D(), parallel_blockstructured::ComputeMetricIdentities(), parallel_blockstructured::ComputeMetrics(), parallel_blockstructured::ComputeRectilinearMetrics(), parallel_blockstructured::CurvilinearMetrics(), parallel_blockstructured::GradIJK(), and parallel_blockstructured::SetupDifferentialOperator().
|
protected |
Differential operator.
Definition at line 690 of file Grid.H.
Referenced by parallel_blockstructured::ComputeCurvilinearMetrics2D(), parallel_blockstructured::ComputeMetricIdentities(), parallel_blockstructured::ComputeMetrics(), parallel_blockstructured::ComputeRectilinearMetrics(), parallel_blockstructured::CurvilinearMetrics(), parallel_blockstructured::GradIJK(), and parallel_blockstructured::SetupDifferentialOperator().
|
protected |
Sub-regions and boundaries.
Definition at line 704 of file Grid.H.
Referenced by parallel_blockstructured::Finalize(), parallel_blockstructured::SetNumThreads(), and parallel_blockstructured::SetupThreads().
|
protected |
Definition at line 699 of file Grid.H.
Referenced by parallel_blockstructured::SetupThreads().
|
protected |
Definition at line 700 of file Grid.H.
Referenced by parallel_blockstructured::ExchangeCoordinates(), and parallel_blockstructured::ExchangeNodalData().