Block-Structured AMR Software Framework
amrex::MLABecLaplacianT< MF > Class Template Reference

#include <AMReX_MLABecLaplacian.H>

Inheritance diagram for amrex::MLABecLaplacianT< MF >:
amrex::MLCellABecLapT< MF > amrex::MLCellLinOpT< MF > amrex::MLLinOpT< MF > amrex::MLTensorOp

Public Types

using FAB = typename MF::fab_type
 
using RT = typename MF::value_type
 
using BCType = LinOpBCType
 
using Location = typename MLLinOpT< MF >::Location
 
- Public Types inherited from amrex::MLCellABecLapT< MF >
using FAB = typename MF::fab_type
 
using RT = typename MF::value_type
 
using Location = typename MLLinOpT< MF >::Location
 
- Public Types inherited from amrex::MLCellLinOpT< MF >
using FAB = typename MF::fab_type
 
using RT = typename MF::value_type
 
using BCType = LinOpBCType
 
using BCMode = typename MLLinOpT< MF >::BCMode
 
using StateMode = typename MLLinOpT< MF >::StateMode
 
using Location = typename MLLinOpT< MF >::Location
 
- Public Types inherited from amrex::MLLinOpT< MF >
using MFType = MF
 
using FAB = typename FabDataType< MF >::fab_type
 
using RT = typename FabDataType< MF >::value_type
 
using BCType = LinOpBCType
 
using BCMode = LinOpEnumType::BCMode
 
using StateMode = LinOpEnumType::StateMode
 
using Location = LinOpEnumType::Location
 

Public Member Functions

 MLABecLaplacianT ()=default
 
 MLABecLaplacianT (const Vector< Geometry > &a_geom, const Vector< BoxArray > &a_grids, const Vector< DistributionMapping > &a_dmap, const LPInfo &a_info=LPInfo(), const Vector< FabFactory< FAB > const * > &a_factory={}, int a_ncomp=1)
 
 MLABecLaplacianT (const Vector< Geometry > &a_geom, const Vector< BoxArray > &a_grids, const Vector< DistributionMapping > &a_dmap, const Vector< iMultiFab const * > &a_overset_mask, const LPInfo &a_info=LPInfo(), const Vector< FabFactory< FAB > const * > &a_factory={}, int a_ncomp=1)
 
 ~MLABecLaplacianT () override
 
 MLABecLaplacianT (const MLABecLaplacianT< MF > &)=delete
 
 MLABecLaplacianT (MLABecLaplacianT< MF > &&)=delete
 
MLABecLaplacianT< MF > & operator= (const MLABecLaplacianT< MF > &)=delete
 
MLABecLaplacianT< MF > & operator= (MLABecLaplacianT< MF > &&)=delete
 
void define (const Vector< Geometry > &a_geom, const Vector< BoxArray > &a_grids, const Vector< DistributionMapping > &a_dmap, const LPInfo &a_info=LPInfo(), const Vector< FabFactory< FAB > const * > &a_factory={}, int a_ncomp=1)
 
void define (const Vector< Geometry > &a_geom, const Vector< BoxArray > &a_grids, const Vector< DistributionMapping > &a_dmap, const Vector< iMultiFab const * > &a_overset_mask, const LPInfo &a_info=LPInfo(), const Vector< FabFactory< FAB > const * > &a_factory={}, int a_ncomp=1)
 
template<typename T1 , typename T2 , std::enable_if_t< std::is_convertible_v< T1, typename MF::value_type > &&std::is_convertible_v< T2, typename MF::value_type >, int > = 0>
void setScalars (T1 a, T2 b) noexcept
 
template<typename AMF , std::enable_if_t< IsFabArray< AMF >::value &&std::is_convertible_v< typename AMF::value_type, typename MF::value_type >, int > = 0>
void setACoeffs (int amrlev, const AMF &alpha)
 
template<typename T , std::enable_if_t< std::is_convertible_v< T, typename MF::value_type >, int > = 0>
void setACoeffs (int amrlev, T alpha)
 
template<typename AMF , std::enable_if_t< IsFabArray< AMF >::value &&std::is_convertible_v< typename AMF::value_type, typename MF::value_type >, int > = 0>
void setBCoeffs (int amrlev, const Array< AMF const *, AMREX_SPACEDIM > &beta)
 
template<typename T , std::enable_if_t< std::is_convertible_v< T, typename MF::value_type >, int > = 0>
void setBCoeffs (int amrlev, T beta)
 
template<typename T , std::enable_if_t< std::is_convertible_v< T, typename MF::value_type >, int > = 0>
void setBCoeffs (int amrlev, Vector< T > const &beta)
 
int getNComp () const override
 Return number of components. More...
 
bool needsUpdate () const override
 Does it need update if it's reused? More...
 
void update () override
 Update for reuse. More...
 
void prepareForSolve () override
 
bool isSingular (int amrlev) const override
 Is it singular on given AMR level? More...
 
