IBAMR  IBAMR version 0.19.
Public Types | Public Member Functions | Private Member Functions | Static Private Member Functions | Private Attributes | Static Private Attributes | List of all members
SAMRAI::hier::PatchLevel< DIM > Class Template Reference

#include <ibtk/VCSCViscousPETScLevelSolver.h>

Inheritance diagram for SAMRAI::hier::PatchLevel< DIM >:
Inheritance graph
[legend]

Public Types

typedef PatchLevelIterator< DIM > Iterator
 

Public Member Functions

 PatchLevel ()
 
 PatchLevel (const BoxArray< DIM > &boxes, const ProcessorMapping &mapping, const IntVector< DIM > &ratio_to_level_zero, const tbox::Pointer< GridGeometry< DIM > > grid_geometry, const tbox::Pointer< PatchDescriptor< DIM > > descriptor, tbox::Pointer< PatchFactory< DIM > > factory=NULL, bool defer_boundary_box_creation=false)
 
 PatchLevel (tbox::Pointer< tbox::Database > level_database, tbox::Pointer< GridGeometry< DIM > > grid_geometry, tbox::Pointer< PatchDescriptor< DIM > > descriptor, tbox::Pointer< PatchFactory< DIM > > factory, ComponentSelector component_selector=ComponentSelector(false), bool defer_boundary_box_creation=false)
 
virtual ~PatchLevel ()
 
int getLevelNumber () const
 
void setLevelNumber (const int l)
 
int getNextCoarserHierarchyLevelNumber () const
 
void setNextCoarserHierarchyLevelNumber (const int l)
 
bool inHierarchy () const
 
void setLevelInHierarchy (bool in_hierarchy)
 
int getNumberOfPatches () const
 
tbox::Pointer< Patch< DIM > > getPatch (const int p) const
 
tbox::Pointer< PatchDescriptor< DIM > > getPatchDescriptor () const
 
tbox::Pointer< PatchFactory< DIM > > getPatchFactory () const
 
tbox::Pointer< GridGeometry< DIM > > getGridGeometry () const
 
void setRefinedPatchLevel (const tbox::Pointer< hier::PatchLevel< DIM > > coarse_level, const hier::IntVector< DIM > &refine_ratio, const tbox::Pointer< hier::GridGeometry< DIM > > fine_grid_geometry=NULL, bool defer_boundary_box_creation=false)
 
void setCoarsenedPatchLevel (const tbox::Pointer< hier::PatchLevel< DIM > > fine_level, const hier::IntVector< DIM > &coarsen_ratio, const tbox::Pointer< hier::GridGeometry< DIM > > coarse_grid_geom=NULL, bool defer_boundary_box_creation=false)
 
void setBoundaryBoxes ()
 
const BoxArray< DIM > & getPhysicalDomain () const
 
const BoxArray< DIM > & getBoxes () const
 
const tbox::Array< tbox::List< IntVector< DIM > > > & getShiftsForLevel () const
 
const ProcessorMappinggetProcessorMapping () const
 
const IntVector< DIM > & getRatio () const
 
const IntVector< DIM > & getRatioToCoarserLevel () const
 
void setRatioToCoarserLevel (const IntVector< DIM > &ratio)
 
int getMappingForPatch (const int p) const
 
const Box< DIM > & getBoxForPatch (const int p) const
 
const tbox::List< IntVector< DIM > > & getShiftsForPatch (const int p) const
 
bool patchTouchesRegularBoundary (const int p) const
 
bool patchTouchesPeriodicBoundary (const int p) const
 
void allocatePatchData (const int id, const double timestamp=0.0, tbox::Pointer< tbox::Arena > pool=NULL)
 
void allocatePatchData (const ComponentSelector &components, const double timestamp=0.0, tbox::Pointer< tbox::Arena > pool=NULL)
 
bool checkAllocated (const int id) const
 
void deallocatePatchData (const int id)
 
void deallocatePatchData (const ComponentSelector &components)
 
