WarpX
Public Member Functions | Protected Member Functions | Protected Attributes | List of all members
Diagnostics Class Referenceabstract

base class for diagnostics. Contains main routines to filter, compute and flush diagnostics. More...

#include <Diagnostics.H>

Inheritance diagram for Diagnostics:
BTDiagnostics BoundaryScrapingDiagnostics FullDiagnostics

Public Member Functions

 Diagnostics (int i, std::string name)
 
virtual ~Diagnostics ()
 
 Diagnostics (Diagnostics const &)=delete
 
Diagnosticsoperator= (Diagnostics const &)=delete
 
 Diagnostics (Diagnostics &&)=default
 
Diagnosticsoperator= (Diagnostics &&)=default
 
void ComputeAndPack ()
 
virtual void Flush (int i_buffer, bool force_flush)=0
 Flush particle and field buffers to file using the FlushFormat member variable. More...
 
void InitData ()
 
void InitDataBeforeRestart ()
 
void InitDataAfterRestart ()
 
virtual void InitializeFieldFunctors (int lev)=0
 
virtual void InitializeFieldFunctorsRZopenPMD ([[maybe_unused]] int lev)
 
virtual void InitializeParticleFunctors ()
 
virtual bool DoComputeAndPack (int step, bool force_flush=false)=0
 
virtual bool DoDump (int step, int i_buffer, bool force_flush=false)=0
 
void NewIteration ()
 
void FilterComputePackFlush (int step, bool force_flush=false)
 
bool DoDumpLastTimestep () const
 
int getnumbuffers () const
 
virtual amrex::Real gettlab ([[maybe_unused]] int i_buffer)
 
virtual void settlab ([[maybe_unused]] int i_buffer, [[maybe_unused]] amrex::Real tlab)
 
virtual int get_buffer_k_index_hi ([[maybe_unused]] int i_buffer)
 
virtual void set_buffer_k_index_hi ([[maybe_unused]] int i_buffer, [[maybe_unused]] int kindex)
 
virtual amrex::Real get_snapshot_domain_lo ([[maybe_unused]] int i_buffer, [[maybe_unused]] int idim)
 
virtual amrex::Real get_snapshot_domain_hi ([[maybe_unused]] int i_buffer, [[maybe_unused]] int idim)
 
void setSnapshotDomainLo (int i_buffer, int idim, amrex::Real domain_lab_lo)
 
void setSnapshotDomainHi (int i_buffer, int idim, amrex::Real domain_lab_hi)
 
virtual int get_flush_counter ([[maybe_unused]] int i_buffer)
 
virtual void set_flush_counter ([[maybe_unused]] int i_buffer, [[maybe_unused]] int flush_counter)
 
virtual int get_last_valid_Zslice ([[maybe_unused]] int i_buffer)
 
virtual void set_last_valid_Zslice ([[maybe_unused]] int i_buffer, [[maybe_unused]] int last_valid_Zslice)
 
virtual int get_snapshot_full_flag ([[maybe_unused]] int i_buffer)
 
virtual void set_snapshot_full ([[maybe_unused]] int i_buffer, [[maybe_unused]] int snapshot_full)
 

Protected Member Functions

bool BaseReadParameters ()
 
void InitBaseData ()
 
virtual void InitializeBufferData (int i_buffer, int lev, bool restart=false)=0
 
virtual void DerivedInitData ()
 
virtual void InitializeParticleBuffer ()=0
 
virtual void PrepareBufferData ()
 
virtual void UpdateBufferData ()
 
virtual void PrepareFieldDataForOutput ()
 
virtual void PrepareParticleDataForOutput ()
 
virtual void MovingWindowAndGalileanDomainShift (int step)
 

Protected Attributes

std::string m_diag_name
 
std::string m_file_prefix
 
int m_file_min_digits = 6
 
int m_diag_index
 
amrex::Vector< std::string > m_varnames
 
amrex::Vector< std::string > m_varnames_fields
 
amrex::Vector< std::string > m_pfield_varnames
 
std::vector< std::string > m_pfield_species
 
std::vector< bool > m_pfield_do_average
 
std::vector< intm_pfield_species_index
 
std::vector< std::string > m_pfield_strings
 
std::vector< bool > m_pfield_dofilter
 
std::vector< std::string > m_pfield_filter_strings
 
bool m_dump_last_timestep = true
 