bool isBottomSingular () const override
 Is the bottom of MG singular? More...
 
void Fapply (int amrlev, int mglev, MF &out, const MF &in) const final
 
void Fsmooth (int amrlev, int mglev, MF &sol, const MF &rhs, int redblack) const final
 
void FFlux (int amrlev, const MFIter &mfi, const Array< FAB *, AMREX_SPACEDIM > &flux, const FAB &sol, Location, int face_only=0) const final
 
void normalize (int amrlev, int mglev, MF &mf) const final
 Divide mf by the diagonal component of the operator. Used by bicgstab. More...
 
RT getAScalar () const final
 
RT getBScalar () const final
 
MF const * getACoeffs (int amrlev, int mglev) const final
 
Array< MF const *, AMREX_SPACEDIM > getBCoeffs (int amrlev, int mglev) const final
 
std::unique_ptr< MLLinOpT< MF > > makeNLinOp (int) const final
 
bool supportNSolve () const final
 
void copyNSolveSolution (MF &dst, MF const &src) const final
 
void averageDownCoeffsSameAmrLevel (int amrlev, Vector< MF > &a, Vector< Array< MF, AMREX_SPACEDIM > > &b)
 
void averageDownCoeffs ()
 
void averageDownCoeffsToCoarseAmrLevel (int flev)
 
void applyMetricTermsCoeffs ()
 
void applyRobinBCTermsCoeffs ()
 
- Public Member Functions inherited from amrex::MLCellABecLapT< MF >
 MLCellABecLapT ()=default
 
 ~MLCellABecLapT () override=default
 
 MLCellABecLapT (const MLCellABecLapT< MF > &)=delete
 
 MLCellABecLapT (MLCellABecLapT< MF > &&)=delete
 
MLCellABecLapT< MF > & operator= (const MLCellABecLapT< MF > &)=delete
 
MLCellABecLapT< MF > & operator= (MLCellABecLapT< MF > &&)=delete
 
void define (const Vector< Geometry > &a_geom, const Vector< BoxArray > &a_grids, const Vector< DistributionMapping > &a_dmap, const LPInfo &a_info=LPInfo(), const Vector< FabFactory< FAB > const * > &a_factory={})
 
void define (const Vector< Geometry > &a_geom, const Vector< BoxArray > &a_grids, const Vector< DistributionMapping > &a_dmap, const Vector< iMultiFab const * > &a_overset_mask, const LPInfo &a_info=LPInfo(), const Vector< FabFactory< FAB > const * > &a_factory={})
 
iMultiFab const * getOversetMask (int amrlev, int mglev) const
 
bool needsUpdate () const override
 Does it need update if it's reused? More...
 
void update () override
 Update for reuse. More...
 
void prepareForSolve () override
 
void setDirichletNodesToZero (int amrlev, int mglev, MF &mf) const override
 
void getFluxes (const Vector< Array< MF *, AMREX_SPACEDIM > > &a_flux, const Vector< MF * > &a_sol, Location a_loc) const final
 
void getFluxes (const Vector< MF * > &, const Vector< MF * > &) const final
 
void applyInhomogNeumannTerm (int amrlev, MF &rhs) const final
 Extra terms introduced when we treat inhomogeneous Nuemann BC as homogeneous. More...
 
void addInhomogNeumannFlux (int amrlev, const Array< MF *, AMREX_SPACEDIM > &grad, MF const &sol, bool mult_bcoef) const final
 
void applyOverset (int amrlev, MF &rhs) const override
 for overset solver only More...
 
- Public Member Functions inherited from amrex::MLCellLinOpT< MF >
 MLCellLinOpT ()
 
 ~MLCellLinOpT () override=default
 
 MLCellLinOpT (const MLCellLinOpT< MF > &)=delete
 
 MLCellLinOpT (MLCellLinOpT< MF > &&)=delete
 
MLCellLinOpT< MF > & operator= (const MLCellLinOpT< MF > &)=delete
 
MLCellLinOpT< MF > & operator= (MLCellLinOpT< MF > &&)=delete
 
void define (const Vector< Geometry > &a_geom, const Vector< BoxArray > &a_grids, const Vector< DistributionMapping > &a_dmap, const LPInfo &a_info=LPInfo(), const Vector< FabFactory< FAB > const * > &a_factory={})
 
void setLevelBC (int amrlev, const MF *levelbcdata, const MF *robinbc_a=nullptr, const MF *robinbc_b=nullptr, const MF *robinbc_f=nullptr) final
 Set boundary conditions for given level. For cell-centered solves only. More...
 
bool needsUpdate () const override
 Does it need update if it's reused? More...
 
void update () override
 Update for reuse. More...
 
void setGaussSeidel (bool flag) noexcept
 
virtual bool isCrossStencil () const
 
virtual bool isTensorOp () const
 
void updateSolBC (int amrlev, const MF &crse_bcdata) const
 