void setTime (const double timestamp, const int id)
 
void setTime (const double timestamp, const ComponentSelector &components)
 
void setTime (const double timestamp)
 
void getFromDatabase (tbox::Pointer< tbox::Database > database, ComponentSelector component_selector)
 
void putToDatabase (tbox::Pointer< tbox::Database > database, const ComponentSelector &patchdata_write_table)
 
int recursivePrint (std::ostream &os, const std::string &border=std::string(), unsigned short depth=0)
 Print a patch level to varying details. More...
 
tbox::Pointer< BoxGraph< DIM > > getBoxGraph ()
 
tbox::Pointer< BoxTop< DIM > > getBoxTop ()
 
tbox::Pointer< BoxTree< DIM > > getBoxTree ()
 
tbox::Pointer< BinaryTree< DIM > > getBinaryTree ()
 

Private Member Functions

void setPatchTouchesBoundaryArrays ()
 

Static Private Member Functions

static void initializeTimers ()
 
static void freeTimers ()
 

Private Attributes

BoxArray< DIM > d_boxes
 
ProcessorMapping d_mapping
 
IntVector< DIM > d_ratio_to_level_zero
 
tbox::Pointer< GridGeometry< DIM > > d_geometry
 
tbox::Pointer< PatchDescriptor< DIM > > d_descriptor
 
tbox::Pointer< PatchFactory< DIM > > d_factory
 
int d_number_patches
 
BoxArray< DIM > d_physical_domain
 
IntVector< DIM > d_ratio_to_coarser_level
 
int d_level_number
 
int d_next_coarser_level_number
 
bool d_in_hierarchy
 
tbox::Array< tbox::Pointer< Patch< DIM > > > d_patches
 
tbox::Array< boold_patch_touches_regular_boundary
 
tbox::Array< boold_patch_touches_periodic_boundary
 
tbox::Array< tbox::List< IntVector< DIM > > > d_shifts
 
bool d_boundary_boxes_created
 
tbox::Pointer< BoxGraph< DIM > > d_box_graph
 
tbox::Pointer< BoxTop< DIM > > d_box_top
 
tbox::Pointer< BoxTree< DIM > > d_box_tree
 
tbox::Pointer< BinaryTree< DIM > > d_binary_tree
 

Static Private Attributes

static tbox::Pointer< tbox::Timert_level_constructor
 

Detailed Description

template<int DIM>
class SAMRAI::hier::PatchLevel< DIM >

Class PatchLevel<DIM> is a container class for the patches defined at one level of the AMR hierarchy. The patches in a patch level are distributed across the processors of a parallel machine, so not all patches reside on the local processor. Each patch is assigned to one and only one processor.

To iterate over the local patches in a patch level, use the patch level iterator class (PatchLevel<DIM>::Iterator). This iterator will use the owner-computes rule to pick off local patches for computation.

See also
hier::BasePatchLevel
hier::Patch
hier::PatchDescriptor
hier::PatchFactory
hier::PatchLevelIterator

Member Typedef Documentation

◆ Iterator

template<int DIM>
typedef PatchLevelIterator<DIM> SAMRAI::hier::PatchLevel< DIM >::Iterator

The iterator for the patches on a patch level. The iterator will return the patches that live on the local processor. Use iterator PatchLevel<DIM>::Iterator instead of PatchLevelIterator<DIM>, since the iterator may be defined as a nested class in the future.

Constructor & Destructor Documentation

◆ PatchLevel() [1/3]

template<int DIM>
SAMRAI::hier::PatchLevel< DIM >::PatchLevel ( )

Default constructor. PatchLevel must be initialized before it can be used.

◆ PatchLevel() [2/3]

