|
| 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 |
|
virtual RT | getAScalar () const =0 |
|
virtual RT | getBScalar () const =0 |
|
virtual MF const * | getACoeffs (int amrlev, int mglev) const =0 |
|
virtual Array< MF const *, AMREX_SPACEDIM > | getBCoeffs (int amrlev, int mglev) const =0 |
|
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...
|
|
| 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< RT > | getSolvabilityOffset (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...
|
|
virtual void | Fapply (int amrlev, int mglev, MF &out, const MF &in) const =0 |
|
virtual void | Fsmooth (int amrlev, int mglev, MF &sol, const MF &rhs, int redblack) const =0 |
|
virtual void | FFlux (int amrlev, const MFIter &mfi, const Array< FAB *, AMREX_SPACEDIM > &flux, const FAB &sol, Location loc, int face_only=0) const =0 |
|
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 |
|
| 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 | getNComp () const |
| Return number of components. More...
|
|
virtual int | getNGrow (int=0, int=0) const |
|
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 | 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 bool | isSingular (int amrlev) const =0 |
| Is it singular on given AMR level? More...
|
|
virtual bool | isBottomSingular () const =0 |
| Is the bottom of MG singular? More...
|
|
virtual std::unique_ptr< MLLinOpT< MF > > | makeNLinOp (int) const |
|
virtual bool | supportNSolve () const |
|
virtual void | copyNSolveSolution (MF &, MF const &) const |
|
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 Geometry & | Geom (int amr_lev, int mglev=0) const noexcept |
|