|
| MLNodeLinOp () |
|
| ~MLNodeLinOp () override=default |
|
| MLNodeLinOp (const MLNodeLinOp &)=delete |
|
| MLNodeLinOp (MLNodeLinOp &&)=delete |
|
MLNodeLinOp & | operator= (const MLNodeLinOp &)=delete |
|
MLNodeLinOp & | operator= (MLNodeLinOp &&)=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< FArrayBox > const * > &a_factory={}, int a_eb_limit_coarsening=-1) |
|
void | setSmoothNumSweeps (int nsweeps) noexcept |
|
void | setLevelBC (int, const MultiFab *, const MultiFab *=nullptr, const MultiFab *=nullptr, const MultiFab *=nullptr) final |
|
void | apply (int amrlev, int mglev, MultiFab &out, MultiFab &in, BCMode bc_mode, StateMode s_mode, const MLMGBndry *bndry=nullptr) const final |
|
void | smooth (int amrlev, int mglev, MultiFab &sol, const MultiFab &rhs, bool skip_fillboundary=false) const override |
|
void | solutionResidual (int amrlev, MultiFab &resid, MultiFab &x, const MultiFab &b, const MultiFab *crse_bcdata=nullptr) override |
|
void | correctionResidual (int amrlev, int mglev, MultiFab &resid, MultiFab &x, const MultiFab &b, BCMode bc_mode, const MultiFab *crse_bcdata=nullptr) override |
|
Vector< Real > | getSolvabilityOffset (int amrlev, int mglev, MultiFab const &rhs) const override |
|
void | fixSolvabilityByOffset (int amrlev, int mglev, MultiFab &rhs, Vector< Real > const &offset) const override |
|
void | prepareForSolve () override |
|
void | prepareForGMRES () override |
|
void | setDirichletNodesToZero (int amrlev, int mglev, MultiFab &mf) const 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...
|
|
Real | xdoty (int amrlev, int mglev, const MultiFab &x, const MultiFab &y, bool local) const final |
|
virtual void | applyBC (int amrlev, int mglev, MultiFab &phi, BCMode bc_mode, StateMode state_mode, bool skip_fillboundary=false) const |
|
virtual void | Fapply (int amrlev, int mglev, MultiFab &out, const MultiFab &in) const =0 |
|
virtual void | Fsmooth (int amrlev, int mglev, MultiFab &sol, const MultiFab &rhs) const =0 |
|
void | nodalSync (int amrlev, int mglev, MultiFab &mf) const |
|
void | buildMasks () |
|
void | setOversetMask (int amrlev, const iMultiFab &a_dmask) |
|
virtual void | fixUpResidualMask (int, iMultiFab &) |
|
Real | normInf (int amrlev, MultiFab const &mf, bool local) const override |
|
void | avgDownResAmr (int, MultiFab &, MultiFab const &) const final |
|
void | interpolationAmr (int famrlev, MultiFab &fine, const MultiFab &crse, IntVect const &nghost) const override |
|
void | averageDownAndSync (Vector< MultiFab > &sol) const override |
|
void | interpAssign (int amrlev, int fmglev, MultiFab &fine, MultiFab &crse) const override |
|
| 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 |
|
virtual void | setLevelBC (int, const MF *, const MF *=nullptr, const MF *=nullptr, const MF *=nullptr)=0 |
| Set boundary conditions for given level. For cell-centered solves only. More...
|
|
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 | getNComp () const |
| Return number of components. More...
|
|
virtual int | getNGrow (int=0, int=0) const |
|
virtual bool | needsUpdate () const |
| Does it need update if it's reused? More...
|
|
virtual void | update () |
| Update for reuse. More...
|
|
virtual void | restriction (int amrlev, int cmglev, MF &crse, MF &fine) const =0 |
| Restriction onto coarse MG level. More...
|
|
virtual void | interpolation (int amrlev, int fmglev, MF &fine, const MF &crse) const =0 |
| Add interpolated coarse MG level data to fine MG level data. More...
|
|
virtual void | interpAssign (int amrlev, int fmglev, MF &fine, MF &crse) const |
| Overwrite fine MG level data with interpolated coarse data. More...
|
|
virtual void | interpolationAmr (int famrlev, MF &fine, const MF &crse, IntVect const &nghost) const |
| Interpolation between AMR levels. More...
|
|
virtual void | averageDownSolutionRHS (int camrlev, MF &crse_sol, MF &crse_rhs, const MF &fine_sol, const MF &fine_rhs) |
| Average-down data from fine AMR level to coarse AMR level. More...
|
|
virtual void | apply (int amrlev, int mglev, MF &out, MF &in, BCMode bc_mode, StateMode s_mode, const MLMGBndryT< MF > *bndry=nullptr) const =0 |
| Apply the linear operator, out = L(in) More...
|
|
virtual void | smooth (int amrlev, int mglev, MF &sol, const MF &rhs, bool skip_fillboundary=false) const =0 |
| Smooth. More...
|
|
virtual void | normalize (int amrlev, int mglev, MF &mf) const |
| Divide mf by the diagonal component of the operator. Used by bicgstab. More...
|
|
virtual void | solutionResidual (int amrlev, MF &resid, MF &x, const MF &b, const MF *crse_bcdata=nullptr)=0 |
| Compute residual for solution. More...
|
|
virtual void | prepareForFluxes (int, const MF *=nullptr) |
|
virtual void | correctionResidual (int amrlev, int mglev, MF &resid, MF &x, const MF &b, BCMode bc_mode, const MF *crse_bcdata=nullptr)=0 |
| Compute residual for the residual-correction form, resid = b - L(x) More...
|
|
virtual void | reflux (int crse_amrlev, MF &res, const MF &crse_sol, const MF &crse_rhs, MF &fine_res, MF &fine_sol, const MF &fine_rhs) const |
| Reflux at AMR coarse/fine boundary. More...
|
|
virtual void | compFlux (int, const Array< MF *, AMREX_SPACEDIM > &, MF &, Location) const |
| Compute fluxes. More...
|
|
virtual void | compGrad (int, const Array< MF *, AMREX_SPACEDIM > &, MF &, Location) const |
| Compute gradients of the solution. More...
|
|
virtual void | applyMetricTerm (int, int, MF &) const |
| apply metric terms if there are any More...
|
|
virtual void | unapplyMetricTerm (int, int, MF &) const |
| unapply metric terms if there are any More...
|
|
virtual void | unimposeNeumannBC (int, MF &) const |
| This is needed for our nodal projection solver. More...
|
|
virtual void | applyInhomogNeumannTerm (int, MF &) const |
| Extra terms introduced when we treat inhomogeneous Nuemann BC as homogeneous. More...
|
|
virtual void | applyOverset (int, MF &) const |
| for overset solver only More...
|
|
virtual void | scaleRHS (int, MF &) const |
| scale RHS to fix solvability More...
|
|
virtual Vector< RT > | getSolvabilityOffset (int, int, MF const &) const |
| get offset for fixing solvability More...
|
|
virtual void | fixSolvabilityByOffset (int, int, MF &, Vector< RT > const &) const |
| fix solvability by subtracting offset from RHS More...
|
|
virtual void | setDirichletNodesToZero (int, int, MF &) const |
|
virtual RT | xdoty (int amrlev, int mglev, const MF &x, const MF &y, bool local) const =0 |
| x dot y, used by the bottom solver More...
|
|
virtual std::unique_ptr< MLLinOpT< MF > > | makeNLinOp (int) const |
|
virtual void | getFluxes (const Vector< Array< MF *, AMREX_SPACEDIM > > &, const Vector< MF * > &, Location) const |
|
virtual void | getFluxes (const Vector< MF * > &, const Vector< MF * > &) const |
|
virtual bool | supportNSolve () const |
|
virtual void | copyNSolveSolution (MF &, MF const &) const |
|
virtual void | postSolve (Vector< MF > &) const |
|
virtual RT | normInf (int amrlev, MF const &mf, bool local) const =0 |
|
virtual void | averageDownAndSync (Vector< MF > &sol) const =0 |
|
virtual void | avgDownResAmr (int clev, MF &cres, MF const &fres) 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 Geometry & | Geom (int amr_lev, int mglev=0) const noexcept |
|