template<int DIM>
SAMRAI::hier::PatchLevel< DIM >::PatchLevel ( const BoxArray< DIM > &  boxes,
const ProcessorMapping mapping,
const IntVector< DIM > &  ratio_to_level_zero,
const tbox::Pointer< GridGeometry< DIM > >  grid_geometry,
const tbox::Pointer< PatchDescriptor< DIM > >  descriptor,
tbox::Pointer< PatchFactory< DIM > >  factory = NULL,
bool  defer_boundary_box_creation = false 
)

Construct a new patch level given an array of boxes and a processor mapping. The ratio information establishes the ratio between the index space of the new level and some reference level. Typically, the reference level is level zero (i.e., the coarsest level) in some patch hierarchy. Also, the ratio is used by the grid geometry object to initialize the geometry information of the level and the patches on the level. All patch data owned by the local processor are allocated using the specified descriptor. A patch factory can be passed into the level constructor to specify the appropriate patch factory; if no factory is specified, then the standard patch factory will be used.

When assertion checking is active, an unrecoverable assertion results if either the grid geometry pointer or patch descriptor pointer is null, or if the number of boxes in the array does not match the mapping array.

defer_boundary_box_creation, if set to true, will suppress the construction of the boundary boxes.

◆ PatchLevel() [3/3]

template<int DIM>
SAMRAI::hier::PatchLevel< DIM >::PatchLevel ( tbox::Pointer< tbox::Database level_database,
tbox::Pointer< GridGeometry< DIM > >  grid_geometry,
tbox::Pointer< PatchDescriptor< DIM > >  descriptor,
tbox::Pointer< PatchFactory< DIM > >  factory,
ComponentSelector  component_selector = ComponentSelector(false),
bool  defer_boundary_box_creation = false 
)

Construct a new patch level from the specified PatchLevel database.
The box, mapping, and ratio to level zero data which are normally passed in during the construction of a new patch level are retrieved from the specified database. The component_selector argument specifies which patch data components should be allocated and read in from the level_database. By default, all bits in the component selector are set to false so that no patch data are allocated.

When assertion checking is turned on, the level_database, grid_geometry, and descriptor are checked to make sure that they are not null.

defer_boundary_box_creation, if set to true, will suppress the construction of the boundary boxes.

◆ ~PatchLevel()

template<int DIM>
virtual SAMRAI::hier::PatchLevel< DIM >::~PatchLevel ( )
virtual

The virtual destructor for patch level deallocates all patches.

Member Function Documentation

◆ getLevelNumber()

template<int DIM>
int SAMRAI::hier::PatchLevel< DIM >::getLevelNumber ( ) const

Return the number of this level in a hierarchy, or the number of a hierarchy level matching the index space of this level. If this level does not align with the index space of a level in the hierarchy, then this value is -1. When the level is in a hierarchy, the return value os the number of the level in the hierarchy. See member function inHierarchy() below.

◆ setLevelNumber()

template<int DIM>
void SAMRAI::hier::PatchLevel< DIM >::setLevelNumber ( const int  l)

Set the number of this level to the level in the hierarchy aligning with the index space of this level. The default value is -1 meaning the level index space doesn't align with that of any hierarchy level.

◆ getNextCoarserHierarchyLevelNumber()

template<int DIM>
int SAMRAI::hier::PatchLevel< DIM >::getNextCoarserHierarchyLevelNumber ( ) const

Return the number of the next coarser level in a hierarchy for the purposes of data interpolation from coarser levels. If the level is in a hierarchy, then this value is getLevelNumber() - 1. See member function inHierarchy() below.

◆ setNextCoarserHierarchyLevelNumber()

template<int DIM>
void SAMRAI::hier::PatchLevel< DIM >::setNextCoarserHierarchyLevelNumber ( const int  l)

Set the number of of the next coarser level in a hierarchy for the purposes of data interpolation from coarser levels. The default is -1 meaning the level doesn't relate to any hierarchy.

◆ inHierarchy()

template<int DIM>
bool SAMRAI::hier::PatchLevel< DIM >::inHierarchy ( ) const

Return true when this level resides in a hierarchy and false otherwise.

◆ setLevelInHierarchy()