std::string m_format = "plotfile"
 
int m_already_done = false
 
std::unique_ptr< FlushFormatm_flush_format
 
amrex::Vector< amrex::Vector< amrex::MultiFab > > m_mf_output
 
amrex::Vector< amrex::Vector< amrex::Geometry > > m_geom_output
 
int nlev
 
int nmax_lev
 
int nlev_output
 
std::vector< std::string > m_output_species_names
 
std::vector< std::string > m_all_species_names
 
amrex::Vector< amrex::Vector< ParticleDiag > > m_output_species
 
amrex::Vector< amrex::Vector< std::unique_ptr< ComputeDiagFunctor > > > m_all_field_functors
 
amrex::IntVect m_crse_ratio = amrex::IntVect(1)
 
amrex::Vector< amrex::Real > m_lo
 
amrex::Vector< amrex::Real > m_hi
 
int m_num_buffers
 
amrex::Vector< intm_rho_per_species_index
 
amrex::Vector< amrex::Vector< std::unique_ptr< PinnedMemoryParticleContainer > > > m_particles_buffer
 
amrex::Vector< std::unique_ptr< ComputeParticleDiagFunctor > > m_all_particle_functors
 
amrex::Vector< amrex::Vector< int > > m_totalParticles_in_buffer
 
amrex::Vector< amrex::RealBoxm_snapshot_domain_lab
 

Detailed Description

base class for diagnostics. Contains main routines to filter, compute and flush diagnostics.

Each specific diagnostics derives from this class.

Constructor & Destructor Documentation

◆ Diagnostics() [1/3]

Diagnostics::Diagnostics ( int  i,
std::string  name 
)

Constructor

Parameters
iindex of diagnostics in MultiDiagnostics::alldiags
namediagnostics name in the inputs file

◆ ~Diagnostics()

Diagnostics::~Diagnostics ( )
virtualdefault

Virtual Destructor to handle clean destruction of derived classes

◆ Diagnostics() [2/3]

Diagnostics::Diagnostics ( Diagnostics const &  )
delete

◆ Diagnostics() [3/3]

Diagnostics::Diagnostics ( Diagnostics &&  )
default

Member Function Documentation

◆ BaseReadParameters()

bool Diagnostics::BaseReadParameters ( )
protected

Read Parameters of the base Diagnostics class

◆ ComputeAndPack()

void Diagnostics::ComputeAndPack ( )

Pack (stack) all fields in the cell-centered output MultiFab m_mf_output.

Fields are computed (e.g., cell-centered or back-transformed) on-the-fly using a functor.

◆ DerivedInitData()

virtual void Diagnostics::DerivedInitData ( )
inlineprotectedvirtual

Initialize member variables and arrays specific to the diagnostics in the derived classes.(FullDiagnostics, BTDiagnostics)

Reimplemented in BTDiagnostics.

◆ DoComputeAndPack()

virtual bool Diagnostics::DoComputeAndPack ( int  step,
bool  force_flush = false 
)
pure virtual

whether to compute and pack data in output buffers at this time step

Parameters
[in]stepcurrent time step
[in]force_flushif true, return true for any step
Returns
bool, whether to compute and pack data

Implemented in FullDiagnostics, BTDiagnostics, and BoundaryScrapingDiagnostics.

◆ DoDump()

virtual bool Diagnostics::DoDump ( int  step,
int  i_buffer,
bool  force_flush = false 
)
pure virtual

whether to flush at this time step

Parameters
[in]stepcurrent time step
[in]i_bufferindex of the buffer data to be flushed.
[in]force_flushif true, return true for any step
Returns
bool, whether to flush

Implemented in FullDiagnostics, BTDiagnostics, and BoundaryScrapingDiagnostics.

◆ DoDumpLastTimestep()

bool Diagnostics::DoDumpLastTimestep ( ) const
inline

Whether the last timestep is always dumped

◆ FilterComputePackFlush()

void Diagnostics::FilterComputePackFlush ( int  step,
bool  force_flush = false 
)

Perform necessary operations with user-defined diagnostic parameters to filter (coarsen, slice), compute (cell-center, back-transform), and flush the output data stored in buffers, m_mf_output.

Parameters
[in]stepcurrent timestep
[in]force_flushused to force-fully write data stored in buffers.

◆ Flush()