void updateCorBC (int amrlev, const MF &crse_bcdata) const
 
virtual void applyBC (int amrlev, int mglev, MF &in, BCMode bc_mode, StateMode s_mode, const MLMGBndryT< MF > *bndry=nullptr, bool skip_fillboundary=false) const
 
BoxArray makeNGrids (int grid_size) const
 
void restriction (int, int, MF &crse, MF &fine) const override
 Restriction onto coarse MG level. More...
 
void interpolation (int amrlev, int fmglev, MF &fine, const MF &crse) const override
 Add interpolated coarse MG level data to fine MG level data. More...
 
void interpAssign (int amrlev, int fmglev, MF &fine, MF &crse) const override
 Overwrite fine MG level data with interpolated coarse data. More...
 
void interpolationAmr (int famrlev, MF &fine, const MF &crse, IntVect const &nghost) const override
 Interpolation between AMR levels. More...
 
void averageDownSolutionRHS (int camrlev, MF &crse_sol, MF &crse_rhs, const MF &fine_sol, const MF &fine_rhs) override
 Average-down data from fine AMR level to coarse AMR level. More...
 
void apply (int amrlev, int mglev, MF &out, MF &in, BCMode bc_mode, StateMode s_mode, const MLMGBndryT< MF > *bndry=nullptr) const override
 Apply the linear operator, out = L(in) More...
 
void smooth (int amrlev, int mglev, MF &sol, const MF &rhs, bool skip_fillboundary=false) const final
 Smooth. More...
 
void solutionResidual (int amrlev, MF &resid, MF &x, const MF &b, const MF *crse_bcdata=nullptr) override
 Compute residual for solution. More...
 
void prepareForFluxes (int amrlev, const MF *crse_bcdata=nullptr) override
 
void correctionResidual (int amrlev, int mglev, MF &resid, MF &x, const MF &b, BCMode bc_mode, const MF *crse_bcdata=nullptr) final
 Compute residual for the residual-correction form, resid = b - L(x) More...
 
void reflux (int crse_amrlev, MF &res, const MF &crse_sol, const MF &, MF &, MF &fine_sol, const MF &) const final
 Reflux at AMR coarse/fine boundary. More...
 
void compFlux (int amrlev, const Array< MF *, AMREX_SPACEDIM > &fluxes, MF &sol, Location loc) const override
 Compute fluxes. More...
 
void compGrad (int amrlev, const Array< MF *, AMREX_SPACEDIM > &grad, MF &sol, Location loc) const override
 Compute gradients of the solution. More...
 
void applyMetricTerm (int amrlev, int mglev, MF &rhs) const final
 apply metric terms if there are any More...
 
void unapplyMetricTerm (int amrlev, int mglev, MF &rhs) const final
 unapply metric terms if there are any More...
 
Vector< RTgetSolvabilityOffset (int amrlev, int mglev, MF const &rhs) const override
 get offset for fixing solvability More...
 
void fixSolvabilityByOffset (int amrlev, int mglev, MF &rhs, Vector< RT > const &offset) const override
 
void prepareForSolve () override
 
RT xdoty (int amrlev, int mglev, const MF &x, const MF &y, bool local) const final
 x dot y, used by the bottom solver More...
 
RT normInf (int amrlev, MF const &mf, bool local) const override
 
void averageDownAndSync (Vector< MF > &sol) const override
 
void avgDownResAmr (int clev, MF &cres, MF const &fres) const override
 
- Public Member Functions inherited from amrex::MLLinOpT< MF >
 MLLinOpT ()=default
 
virtual ~MLLinOpT ()=default
 
 MLLinOpT (const MLLinOpT< MF > &)=delete
 
 MLLinOpT (MLLinOpT< MF > &&)=delete
 
MLLinOpT< MF > & operator= (const MLLinOpT< MF > &)=delete
 
MLLinOpT< MF > & operator= (MLLinOpT< MF > &&)=delete
 
void define (const Vector< Geometry > &a_geom, const Vector< BoxArray > &a_grids, const Vector< DistributionMapping > &a_dmap, const LPInfo &a_info, const Vector< FabFactory< FAB > const * > &a_factory, bool eb_limit_coarsening=true)
 
virtual std::string name () const
 
void setDomainBC (const Array< BCType, AMREX_SPACEDIM > &lobc, const Array< BCType, AMREX_SPACEDIM > &hibc) noexcept
 Boundary of the whole domain. More...
 
void setDomainBC (const Vector< Array< BCType, AMREX_SPACEDIM > > &lobc, const Vector< Array< BCType, AMREX_SPACEDIM > > &hibc) noexcept
 Boundary of the whole domain. More...
 
void setDomainBCLoc (const Array< Real, AMREX_SPACEDIM > &lo_bcloc, const Array< Real, AMREX_SPACEDIM > &hi_bcloc) noexcept
 Set location of domain boundaries. More...
 