template<int DIM>
void SAMRAI::hier::PatchLevel< DIM >::setLevelInHierarchy ( bool  in_hierarchy)

Set to true if this level resides in a hierarchy; false otherwise. The default setting is false.

◆ getNumberOfPatches()

template<int DIM>
int SAMRAI::hier::PatchLevel< DIM >::getNumberOfPatches ( ) const

Return the total number of patches on the level.

◆ getPatch()

template<int DIM>
tbox::Pointer< Patch<DIM> > SAMRAI::hier::PatchLevel< DIM >::getPatch ( const int  p) const

Return a pointer to the specified patch on the level. The patches are numbered starting at zero.

◆ getPatchDescriptor()

template<int DIM>
tbox::Pointer< PatchDescriptor<DIM> > SAMRAI::hier::PatchLevel< DIM >::getPatchDescriptor ( ) const

Return pointer to the patch descriptor for the level.

◆ getPatchFactory()

template<int DIM>
tbox::Pointer< PatchFactory<DIM> > SAMRAI::hier::PatchLevel< DIM >::getPatchFactory ( ) const

Return the factory object used to created patches in the level.

◆ getGridGeometry()

template<int DIM>
tbox::Pointer< GridGeometry<DIM> > SAMRAI::hier::PatchLevel< DIM >::getGridGeometry ( ) const

Return the grid geometry description.

◆ setRefinedPatchLevel()

template<int DIM>
void SAMRAI::hier::PatchLevel< DIM >::setRefinedPatchLevel ( const tbox::Pointer< hier::PatchLevel< DIM > >  coarse_level,
const hier::IntVector< DIM > &  refine_ratio,
const tbox::Pointer< hier::GridGeometry< DIM > >  fine_grid_geometry = NULL,
bool  defer_boundary_box_creation = false 
)

◆ setCoarsenedPatchLevel()

template<int DIM>
void SAMRAI::hier::PatchLevel< DIM >::setCoarsenedPatchLevel ( const tbox::Pointer< hier::PatchLevel< DIM > >  fine_level,
const hier::IntVector< DIM > &  coarsen_ratio,
const tbox::Pointer< hier::GridGeometry< DIM > >  coarse_grid_geom = NULL,
bool  defer_boundary_box_creation = false 
)

Set data members of this patch level by coarsening information on given fine level by the given ratio between the two levels. The coarse level will cover the same physical space as the fine level and will have the same number of patches with the same mapping of those patches to processors. However, the index space of the level will be coarsened by the specified ratio.

If the coarse grid geometry is null (default case), then it is assumed that this level is to use the same grid geometry as the given fine level and the ratio to level zero is set relative to the given fine level. Otherwise, we use the given grid geometry (assumed to be a proper coarsening of the grid geometry used on the given fine level) and copy ratio to level zero from given fine level. In other words, the function can be used to produce two different results. First, when passed a null grid geometry pointer, the coarsened patch level can be used for data exchange operations with the AMR hierarchy in which the fine level resides – both levels are defined with respect to the index space of the grid geometry object which they share. Thus, the coarsened patch level can be used in data exchanges with the AMR hierarchy of the fine level automatically. Second, when passed a non-null coarse grid geometry pointer, the level is defined relative to that geometry and the coarsened patch level cannot be used in data exchanges with the AMR hierarchy of the fine level automatically in general. This mode is used to construct a coarsened copy of an entire patch hierarchy, typically.

◆ setBoundaryBoxes()

template<int DIM>
void SAMRAI::hier::PatchLevel< DIM >::setBoundaryBoxes ( )

Create and store the boundary boxes for this level, if they do not already exist. If they have already been construction, this function does nothing. If the level is constructed with boundary box creation deferred, this method must be called before any attempt at filling data at physical boundaries. This function is called from xfer::RefineSchedule<DIM> prior to any physical boundary operations.

◆ getPhysicalDomain()