virtual void Diagnostics::Flush ( int  i_buffer,
bool  force_flush 
)
pure virtual

Flush particle and field buffers to file using the FlushFormat member variable.

This function should belong to class Diagnostics and not be virtual, as it flushes the particle buffers (name not found yet) and the field buffers (m_mf_output), both of which are members of Diagnostics. Yet, the implementation is left to derived classes for now because:

  • The functions underlying FlushFormat::WriteToFile expect a geometry object, which is WarpX::geom for FullDiagnostics but should be constructed for BTDiagnostics;
  • The functions underlying FlushFormat::WriteToFile do not support writing a buffer to file multiple times yet. When these are fixed, the implementation of Flush should be in Diagnostics.cpp
    Parameters
    [in]i_bufferindex of the buffer data to be flushed.
    [in]force_flushonly used for BTD, whether to do a complete flush of the data (including metadata listing the total number of particles) even if the snapshot is incomplete

Implemented in FullDiagnostics, BoundaryScrapingDiagnostics, and BTDiagnostics.

◆ get_buffer_k_index_hi()

virtual int Diagnostics::get_buffer_k_index_hi ( [[maybe_unused] ] int  i_buffer)
inlinevirtual

Returns k-index in big end of the buffer box currently being filled for the ith snapshot in BTD

Parameters
[in]i_bufferindex of the buffer

◆ get_flush_counter()

virtual int Diagnostics::get_flush_counter ( [[maybe_unused] ] int  i_buffer)
inlinevirtual

Returns counter for the number of times buffer data for the ith snapshot has been flushed

Parameters
[in]i_bufferindex of the buffer

◆ get_last_valid_Zslice()

virtual int Diagnostics::get_last_valid_Zslice ( [[maybe_unused] ] int  i_buffer)
inlinevirtual

Returns 0/1 if the last valid Zslice for the ith snapshot has been filled (1) or not(0)

Parameters
[in]i_bufferindex of the buffer

◆ get_snapshot_domain_hi()

virtual amrex::Real Diagnostics::get_snapshot_domain_hi ( [[maybe_unused] ] int  i_buffer,
[[maybe_unused] ] int  idim 
)
inlinevirtual

Returns hi-end of the lab-frame physical domain for the ith snapshot in BTD

Parameters
[in]i_bufferindex of the buffer
[in]idimdimension along which the hi-end of the lab-frame physical domain is returned

◆ get_snapshot_domain_lo()

virtual amrex::Real Diagnostics::get_snapshot_domain_lo ( [[maybe_unused] ] int  i_buffer,
[[maybe_unused] ] int  idim 
)
inlinevirtual

Returns lo-end of the lab-frame physical domain for the ith snapshot in BTD

Parameters
[in]i_bufferindex of the buffer
[in]idimdimension along which the lo-end of the lab-frame physical domain is returned

◆ get_snapshot_full_flag()

virtual int Diagnostics::get_snapshot_full_flag ( [[maybe_unused] ] int  i_buffer)
inlinevirtual

Returns 0/1 if the snapshot is fully filled and BTD for that snapshot is complete(1) or not(0)

Parameters
[in]i_bufferindex of the buffer

◆ getnumbuffers()

int Diagnostics::getnumbuffers ( ) const
inline

Returns the number of snapshots used in BTD. For Full-Diagnostics, the value is 1

◆ gettlab()

virtual amrex::Real Diagnostics::gettlab ( [[maybe_unused] ] int  i_buffer)
inlinevirtual

Time in lab-frame associated with the ith snapshot

Parameters
[in]i_bufferindex of the buffer

◆ InitBaseData()

void Diagnostics::InitBaseData ( )
protected

Initialize member variables of the base Diagnostics class.

◆ InitData()

void Diagnostics::InitData ( )

Initialize pointers to main fields and allocate output multifab m_mf_output.

◆ InitDataAfterRestart()

void Diagnostics::InitDataAfterRestart ( )

◆ InitDataBeforeRestart()

void Diagnostics::InitDataBeforeRestart ( )

◆ InitializeBufferData()

virtual void Diagnostics::InitializeBufferData ( int  i_buffer,
int  lev,
bool  restart = false 
)
protectedpure virtual

Initialize m_mf_output vectors and data required to construct the buffers

Parameters
[in]i_bufferindex of buffer for which the output MultiFab is defined.
[in]levlevel on which the output MultiFab is defined