bool needsCoarseDataForBC () const noexcept
 Needs coarse data for bc? More...
 
void setCoarseFineBC (const MF *crse, int crse_ratio, LinOpBCType bc_type=LinOpBCType::Dirichlet) noexcept
 Set coarse/fine boundary conditions. For cell-centered solves only. More...
 
void setCoarseFineBC (const MF *crse, IntVect const &crse_ratio, LinOpBCType bc_type=LinOpBCType::Dirichlet) noexcept
 
template<typename AMF , std::enable_if_t<!std::is_same_v< MF, AMF >, int > = 0>
void setCoarseFineBC (const AMF *crse, int crse_ratio, LinOpBCType bc_type=LinOpBCType::Dirichlet) noexcept
 
template<typename AMF , std::enable_if_t<!std::is_same_v< MF, AMF >, int > = 0>
void setCoarseFineBC (const AMF *crse, IntVect const &crse_ratio, LinOpBCType bc_type=LinOpBCType::Dirichlet) noexcept
 
template<typename AMF , std::enable_if_t<!std::is_same_v< MF, AMF >, int > = 0>
void setLevelBC (int amrlev, const AMF *levelbcdata, const AMF *robinbc_a=nullptr, const AMF *robinbc_b=nullptr, const AMF *robinbc_f=nullptr)
 
void setVerbose (int v) noexcept
 Set verbosity. More...
 
void setMaxOrder (int o) noexcept
 Set order of interpolation at coarse/fine boundary. More...
 
int getMaxOrder () const noexcept
 Get order of interpolation at coarse/fine boundary. More...
 
void setEnforceSingularSolvable (bool o) noexcept
 
bool getEnforceSingularSolvable () const noexcept
 
virtual BottomSolver getDefaultBottomSolver () const
 
virtual int getNGrow (int=0, int=0) const
 
virtual void unimposeNeumannBC (int, MF &) const
 This is needed for our nodal projection solver. More...
 
virtual void scaleRHS (int, MF &) const
 scale RHS to fix solvability More...
 
virtual void fixSolvabilityByOffset (int, int, MF &, Vector< RT > const &) const
 fix solvability by subtracting offset from RHS More...
 
virtual void prepareForGMRES ()
 
virtual void postSolve (Vector< MF > &) const
 
virtual void avgDownResMG (int clev, MF &cres, MF const &fres) const
 
bool isMFIterSafe (int amrlev, int mglev1, int mglev2) const
 
int NAMRLevels () const noexcept
 Return the number of AMR levels. More...
 
int NMGLevels (int amrlev) const noexcept
 Return the number of MG levels at given AMR level. More...
 
const GeometryGeom (int amr_lev, int mglev=0) const noexcept
 

Static Public Member Functions

static void FFlux (Box const &box, Real const *dxinv, RT bscalar, Array< FAB const *, AMREX_SPACEDIM > const &bcoef, Array< FAB *, AMREX_SPACEDIM > const &flux, FAB const &sol, int face_only, int ncomp)
 

Public Attributes

RT m_a_scalar = std::numeric_limits<RT>::quiet_NaN()
 
RT m_b_scalar = std::numeric_limits<RT>::quiet_NaN()
 
Vector< Vector< MF > > m_a_coeffs
 
Vector< Vector< Array< MF, AMREX_SPACEDIM > > > m_b_coeffs
 
bool m_scalars_set = false
 
bool m_acoef_set = false
 
- Public Attributes inherited from amrex::MLCellLinOpT< MF >
Vector< std::unique_ptr< MF > > m_robin_bcval
 
- Public Attributes inherited from amrex::MLLinOpT< MF >
Vector< Array< BCType, AMREX_SPACEDIM > > m_lobc
 
Vector< Array< BCType, AMREX_SPACEDIM > > m_hibc
 
Vector< Array< BCType, AMREX_SPACEDIM > > m_lobc_orig
 
Vector< Array< BCType, AMREX_SPACEDIM > > m_hibc_orig
 

Protected Member Functions

bool supportRobinBC () const noexcept override
 
- Protected Member Functions inherited from amrex::MLCellABecLapT< MF >
bool supportInhomogNeumannBC () const noexcept override
 
- Protected Member Functions inherited from amrex::MLLinOpT< MF >
const Vector< int > & AMRRefRatio () const noexcept
 Return AMR refinement ratios. More...
 
int AMRRefRatio (int amr_lev) const noexcept
 Return AMR refinement ratio at given AMR level. More...
 
FabFactory< FAB > const * Factory (int amr_lev, int mglev=0) const noexcept
 
GpuArray< BCType, AMREX_SPACEDIM > LoBC (int icomp=0) const noexcept
 
GpuArray< BCType, AMREX_SPACEDIM > HiBC (int icomp=0) const noexcept
 
bool hasBC (BCType bct) const noexcept
 
bool hasInhomogNeumannBC () const noexcept
 
bool hasRobinBC () const noexcept
 