template<int DIM>
const BoxArray<DIM>& SAMRAI::hier::PatchLevel< DIM >::getPhysicalDomain ( ) const

Return a const reference to the box array that defines the extent of the index space on the level.

◆ getBoxes()

template<int DIM>
const BoxArray<DIM>& SAMRAI::hier::PatchLevel< DIM >::getBoxes ( ) const

Return a const reference to the box array that defines the patches on the level.

◆ getShiftsForLevel()

template<int DIM>
const tbox::Array< tbox::List< IntVector<DIM> > >& SAMRAI::hier::PatchLevel< DIM >::getShiftsForLevel ( ) const

Return a const reference to the shift array for the patches on the level; the shift array contains a list of shift vectors for each patch when the domain has some periodic direction.

◆ getProcessorMapping()

template<int DIM>
const ProcessorMapping& SAMRAI::hier::PatchLevel< DIM >::getProcessorMapping ( ) const

Return a const reference to the mapping of patches to processors.

◆ getRatio()

template<int DIM>
const IntVector<DIM>& SAMRAI::hier::PatchLevel< DIM >::getRatio ( ) const

Return a const reference to the vector ratio between the index space of this patch level and that of a reference level in AMR hierarchy (typically, level zero). Specifically, this is the ratio passed to the constructor.

◆ getRatioToCoarserLevel()

template<int DIM>
const IntVector<DIM>& SAMRAI::hier::PatchLevel< DIM >::getRatioToCoarserLevel ( ) const

Return the vector ratio between this level and the next coarser level in the patch hierarchy. This vector is set with the setRatioToCoarserLevel() function. If the level is not in a hierarchy, a default ratio of zero is returned.

◆ setRatioToCoarserLevel()

template<int DIM>
void SAMRAI::hier::PatchLevel< DIM >::setRatioToCoarserLevel ( const IntVector< DIM > &  ratio)

Set the vector ratio between this level and the next coarser level in the patch hierarchy. This is required only when level resides in a hierarchy.

◆ getMappingForPatch()

template<int DIM>
int SAMRAI::hier::PatchLevel< DIM >::getMappingForPatch ( const int  p) const

Return the processor that owns the specified patch. The patches are numbered starting at zero.

◆ getBoxForPatch()

template<int DIM>
const Box<DIM>& SAMRAI::hier::PatchLevel< DIM >::getBoxForPatch ( const int  p) const

Return the box for the specified patch. The patches are numbered starting at zero.

◆ getShiftsForPatch()

template<int DIM>
const tbox::List< IntVector<DIM> >& SAMRAI::hier::PatchLevel< DIM >::getShiftsForPatch ( const int  p) const

Return the list of valid periodic shifts for the specified patch. The patches are numbered starting at zero.

◆ patchTouchesRegularBoundary()

template<int DIM>
bool SAMRAI::hier::PatchLevel< DIM >::patchTouchesRegularBoundary ( const int  p) const

Return true if patch with given number is adjacent to a non-periodic physical domain boundary. Otherwise, return false.

◆ patchTouchesPeriodicBoundary()

template<int DIM>
bool SAMRAI::hier::PatchLevel< DIM >::patchTouchesPeriodicBoundary ( const int  p) const

Return true if patch with given number is adjacent to a periodic physical domain boundary. Otherwise, return false.

◆ allocatePatchData() [1/2]

template<int DIM>
void SAMRAI::hier::PatchLevel< DIM >::allocatePatchData ( const int  id,
const double  timestamp = 0.0,
tbox::Pointer< tbox::Arena pool = NULL 
)

Allocate the specified component on all patches. If no memory arena is specified, then the standard memory arena will be used.

◆ allocatePatchData() [2/2]

template<int DIM>
void SAMRAI::hier::PatchLevel< DIM >::allocatePatchData ( const ComponentSelector components,
const double  timestamp = 0.0,
tbox::Pointer< tbox::Arena pool = NULL 
)

Allocate the specified components on all patches. If no memory arena is specified, then the standard memory arena will be used.