Implemented in FullDiagnostics, BTDiagnostics, and BoundaryScrapingDiagnostics.

◆ InitializeFieldFunctors()

virtual void Diagnostics::InitializeFieldFunctors ( int  lev)
pure virtual

Initialize functors that store pointers to the fields requested by the user.

Derived classes MUST implement this function, and it must allocate m_all_field_functors and fill it with ComputeDiagFunctor objects. The functions is called at initialization and when the domain is decomposed during the simulation to load-balance.

Parameters
[in]levlevel on which the vector of unique_ptrs to field functors is initialized.

Implemented in FullDiagnostics, BTDiagnostics, and BoundaryScrapingDiagnostics.

◆ InitializeFieldFunctorsRZopenPMD()

virtual void Diagnostics::InitializeFieldFunctorsRZopenPMD ( [[maybe_unused] ] int  lev)
inlinevirtual

Initialize functors that store pointers to the fields requested by the user.

The function is called at initialization and when the domain is decomposed during the simulation to load-balance.

Parameters
[in]levlevel on which the vector of unique_ptrs to field functors is initialized.

◆ InitializeParticleBuffer()

virtual void Diagnostics::InitializeParticleBuffer ( )
protectedpure virtual

This function initialized particle buffers (not implemented in diagnostics, yet)

Implemented in FullDiagnostics, BTDiagnostics, and BoundaryScrapingDiagnostics.

◆ InitializeParticleFunctors()

virtual void Diagnostics::InitializeParticleFunctors ( )
inlinevirtual

Initialize functors that store pointers to the species data requested by the user.

Reimplemented in BTDiagnostics.

◆ MovingWindowAndGalileanDomainShift()

virtual void Diagnostics::MovingWindowAndGalileanDomainShift ( int  step)
inlineprotectedvirtual

Update the physical extent of the diagnostic domain for moving window and galilean shift simulations

Parameters
[in]stepcurrent time step

Reimplemented in FullDiagnostics.

◆ NewIteration()

void Diagnostics::NewIteration ( )
inline

Start a new iteration, i.e., dump has not been done yet.

◆ operator=() [1/2]

Diagnostics& Diagnostics::operator= ( Diagnostics &&  )
default

◆ operator=() [2/2]

Diagnostics& Diagnostics::operator= ( Diagnostics const &  )
delete

◆ PrepareBufferData()

virtual void Diagnostics::PrepareBufferData ( )
inlineprotectedvirtual

This function prepares buffer data as required for fields and particles. For back-transformed diagnostics, this function prepares the z coordinate in the boosted-frame and lab-frame.

Reimplemented in BTDiagnostics.

◆ PrepareFieldDataForOutput()

virtual void Diagnostics::PrepareFieldDataForOutput ( )
inlineprotectedvirtual

Prepare data (either fill-boundary or cell-centered data for back-transform diagnostics) to be processed for diagnostics.

Reimplemented in FullDiagnostics, and BTDiagnostics.

◆ PrepareParticleDataForOutput()

virtual void Diagnostics::PrepareParticleDataForOutput ( )
inlineprotectedvirtual

The Particle Geometry, BoxArray, and RealBox are set for the lab-frame output

Reimplemented in FullDiagnostics, and BTDiagnostics.

◆ set_buffer_k_index_hi()

virtual void Diagnostics::set_buffer_k_index_hi ( [[maybe_unused] ] int  i_buffer,
[[maybe_unused] ] int  kindex 
)
inlinevirtual

Set k-index of the buffer in the moving window direction currently being filled for the ith snapshot

Parameters
[in]i_bufferindex of the buffer
[in]kindexvalue used to set the k-index for the big end of the buffer box

◆ set_flush_counter()

virtual void Diagnostics::set_flush_counter ( [[maybe_unused] ] int  i_buffer,
[[maybe_unused] ] int  flush_counter 
)
inlinevirtual

Sets counter for the number of times buffer data for the ith snapshot has been flushed to parameter input in the function

Parameters
[in]i_bufferindex of the buffer
[in]flush_countervalue of the counter

◆ set_last_valid_Zslice()

virtual void Diagnostics::set_last_valid_Zslice ( [[maybe_unused] ] int  i_buffer,
[[maybe_unused] ] int  last_valid_Zslice 
)
inlinevirtual

Sets if the last valid Zslice for the ith snapshot has been filled (1) or not(0) with input parameter last_Valid_Zslice