bool isBottomActive () const noexcept
 
MPI_Comm BottomCommunicator () const noexcept
 
MPI_Comm Communicator () const noexcept
 
void setCoarseFineBCLocation (const RealVect &cloc) noexcept
 
bool doAgglomeration () const noexcept
 
bool doConsolidation () const noexcept
 
bool doSemicoarsening () const noexcept
 
bool isCellCentered () const noexcept
 
virtual IntVect getNGrowVectRestriction () const
 
virtual void make (Vector< Vector< MF > > &mf, IntVect const &ng) const
 
virtual MF make (int amrlev, int mglev, IntVect const &ng) const
 
virtual MF makeAlias (MF const &mf) const
 
virtual MF makeCoarseMG (int amrlev, int mglev, IntVect const &ng) const
 
virtual MF makeCoarseAmr (int famrlev, IntVect const &ng) const
 
virtual std::unique_ptr< FabFactory< FAB > > makeFactory (int, int) const
 
virtual void resizeMultiGrid (int new_size)
 
bool hasHiddenDimension () const noexcept
 
int hiddenDirection () const noexcept
 
Box compactify (Box const &b) const noexcept
 
template<typename T >
Array4< T > compactify (Array4< T > const &a) const noexcept
 
template<typename T >
get_d0 (T const &dx, T const &dy, T const &) const noexcept
 
template<typename T >
get_d1 (T const &, T const &dy, T const &dz) const noexcept
 

Protected Attributes

bool m_needs_update = true
 
Vector< intm_is_singular
 
- Protected Attributes inherited from amrex::MLCellABecLapT< MF >
Vector< Vector< std::unique_ptr< iMultiFab > > > m_overset_mask
 
LPInfo m_lpinfo_arg
 
- Protected Attributes inherited from amrex::MLCellLinOpT< MF >
bool m_has_metric_term = false
 
Vector< std::unique_ptr< MLMGBndryT< MF > > > m_bndry_sol
 
Vector< std::unique_ptr< BndryRegisterT< MF > > > m_crse_sol_br
 
Vector< std::unique_ptr< MLMGBndryT< MF > > > m_bndry_cor
 
Vector< std::unique_ptr< BndryRegisterT< MF > > > m_crse_cor_br
 
Vector< Vector< std::unique_ptr< BndryCondLoc > > > m_bcondloc
 
Vector< Vector< BndryRegisterT< MF > > > m_undrrelxr
 
Vector< Vector< Array< MultiMask, 2 *AMREX_SPACEDIM > > > m_maskvals
 
Vector< std::unique_ptr< iMultiFab > > m_norm_fine_mask
 
Vector< YAFluxRegisterT< MF > > m_fluxreg
 
bool m_use_gauss_seidel = true
 
- Protected Attributes inherited from amrex::MLLinOpT< MF >
int mg_domain_min_width = 2
 
LPInfo info
 
int verbose = 0
 
int maxorder = 3
 
bool enforceSingularSolvable = true
 
int m_num_amr_levels = 0
 
Vector< intm_amr_ref_ratio
 
Vector< intm_num_mg_levels
 
const MLLinOpT< MF > * m_parent = nullptr
 
IntVect m_ixtype
 
bool m_do_agglomeration = false
 
bool m_do_consolidation = false
 
bool m_do_semicoarsening = false
 
Vector< IntVectmg_coarsen_ratio_vec
 
Vector< Vector< Geometry > > m_geom
 first Vector is for amr level and second is mg level More...
 
Vector< Vector< BoxArray > > m_grids
 
Vector< Vector< DistributionMapping > > m_dmap
 
Vector< Vector< std::unique_ptr< FabFactory< FAB > > > > m_factory
 
Vector< intm_domain_covered
 
MPI_Comm m_default_comm = MPI_COMM_NULL
 
MPI_Comm m_bottom_comm = MPI_COMM_NULL
 
std::unique_ptr< CommContainerm_raii_comm
 
Array< Real, AMREX_SPACEDIM > m_domain_bloc_lo {{AMREX_D_DECL(0._rt,0._rt,0._rt)}}
 
Array< Real, AMREX_SPACEDIM > m_domain_bloc_hi {{AMREX_D_DECL(0._rt,0._rt,0._rt)}}
 
bool m_needs_coarse_data_for_bc = false
 
LinOpBCType m_coarse_fine_bc_type = LinOpBCType::Dirichlet
 
IntVect m_coarse_data_crse_ratio = IntVect(-1)
 
RealVect m_coarse_bc_loc
 
const MF * m_coarse_data_for_bc = nullptr
 
MF m_coarse_data_for_bc_raii
 

Private Member Functions

void define_ab_coeffs ()
 
void update_singular_flags ()
 

Private Attributes

int m_ncomp = 1
 

Additional Inherited Members

- Protected Types inherited from amrex::MLCellLinOpT< MF >
using RealTuple = Array< RT, 2 *BL_SPACEDIM >
 