◆ checkAllocated()

template<int DIM>
bool SAMRAI::hier::PatchLevel< DIM >::checkAllocated ( const int  id) const

Check whether the specified patch data index has been allocated. This function will return true if (1) there are no patches in this patch level or (2) all of the patches have allocated the patch data component.

◆ deallocatePatchData() [1/2]

template<int DIM>
void SAMRAI::hier::PatchLevel< DIM >::deallocatePatchData ( const int  id)

Deallocate the specified component on all patches. This component will need to be reallocated before its next use.

◆ deallocatePatchData() [2/2]

template<int DIM>
void SAMRAI::hier::PatchLevel< DIM >::deallocatePatchData ( const ComponentSelector components)

Deallocate the specified components on all patches. These components will need to be reallocated before their next use.

◆ setTime() [1/3]

template<int DIM>
void SAMRAI::hier::PatchLevel< DIM >::setTime ( const double  timestamp,
const int  id 
)

Set the simulation time for the specified patch component.

◆ setTime() [2/3]

template<int DIM>
void SAMRAI::hier::PatchLevel< DIM >::setTime ( const double  timestamp,
const ComponentSelector components 
)

Set the simulation time for the specified patch components.

◆ setTime() [3/3]

template<int DIM>
void SAMRAI::hier::PatchLevel< DIM >::setTime ( const double  timestamp)

Set the simulation time for all allocated patch components.

◆ getFromDatabase()

template<int DIM>
void SAMRAI::hier::PatchLevel< DIM >::getFromDatabase ( tbox::Pointer< tbox::Database database,
ComponentSelector  component_selector 
)

Uses the PatchLevel database to set the state of the PatchLevel and to create all patches on the local processor.

Assertions: check that database is a non-null Pointer, that the data being retrieved from the database are of the type expected, that the number of patches is positive, that the number of patches and size of processor mapping array are the same, and that the number of patches and the number of boxes on the level are equal.

◆ putToDatabase()

template<int DIM>
void SAMRAI::hier::PatchLevel< DIM >::putToDatabase ( tbox::Pointer< tbox::Database database,
const ComponentSelector patchdata_write_table 
)

Writes the data from the PatchLevel to the database.
Also tells all local patches to write out their state to the database. The patchdata_write_table specifies which patchdata are to be written to the database.

Assertions: check that database is a non-null Pointer.

◆ recursivePrint()

template<int DIM>
int SAMRAI::hier::PatchLevel< DIM >::recursivePrint ( std::ostream &  os,
const std::string &  border = std::string(),
unsigned short  depth = 0 
)

If depth>0, print function will be called for each patch in the level.

◆ getBoxGraph()

template<int DIM>
tbox::Pointer< BoxGraph<DIM> > SAMRAI::hier::PatchLevel< DIM >::getBoxGraph ( )

Returns pointer to a BoxGraph graph object that was constructed using only boxes on this level.

◆ getBoxTop()

template<int DIM>
tbox::Pointer< BoxTop<DIM> > SAMRAI::hier::PatchLevel< DIM >::getBoxTop ( )

Returns pointer to a BoxTop object that was constructed using boxes on this level.

◆ getBoxTree()

template<int DIM>
tbox::Pointer< BoxTree<DIM> > SAMRAI::hier::PatchLevel< DIM >::getBoxTree ( )

Returns pointer to a BoxTree object that was constructed using boxes on this level.

◆ getBinaryTree()

template<int DIM>
tbox::Pointer< BinaryTree<DIM> > SAMRAI::hier::PatchLevel< DIM >::getBinaryTree ( )

Returns pointer to BinaryTree

◆ setPatchTouchesBoundaryArrays()

template<int DIM>
void SAMRAI::hier::PatchLevel< DIM >::setPatchTouchesBoundaryArrays ( )
private

◆ initializeTimers()

template<int DIM>
static void SAMRAI::hier::PatchLevel< DIM >::initializeTimers ( )
staticprivate

