|
| | MLTensorOp () |
| |
| | MLTensorOp (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={}) |
| |
| | MLTensorOp (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< FArrayBox > const * > &a_factory={}) |
| |
| | ~MLTensorOp () override=default |
| |
| | MLTensorOp (const MLTensorOp &)=delete |
| |
| | MLTensorOp (MLTensorOp &&)=delete |
| |
| MLTensorOp & | operator= (const MLTensorOp &)=delete |
| |
| MLTensorOp & | operator= (MLTensorOp &&)=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={}) |
| |
| 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< FArrayBox > const * > &a_factory={}) |
| |
| void | setShearViscosity (int amrlev, const Array< MultiFab const *, 3 > &eta) |
| |
| void | setShearViscosity (int amrlev, Real eta) |
| |
| void | setBulkViscosity (int amrlev, const Array< MultiFab const *, 3 > &kappa) |
| |
| void | setBulkViscosity (int amrlev, Real kappa) |
| |
| int | getNComp () const final |
| | Return number of components.
|
| |
| bool | isCrossStencil () const final |
| |
| bool | isTensorOp () const final |
| |
| bool | needsUpdate () const final |
| | Does it need update if it's reused?
|
| |
| void | update () final |
| | Update for reuse.
|
| |
| void | prepareForSolve () final |
| |
| bool | isSingular (int) const final |
| | Is it singular on given AMR level?
|
| |
| bool | isBottomSingular () const final |
| | Is the bottom of MG singular?
|
| |
| void | apply (int amrlev, int mglev, MultiFab &out, MultiFab &in, BCMode bc_mode, StateMode s_mode, const MLMGBndry *bndry=nullptr) const final |
| |
| void | compFlux (int amrlev, const Array< MultiFab *, 3 > &fluxes, MultiFab &sol, Location loc) const override |
| |
| void | compVelGrad (int amrlev, const Array< MultiFab *, 3 > &fluxes, MultiFab &sol, Location loc) const |
| |
| void | setBCoeffs (int amrlev, const Array< MultiFab const *, 3 > &beta)=delete |
| |
| void | applyBCTensor (int amrlev, int mglev, MultiFab &vel, BCMode bc_mode, StateMode s_mode, const MLMGBndry *bndry) const |
| |
| | 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 *, 3 > &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) |
| |
| void | Fapply (int amrlev, int mglev, MF &out, const MF &in) const override |
| |
| void | Fsmooth (int amrlev, int mglev, MF &sol, const MF &rhs, int redblack) const override |
| |
| void | FFlux (int amrlev, const MFIter &mfi, const Array< FAB *, 3 > &flux, const FAB &sol, Location, int face_only=0) const override |
| |
| void | normalize (int amrlev, int mglev, MF &mf) const override |
| | Divide mf by the diagonal component of the operator. Used by bicgstab.
|
| |
| RT | getAScalar () const final |
| |
| RT | getBScalar () const final |
| |
| MF const * | getACoeffs (int amrlev, int mglev) const final |
| |
| Array< MF const *, 3 > | getBCoeffs (int amrlev, int mglev) const final |
| |
| std::unique_ptr< MLLinOpT< MF > > | makeNLinOp (int) const final |
| |
| bool | supportNSolve () const override |
| |
| void | copyNSolveSolution (MF &dst, MF const &src) const final |
| |
| void | averageDownCoeffsSameAmrLevel (int amrlev, Vector< MF > &a, Vector< Array< MF, 3 > > &b) |
| |
| void | averageDownCoeffs () |
| |
| void | averageDownCoeffsToCoarseAmrLevel (int flev) |
| |
| void | applyMetricTermsCoeffs () |
| |
| void | applyRobinBCTermsCoeffs () |
| |
| | 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 |
| |
| void | setDirichletNodesToZero (int amrlev, int mglev, MF &mf) const override |
| |
| void | getFluxes (const Vector< Array< MF *, 3 > > &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.
|
| |
| void | addInhomogNeumannFlux (int amrlev, const Array< MF *, 3 > &grad, MF const &sol, bool mult_bcoef) const final |
| |
| void | applyOverset (int amrlev, MF &rhs) const override |
| | for overset solver only
|
| |
| | 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.
|
| |
| void | setGaussSeidel (bool flag) noexcept |
| |
| 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.
|
| |
| void | interpolation (int amrlev, int fmglev, MF &fine, const MF &crse) const override |
| | Add interpolated coarse MG level data to fine MG level data.
|
| |
| void | interpAssign (int amrlev, int fmglev, MF &fine, MF &crse) const override |
| | Overwrite fine MG level data with interpolated coarse data.
|
| |
| void | interpolationAmr (int famrlev, MF &fine, const MF &crse, IntVect const &nghost) const override |
| | Interpolation between AMR levels.
|
| |
| 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.
|
| |
| 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)
|
| |
| void | smooth (int amrlev, int mglev, MF &sol, const MF &rhs, bool skip_fillboundary, int niter) const final |
| | Smooth.
|
| |
| void | solutionResidual (int amrlev, MF &resid, MF &x, const MF &b, const MF *crse_bcdata=nullptr) override |
| | Compute residual for solution.
|
| |
| 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)
|
| |
| 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.
|
| |
| void | compFlux (int amrlev, const Array< MF *, 3 > &fluxes, MF &sol, Location loc) const override |
| | Compute fluxes.
|
| |
| void | compGrad (int amrlev, const Array< MF *, 3 > &grad, MF &sol, Location loc) const override |
| | Compute gradients of the solution.
|
| |
| void | applyMetricTerm (int amrlev, int mglev, MF &rhs) const final |
| | apply metric terms if there are any
|
| |
| void | unapplyMetricTerm (int amrlev, int mglev, MF &rhs) const final |
| | unapply metric terms if there are any
|
| |
| Vector< RT > | getSolvabilityOffset (int amrlev, int mglev, MF const &rhs) const override |
| | get offset for fixing solvability
|
| |
| void | fixSolvabilityByOffset (int amrlev, int mglev, MF &rhs, Vector< RT > const &offset) const 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
|
| |
| RT | dotProductPrecond (Vector< MF const * > const &x, Vector< MF const * > const &y) const final |
| |
| RT | norm2Precond (Vector< MF const * > const &x) const final |
| |
| 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 |
| |
| void | beginPrecondBC () override |
| |
| void | endPrecondBC () override |
| |
| void | setInterpBndryHalfWidth (int w) |
| |
| | 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, 3 > &lobc, const Array< BCType, 3 > &hibc) noexcept |
| | Boundary of the whole domain.
|
| |
| void | setDomainBC (const Vector< Array< BCType, 3 > > &lobc, const Vector< Array< BCType, 3 > > &hibc) noexcept |
| | Boundary of the whole domain.
|
| |
| void | setDomainBCLoc (const Array< Real, 3 > &lo_bcloc, const Array< Real, 3 > &hi_bcloc) noexcept |
| | Set location of domain boundaries.
|
| |
| bool | needsCoarseDataForBC () const noexcept |
| | Needs coarse data for bc?
|
| |
| void | setCoarseFineBC (const MF *crse, int crse_ratio, LinOpBCType bc_type=LinOpBCType::Dirichlet) noexcept |
| | Set coarse/fine boundary conditions. For cell-centered solves only.
|
| |
| 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.
|
| |
| void | setMaxOrder (int o) noexcept |
| | Set order of interpolation at coarse/fine boundary.
|
| |
| int | getMaxOrder () const noexcept |
| | Get order of interpolation at coarse/fine boundary.
|
| |
| 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.
|
| |
| virtual bool | scaleRHS (int, MF *) const |
| | scale RHS to fix solvability
|
| |
| virtual void | fixSolvabilityByOffset (int, int, MF &, Vector< RT > const &) const |
| | fix solvability by subtracting offset from RHS
|
| |
| virtual void | preparePrecond () |
| |
| virtual void | getEBFluxes (const Vector< MF * > &, const Vector< MF * > &) const |
| |
| virtual void | postSolve (Vector< MF * > const &) 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.
|
| |
| int | NMGLevels (int amrlev) const noexcept |
| | Return the number of MG levels at given AMR level.
|
| |
| const Geometry & | Geom (int amr_lev, int mglev=0) const noexcept |
| |
|
| using | FAB = typename MF::fab_type |
| |
| using | RT = typename MF::value_type |
| |
| using | BCType = LinOpBCType |
| |
| using | Location = typename MLLinOpT< MF >::Location |
| |
| using | FAB = typename MF::fab_type |
| |
| using | RT = typename MF::value_type |
| |
| using | Location = typename MLLinOpT< MF >::Location |
| |
| 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 |
| |
| 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 |
| |
| static void | FFlux (Box const &box, Real const *dxinv, RT bscalar, Array< FAB const *, 3 > const &bcoef, Array< FAB *, 3 > const &flux, FAB const &sol, int face_only, int ncomp) |
| |
| 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, 3 > > > | m_b_coeffs |
| |
| bool | m_scalars_set = false |
| |
| bool | m_acoef_set = false |
| |
| Vector< std::unique_ptr< MF > > | m_robin_bcval |
| |
| Vector< Array< BCType, 3 > > | m_lobc |
| |
| Vector< Array< BCType, 3 > > | m_hibc |
| |
| Vector< Array< BCType, 3 > > | m_lobc_orig |
| |
| Vector< Array< BCType, 3 > > | m_hibc_orig |
| |
| using | RealTuple = Array< RT, 2 *3 > |
| |
| using | BCTuple = Array< BoundCond, 2 *3 > |
| |
| bool | supportRobinBC () const noexcept override |
| |
| bool | supportInhomogNeumannBC () const noexcept override |
| |
| const Vector< int > & | AMRRefRatio () const noexcept |
| | Return AMR refinement ratios.
|
| |
| int | AMRRefRatio (int amr_lev) const noexcept |
| | Return AMR refinement ratio at given AMR level.
|
| |
| FabFactory< FAB > const * | Factory (int amr_lev, int mglev=0) const noexcept |
| |
| GpuArray< BCType, 3 > | LoBC (int icomp=0) const noexcept |
| |
| GpuArray< BCType, 3 > | 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 > |
| T | get_d0 (T const &dx, T const &dy, T const &) const noexcept |
| |
| template<typename T > |
| T | get_d1 (T const &, T const &dy, T const &dz) const noexcept |
| |
| static constexpr int | mg_coarsen_ratio = 2 |
| |
| static constexpr int | mg_box_min_width = 2 |
| |