using BCTuple = Array< BoundCond, 2 *BL_SPACEDIM >
 
- Static Protected Attributes inherited from amrex::MLLinOpT< MF >
static constexpr int mg_coarsen_ratio = 2
 
static constexpr int mg_box_min_width = 2
 

Member Typedef Documentation

◆ BCType

template<typename MF >
using amrex::MLABecLaplacianT< MF >::BCType = LinOpBCType

◆ FAB

template<typename MF >
using amrex::MLABecLaplacianT< MF >::FAB = typename MF::fab_type

◆ Location

template<typename MF >
using amrex::MLABecLaplacianT< MF >::Location = typename MLLinOpT<MF>::Location

◆ RT

template<typename MF >
using amrex::MLABecLaplacianT< MF >::RT = typename MF::value_type

Constructor & Destructor Documentation

◆ MLABecLaplacianT() [1/5]

template<typename MF >
amrex::MLABecLaplacianT< MF >::MLABecLaplacianT ( )
default

◆ MLABecLaplacianT() [2/5]

template<typename MF >
amrex::MLABecLaplacianT< MF >::MLABecLaplacianT ( const Vector< Geometry > &  a_geom,
const Vector< BoxArray > &  a_grids,
const Vector< DistributionMapping > &  a_dmap,
const LPInfo a_info = LPInfo(),
const Vector< FabFactory< FAB > const * > &  a_factory = {},
int  a_ncomp = 1 
)

◆ MLABecLaplacianT() [3/5]

template<typename MF >
amrex::MLABecLaplacianT< MF >::MLABecLaplacianT ( const Vector< Geometry > &  a_geom,
const Vector< BoxArray > &  a_grids,
const Vector< DistributionMapping > &  a_dmap,
const Vector< iMultiFab const * > &  a_overset_mask,
const LPInfo a_info = LPInfo(),
const Vector< FabFactory< FAB > const * > &  a_factory = {},
int  a_ncomp = 1 
)

◆ ~MLABecLaplacianT()

template<typename MF >
amrex::MLABecLaplacianT< MF >::~MLABecLaplacianT ( )
overridedefault

◆ MLABecLaplacianT() [4/5]

template<typename MF >
amrex::MLABecLaplacianT< MF >::MLABecLaplacianT ( const MLABecLaplacianT< MF > &  )
delete

◆ MLABecLaplacianT() [5/5]

template<typename MF >
amrex::MLABecLaplacianT< MF >::MLABecLaplacianT ( MLABecLaplacianT< MF > &&  )
delete

Member Function Documentation

◆ applyMetricTermsCoeffs()

template<typename MF >
void amrex::MLABecLaplacianT< MF >::applyMetricTermsCoeffs

◆ applyRobinBCTermsCoeffs()

template<typename MF >
void amrex::MLABecLaplacianT< MF >::applyRobinBCTermsCoeffs

◆ averageDownCoeffs()

template<typename MF >
void amrex::MLABecLaplacianT< MF >::averageDownCoeffs

◆ averageDownCoeffsSameAmrLevel()

template<typename MF >
void amrex::MLABecLaplacianT< MF >::averageDownCoeffsSameAmrLevel ( int  amrlev,
Vector< MF > &  a,
Vector< Array< MF, AMREX_SPACEDIM > > &  b 
)

◆ averageDownCoeffsToCoarseAmrLevel()

template<typename MF >
void amrex::MLABecLaplacianT< MF >::averageDownCoeffsToCoarseAmrLevel ( int  flev)

◆ copyNSolveSolution()

template<typename MF >
void amrex::MLABecLaplacianT< MF >::copyNSolveSolution ( MF &  dst,
MF const &  src 
) const
finalvirtual

Reimplemented from amrex::MLLinOpT< MF >.

◆ define() [1/2]

template<typename MF >
void amrex::MLABecLaplacianT< MF >::define ( const Vector< Geometry > &  a_geom,
const Vector< BoxArray > &  a_grids,
const Vector< DistributionMapping > &  a_dmap,
const LPInfo a_info = LPInfo(),
const Vector< FabFactory< FAB > const * > &  a_factory = {},
int  a_ncomp = 1 
)

◆ define() [2/2]

template<typename MF >
void amrex::MLABecLaplacianT< MF >::define ( const Vector< Geometry > &  a_geom,
const Vector< BoxArray > &  a_grids,
const Vector< DistributionMapping > &  a_dmap,
const Vector< iMultiFab const * > &  a_overset_mask,
const LPInfo a_info = LPInfo(),
const Vector< FabFactory< FAB > const * > &  a_factory = {},
int  a_ncomp = 1 
)

◆ define_ab_coeffs()

template<typename MF >
void amrex::MLABecLaplacianT< MF >::define_ab_coeffs
private

◆ Fapply()

template<typename MF >
void amrex::MLABecLaplacianT< MF >::Fapply ( int  amrlev,
int  mglev,
MF &  out,
const MF &  in 
) const
finalvirtual