Parameters
[in]i_bufferindex of the buffer
[in]last_valid_Zslicevalue to set m_lastValidZSlice in BTD for the ith snapshot (i_buffer)

◆ set_snapshot_full()

virtual void Diagnostics::set_snapshot_full ( [[maybe_unused] ] int  i_buffer,
[[maybe_unused] ] int  snapshot_full 
)
inlinevirtual

Sets the value for m_snapshot_full for the ith snapshot in BTD using parameter snapshot_full

Parameters
[in]i_bufferindex of the buffer
[in]snapshot_fullvalue to set m_snapshot_full in BTD for the ith snapshot (i_buffer)

◆ setSnapshotDomainHi()

void Diagnostics::setSnapshotDomainHi ( int  i_buffer,
int  idim,
amrex::Real  domain_lab_hi 
)
inline

Sets hi-end of the lab-frame physical domain for the ith snapshot in BTD

Parameters
[in]i_bufferindex of the buffer
[in]idimdimension along which the hi-end of the lab-frame physical domain is set
[in]domain_lab_hivalue of the hi-end of the lab-frame physical domain for the ith snapshot

◆ setSnapshotDomainLo()

void Diagnostics::setSnapshotDomainLo ( int  i_buffer,
int  idim,
amrex::Real  domain_lab_lo 
)
inline

Sets lo-end of the lab-frame physical domain for the ith snapshot in BTD

Parameters
[in]i_bufferindex of the buffer
[in]idimdimension along which the lo-end of the lab-frame physical domain is set
[in]domain_lab_lovalue of the lo-end of the lab-frame physical domain for the ith snapshot

◆ settlab()

virtual void Diagnostics::settlab ( [[maybe_unused] ] int  i_buffer,
[[maybe_unused] ] amrex::Real  tlab 
)
inlinevirtual

Set time in lab-frame for the ith snapshot

Parameters
[in]i_bufferindex of the buffer
[in]tlabvalue used to set the lab-frame time for the ith buffer

◆ UpdateBufferData()

virtual void Diagnostics::UpdateBufferData ( )
inlineprotectedvirtual

This function updates buffer data and computes the number of buffers filled in the output multifab as well as identifies if the last buffer has been filled as needed to close the output files.

Reimplemented in BTDiagnostics.

Member Data Documentation

◆ m_all_field_functors

amrex::Vector< amrex::Vector <std::unique_ptr<ComputeDiagFunctor > > > Diagnostics::m_all_field_functors
protected

Vector of (pointers to) functors to compute output fields, per level, per component. This allows for simple operations (averaging to cell-center for standard EB fields) as well as more involved operations (back-transformed diagnostics, filtering, reconstructing cartesian fields in cylindrical).

◆ m_all_particle_functors

amrex::Vector< std::unique_ptr<ComputeParticleDiagFunctor> > Diagnostics::m_all_particle_functors
protected

Vector of pointers to functors to compute particle output per species

◆ m_all_species_names

std::vector< std::string > Diagnostics::m_all_species_names
protected

Names of all species in the simulation

◆ m_already_done

int Diagnostics::m_already_done = false
protected

Whether this iteration has already been dumped, to avoid writing data twice

◆ m_crse_ratio

amrex::IntVect Diagnostics::m_crse_ratio = amrex::IntVect(1)
protected

Coarsening ratio such that, fields are averaged to the coarsened grid. The ratio should render the grid to be coarsenable (as defined by AMReX).

◆ m_diag_index

int Diagnostics::m_diag_index
protected

Index of diagnostics in MultiDiagnostics::alldiags

◆ m_diag_name

std::string Diagnostics::m_diag_name
protected

Name of diagnostics: runtime parameter given in the input file.

◆ m_dump_last_timestep

bool Diagnostics::m_dump_last_timestep = true
protected

If true, a dump is performed at the last timestep regardless of the required dump timesteps

◆ m_file_min_digits

int Diagnostics::m_file_min_digits = 6
protected

Minimum number of digits to iteration number in file name

◆ m_file_prefix

std::string Diagnostics::m_file_prefix
protected

Prefix for output directories

◆ m_flush_format

std::unique_ptr<FlushFormat> Diagnostics::m_flush_format
protected

This class is responsible for flushing the data to file

◆ m_format