Allocate static timers.

◆ freeTimers()

template<int DIM>
static void SAMRAI::hier::PatchLevel< DIM >::freeTimers ( )
staticprivate

Free static timers.

To be called by shutdown registry to make sure memory for timers does not leak.

Member Data Documentation

◆ d_boxes

template<int DIM>
BoxArray<DIM> SAMRAI::hier::PatchLevel< DIM >::d_boxes
private

◆ d_mapping

template<int DIM>
ProcessorMapping SAMRAI::hier::PatchLevel< DIM >::d_mapping
private

◆ d_ratio_to_level_zero

template<int DIM>
IntVector<DIM> SAMRAI::hier::PatchLevel< DIM >::d_ratio_to_level_zero
private

◆ d_geometry

template<int DIM>
tbox::Pointer< GridGeometry<DIM> > SAMRAI::hier::PatchLevel< DIM >::d_geometry
private

◆ d_descriptor

template<int DIM>
tbox::Pointer< PatchDescriptor<DIM> > SAMRAI::hier::PatchLevel< DIM >::d_descriptor
private

◆ d_factory

template<int DIM>
tbox::Pointer< PatchFactory<DIM> > SAMRAI::hier::PatchLevel< DIM >::d_factory
private

◆ d_number_patches

template<int DIM>
int SAMRAI::hier::PatchLevel< DIM >::d_number_patches
private

◆ d_physical_domain

template<int DIM>
BoxArray<DIM> SAMRAI::hier::PatchLevel< DIM >::d_physical_domain
private

◆ d_ratio_to_coarser_level

template<int DIM>
IntVector<DIM> SAMRAI::hier::PatchLevel< DIM >::d_ratio_to_coarser_level
private

◆ d_level_number

template<int DIM>
int SAMRAI::hier::PatchLevel< DIM >::d_level_number
private

◆ d_next_coarser_level_number

template<int DIM>
int SAMRAI::hier::PatchLevel< DIM >::d_next_coarser_level_number
private

◆ d_in_hierarchy

template<int DIM>
bool SAMRAI::hier::PatchLevel< DIM >::d_in_hierarchy
private

◆ d_patches

template<int DIM>
tbox::Array< tbox::Pointer< Patch<DIM> > > SAMRAI::hier::PatchLevel< DIM >::d_patches
private

◆ d_patch_touches_regular_boundary

template<int DIM>
tbox::Array<bool> SAMRAI::hier::PatchLevel< DIM >::d_patch_touches_regular_boundary
private

◆ d_patch_touches_periodic_boundary

template<int DIM>
tbox::Array<bool> SAMRAI::hier::PatchLevel< DIM >::d_patch_touches_periodic_boundary
private

◆ d_shifts

template<int DIM>
tbox::Array< tbox::List< IntVector<DIM> > > SAMRAI::hier::PatchLevel< DIM >::d_shifts
private

◆ d_boundary_boxes_created

template<int DIM>
bool SAMRAI::hier::PatchLevel< DIM >::d_boundary_boxes_created
private

◆ d_box_graph

template<int DIM>
tbox::Pointer< BoxGraph<DIM> > SAMRAI::hier::PatchLevel< DIM >::d_box_graph
private

◆ d_box_top

template<int DIM>
tbox::Pointer< BoxTop<DIM> > SAMRAI::hier::PatchLevel< DIM >::d_box_top
private

◆ d_box_tree

template<int DIM>
tbox::Pointer< BoxTree<DIM> > SAMRAI::hier::PatchLevel< DIM >::d_box_tree
private

◆ d_binary_tree

template<int DIM>
tbox::Pointer< BinaryTree<DIM> > SAMRAI::hier::PatchLevel< DIM >::d_binary_tree
private

◆ t_level_constructor

template<int DIM>
tbox::Pointer<tbox::Timer> SAMRAI::hier::PatchLevel< DIM >::t_level_constructor
staticprivate

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