◆ FFlux() [1/2]

template<typename MF >
void amrex::MLABecLaplacianT< MF >::FFlux ( Box const &  box,
Real const *  dxinv,
RT  bscalar,
Array< FAB const *, AMREX_SPACEDIM > const &  bcoef,
Array< FAB *, AMREX_SPACEDIM > const &  flux,
FAB const &  sol,
int  face_only,
int  ncomp 
)
static

◆ FFlux() [2/2]

template<typename MF >
void amrex::MLABecLaplacianT< MF >::FFlux ( int  amrlev,
const MFIter mfi,
const Array< FAB *, AMREX_SPACEDIM > &  flux,
const FAB sol,
Location  ,
int  face_only = 0 
) const
finalvirtual

◆ Fsmooth()

template<typename MF >
void amrex::MLABecLaplacianT< MF >::Fsmooth ( int  amrlev,
int  mglev,
MF &  sol,
const MF &  rhs,
int  redblack 
) const
finalvirtual

◆ getACoeffs()

template<typename MF >
MF const* amrex::MLABecLaplacianT< MF >::getACoeffs ( int  amrlev,
int  mglev 
) const
inlinefinalvirtual

◆ getAScalar()

template<typename MF >
RT amrex::MLABecLaplacianT< MF >::getAScalar ( ) const
inlinefinalvirtual

◆ getBCoeffs()

template<typename MF >
Array<MF const*,AMREX_SPACEDIM> amrex::MLABecLaplacianT< MF >::getBCoeffs ( int  amrlev,
int  mglev 
) const
inlinefinalvirtual

◆ getBScalar()

template<typename MF >
RT amrex::MLABecLaplacianT< MF >::getBScalar ( ) const
inlinefinalvirtual

◆ getNComp()

template<typename MF >
int amrex::MLABecLaplacianT< MF >::getNComp ( ) const
inlineoverridevirtual

Return number of components.

Reimplemented from amrex::MLLinOpT< MF >.

Reimplemented in amrex::MLTensorOp.

◆ isBottomSingular()

template<typename MF >
bool amrex::MLABecLaplacianT< MF >::isBottomSingular ( ) const
inlineoverridevirtual

Is the bottom of MG singular?

Implements amrex::MLLinOpT< MF >.

Reimplemented in amrex::MLTensorOp.

◆ isSingular()

template<typename MF >
bool amrex::MLABecLaplacianT< MF >::isSingular ( int  amrlev) const
inlineoverridevirtual

Is it singular on given AMR level?

Implements amrex::MLLinOpT< MF >.

Reimplemented in amrex::MLTensorOp.

◆ makeNLinOp()

template<typename MF >
std::unique_ptr< MLLinOpT< MF > > amrex::MLABecLaplacianT< MF >::makeNLinOp ( int  ) const
finalvirtual

Reimplemented from amrex::MLLinOpT< MF >.

◆ needsUpdate()

template<typename MF >
bool amrex::MLABecLaplacianT< MF >::needsUpdate ( ) const
inlineoverridevirtual

Does it need update if it's reused?

Reimplemented from amrex::MLLinOpT< MF >.

Reimplemented in amrex::MLTensorOp.

◆ normalize()

template<typename MF >
void amrex::MLABecLaplacianT< MF >::normalize ( int  amrlev,
int  mglev,
MF &  mf 
) const
finalvirtual

Divide mf by the diagonal component of the operator. Used by bicgstab.

Reimplemented from amrex::MLLinOpT< MF >.

◆ operator=() [1/2]

template<typename MF >
MLABecLaplacianT<MF>& amrex::MLABecLaplacianT< MF >::operator= ( const MLABecLaplacianT< MF > &  )
delete

◆ operator=() [2/2]

template<typename MF >
MLABecLaplacianT<MF>& amrex::MLABecLaplacianT< MF >::operator= ( MLABecLaplacianT< MF > &&  )
delete

◆ prepareForSolve()

template<typename MF >
void amrex::MLABecLaplacianT< MF >::prepareForSolve
overridevirtual

Implements amrex::MLLinOpT< MF >.

Reimplemented in amrex::MLTensorOp.

◆ setACoeffs() [1/2]

template<typename MF >
template<typename AMF , std::enable_if_t< IsFabArray< AMF >::value &&std::is_convertible_v< typename AMF::value_type, typename MF::value_type >, int > >
void amrex::MLABecLaplacianT< MF >::setACoeffs ( int  amrlev,
const AMF &  alpha 
)

Sets alpha as a scalar field to values from a single component multifab.

Parameters
[in]amrlevThe level of the multifab for the solver, with amrlev = 0 always being the lowest level in the AMR hierarchy represented in the solve.
[in]alphaMultifab of alpha values.

◆ setACoeffs() [2/2]