std::string Diagnostics::m_format = "plotfile"
protected

format for output files, "plotfile" or "openpmd" or "sensei" or "ascent" The checkpoint format is applicable for FullDiagnostics only.

◆ m_geom_output

amrex::Vector< amrex::Vector <amrex::Geometry> > Diagnostics::m_geom_output
protected

Geometry that defines the domain attributes corresponding to output multifab. Specifically, the user-defined physical co-ordinates for the diagnostics is used to construct the geometry information for each MultiFab at the respective levels. This geometry will be used to write out plotfile data using the WriteToFile() function

◆ m_hi

amrex::Vector< amrex::Real> Diagnostics::m_hi
protected

Higher corner of the diagnostics output, in physical coordinates

◆ m_lo

amrex::Vector< amrex::Real> Diagnostics::m_lo
protected

Lower corner of the diagnostics output, in physical coordinates

◆ m_mf_output

amrex::Vector< amrex::Vector< amrex::MultiFab > > Diagnostics::m_mf_output
protected

output multifab, where all fields are computed (cell-centered or back-transformed) and stacked. The first vector is for total number of snapshots. (=1 for FullDiagnostics) The second vector is loops over the total number of levels.

◆ m_num_buffers

int Diagnostics::m_num_buffers
protected

Number of output buffers. The value is set to 1 for all FullDiagnostics

◆ m_output_species

amrex::Vector< amrex::Vector< ParticleDiag> > Diagnostics::m_output_species
protected

The first vector is for total number of snapshots. (=1 for FullDiagnostics) The second vector handles output for 1 species

◆ m_output_species_names

std::vector< std::string > Diagnostics::m_output_species_names
protected

Names of species to write to output

◆ m_particles_buffer

amrex::Vector< amrex::Vector<std::unique_ptr<PinnedMemoryParticleContainer> > > Diagnostics::m_particles_buffer
protected

Vector of particle buffer vectors for each snapshot

◆ m_pfield_do_average

std::vector< bool > Diagnostics::m_pfield_do_average
protected

Whether to do averaging for each of the particle field diagnostics

◆ m_pfield_dofilter

std::vector< bool> Diagnostics::m_pfield_dofilter
protected

Whether to use a filter function on particles before calculating particle field diagnostics

◆ m_pfield_filter_strings

std::vector< std::string > Diagnostics::m_pfield_filter_strings
protected

List of parser strings for pre-average filtering for the particle field diagnostics

◆ m_pfield_species

std::vector< std::string > Diagnostics::m_pfield_species
protected

Names of species for which to output particle field diagnostics

◆ m_pfield_species_index

std::vector< int > Diagnostics::m_pfield_species_index
protected

Species indices corresponding to elements of m_pfield_varnames

◆ m_pfield_strings

std::vector< std::string > Diagnostics::m_pfield_strings
protected

List of the parser strings for the particle field diagnostics

◆ m_pfield_varnames

amrex::Vector< std::string > Diagnostics::m_pfield_varnames
protected

Names of particle field properties to output

◆ m_rho_per_species_index

amrex::Vector<int> Diagnostics::m_rho_per_species_index
protected

Array of species indices that dump rho per species

◆ m_snapshot_domain_lab

amrex::Vector<amrex::RealBox> Diagnostics::m_snapshot_domain_lab
protected

Vector of user-defined physical region for diagnostics in lab-frame for each back-transformed snapshot

◆ m_totalParticles_in_buffer

amrex::Vector< amrex::Vector <int> > Diagnostics::m_totalParticles_in_buffer
protected

Vector of total number of particles in the buffer, per species, per snapshot. The first vector is for total number of snapshots and second vector loops over the total number of species selected for diagnostics.

◆ m_varnames

amrex::Vector< std::string > Diagnostics::m_varnames
protected

Names of each component requested by the user. The list is appended with the average particle fields, if used. In cylindrical geometry, this list is also appended with automatically-constructed names for all modes of all fields.

◆ m_varnames_fields

amrex::Vector< std::string > Diagnostics::m_varnames_fields
protected

Names of plotfile fields requested by the user

◆ nlev

int Diagnostics::nlev
protected

number of levels to output

◆ nlev_output

int Diagnostics::nlev_output
protected

Number of levels to be output

◆ nmax_lev

int Diagnostics::nmax_lev
protected

max_level to allocate output multifab and vector of field functors.


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