template<typename MF >
template<typename T , std::enable_if_t< std::is_convertible_v< T, typename MF::value_type >, int > >
void amrex::MLABecLaplacianT< MF >::setACoeffs ( int  amrlev,
alpha 
)

Sets alpha as a single scalar constant value across the multifab.

Parameters
[in]amrlevThe level of the multifab for the solver, with amrlev = 0 always being the lowest level in the AMR hierarchy represented in the solve.
[in]alphaSingle scalar value to populate across multifab.

◆ setBCoeffs() [1/3]

template<typename MF >
template<typename AMF , std::enable_if_t< IsFabArray< AMF >::value &&std::is_convertible_v< typename AMF::value_type, typename MF::value_type >, int > >
void amrex::MLABecLaplacianT< MF >::setBCoeffs ( int  amrlev,
const Array< AMF const *, AMREX_SPACEDIM > &  beta 
)

Sets beta as a scalar field to be the values defined in the supplied multifabs (one for each space dimension).

Parameters
[in]amrlevThe level of the multifab for the solver, with amrlev = 0 always being the lowest level in the AMR hierarchy represented in the solve.
[in]betaArray of Multifabs of beta values.

◆ setBCoeffs() [2/3]

template<typename MF >
template<typename T , std::enable_if_t< std::is_convertible_v< T, typename MF::value_type >, int > >
void amrex::MLABecLaplacianT< MF >::setBCoeffs ( int  amrlev,
beta 
)

Sets beta as a single scalar constant value across the multifabs (one for each dimension).

Parameters
[in]amrlevThe level of the multifab for the solver, with amrlev = 0 always being the lowest level in the AMR hierarchy represented in the solve.
[in]betaSingle scalar value to populate across multifabs.

◆ setBCoeffs() [3/3]

template<typename MF >
template<typename T , std::enable_if_t< std::is_convertible_v< T, typename MF::value_type >, int > >
void amrex::MLABecLaplacianT< MF >::setBCoeffs ( int  amrlev,
Vector< T > const &  beta 
)

Set each beta component to a single scalar constant value corresponding to the respective component of the supplied vector.

Parameters
[in]amrlevThe level of the multifab for the solver, with amrlev = 0 always being the lowest level in the AMR hierarchy represented in the solve.
[in]betaVector of scalar constant values.

◆ setScalars()

template<typename MF >
template<typename T1 , typename T2 , std::enable_if_t< std::is_convertible_v< T1, typename MF::value_type > &&std::is_convertible_v< T2, typename MF::value_type >, int > >
void amrex::MLABecLaplacianT< MF >::setScalars ( T1  a,
T2  b 
)
noexcept

Set scalar constants A and B in the equation: (A \alpha - B \nabla \cdot \beta \nabla ) \phi = f for the Multi-Level AB Laplacian Solver.

◆ supportNSolve()

template<typename MF >
bool amrex::MLABecLaplacianT< MF >::supportNSolve
finalvirtual

Reimplemented from amrex::MLLinOpT< MF >.

◆ supportRobinBC()

template<typename MF >
bool amrex::MLABecLaplacianT< MF >::supportRobinBC ( ) const
inlineoverrideprotectedvirtualnoexcept

Reimplemented from amrex::MLLinOpT< MF >.

◆ update()

template<typename MF >
void amrex::MLABecLaplacianT< MF >::update
overridevirtual

Update for reuse.

Reimplemented from amrex::MLLinOpT< MF >.

Reimplemented in amrex::MLTensorOp.

◆ update_singular_flags()

template<typename MF >
void amrex::MLABecLaplacianT< MF >::update_singular_flags
private

Member Data Documentation

◆ m_a_coeffs

template<typename MF >
Vector<Vector<MF> > amrex::MLABecLaplacianT< MF >::m_a_coeffs

◆ m_a_scalar

template<typename MF >
RT amrex::MLABecLaplacianT< MF >::m_a_scalar = std::numeric_limits<RT>::quiet_NaN()

◆ m_acoef_set

template<typename MF >
bool amrex::MLABecLaplacianT< MF >::m_acoef_set = false

◆ m_b_coeffs

template<typename MF >
Vector<Vector<Array<MF,AMREX_SPACEDIM> > > amrex::MLABecLaplacianT< MF >::m_b_coeffs

◆ m_b_scalar

template<typename MF >
RT amrex::MLABecLaplacianT< MF >::m_b_scalar = std::numeric_limits<RT>::quiet_NaN()

◆ m_is_singular

template<typename MF >
Vector<int> amrex::MLABecLaplacianT< MF >::m_is_singular
protected

◆ m_ncomp

template<typename MF >
int amrex::MLABecLaplacianT< MF >::m_ncomp = 1
private

◆ m_needs_update

template<typename MF >
bool amrex::MLABecLaplacianT< MF >::m_needs_update = true
protected

◆ m_scalars_set

template<typename MF >
bool amrex::MLABecLaplacianT< MF >::m_scalars_set = false

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