| 
| void  | finerOperatorChanged (const MGLevelOp< LevelData< FArrayBox > > &a_operator, int a_coarseningFactor) | 
|   | 
| LevelData< FArrayBox > &  | identityCoef () | 
|   | Returns identity coefficient data.  More...
  | 
|   | 
| virtual void  | diagonalScale (LevelData< FArrayBox > &a_rhs, bool a_kappaWeighted) | 
|   | For TGA.  More...
  | 
|   | 
| virtual void  | divideByIdentityCoef (LevelData< FArrayBox > &a_rhs) | 
|   | For TGA.  More...
  | 
|   | 
| void  | setBCoefInterpolator (RefCountedPtr< CoefficientInterpolator< LevelData< FluxBox >, LevelData< FArrayBox > > > &a_bCoefInterpolator) | 
|   | 
| LevelData< FluxBox > &  | BCoef () | 
|   | Returns the B coefficient.  More...
  | 
|   | 
| RefCountedPtr< CoefficientInterpolator< LevelData< FluxBox >, LevelData< FArrayBox > > >  | BCoefInterpolator () | 
|   | 
| void  | setTime (Real a_time) | 
|   | 
| virtual void  | getFlux (FluxBox &a_flux, const LevelData< FArrayBox > &a_data, const Box &a_grid, const DataIndex &a_dit, Real a_scale) | 
|   | 
| virtual void  | getFlux (FluxBox &a_flux, const LevelData< FArrayBox > &a_data, const FluxBox &a_bCoef, const Box &a_grid, const DataIndex &a_dit, Real a_scale) | 
|   | 
 | 
|   | VCAMRPoissonOp2 () | 
|   | 
| virtual  | ~VCAMRPoissonOp2 () | 
|   | 
| virtual void  | residualI (LevelData< FArrayBox > &a_lhs, const LevelData< FArrayBox > &a_phi, const LevelData< FArrayBox > &a_rhs, bool a_homogeneous=false) | 
|   | despite what you might think, the "I" here means "Ignore the coarse-fine boundary"  More...
  | 
|   | 
| virtual void  | preCond (LevelData< FArrayBox > &a_correction, const LevelData< FArrayBox > &a_residual) | 
|   | 
| virtual void  | applyOpI (LevelData< FArrayBox > &a_lhs, const LevelData< FArrayBox > &a_phi, bool a_homogeneous=false) | 
|   | despite what you might think, the "I" here means "Ignore the coarse-fine boundary"  More...
  | 
|   | 
| virtual void  | applyOpNoBoundary (LevelData< FArrayBox > &a_lhs, const LevelData< FArrayBox > &a_phi) | 
|   | 
| virtual void  | setAlphaAndBeta (const Real &a_alpha, const Real &a_beta) | 
|   | For tga stuff.  More...
  | 
|   | 
| virtual void  | setCoefs (const RefCountedPtr< LevelData< FArrayBox > > &a_aCoef, const RefCountedPtr< LevelData< FluxBox > > &a_bCoef, const Real &a_alpha, const Real &a_beta) | 
|   | Also calls reset lambda.  More...
  | 
|   | 
| virtual void  | resetLambda () | 
|   | Should be called before the relaxation parameter is needed.  More...
  | 
|   | 
| virtual void  | computeLambda () | 
|   | Compute lambda once alpha, aCoef, beta, bCoef are defined.  More...
  | 
|   | 
| virtual void  | reflux (const LevelData< FArrayBox > &a_phiFine, const LevelData< FArrayBox > &a_phi, LevelData< FArrayBox > &a_residual, AMRLevelOp< LevelData< FArrayBox > > *a_finerOp) | 
|   | 
 | 
| virtual void  | restrictResidual (LevelData< FArrayBox > &a_resCoarse, LevelData< FArrayBox > &a_phiFine, const LevelData< FArrayBox > &a_rhsFine) | 
|   | 
| virtual Real  | dx () const | 
|   | 
|   | AMRPoissonOp () | 
|   | 
| virtual  | ~AMRPoissonOp () | 
|   | 
| void  | define (const DisjointBoxLayout &a_grids, const DisjointBoxLayout &a_gridsFiner, const DisjointBoxLayout &a_gridsCoarser, const Real &a_dxLevel, int a_refRatio, int a_refRatioFiner, const ProblemDomain &a_domain, BCHolder a_bc, const Copier &a_exchange, const CFRegion &a_cfregion, const int a_nComp=1) | 
|   | 
| void  | define (const DisjointBoxLayout &a_grids, const DisjointBoxLayout &a_gridsFiner, const Real &a_dxLevel, int a_refRatio, int a_refRatioFiner, const ProblemDomain &a_domain, BCHolder a_bc, const Copier &a_exchange, const CFRegion &a_cfregion, const int a_nComp=1) | 
|   | 
| void  | define (const DisjointBoxLayout &a_grids, const DisjointBoxLayout &a_baseBAPtr, const Real &a_dxLevel, int a_refRatio, const ProblemDomain &a_domain, BCHolder a_bc, const Copier &a_exchange, const CFRegion &a_cfregion, int a_numComp=1) | 
|   | 
| void  | define (const DisjointBoxLayout &a_grids, const Real &a_dx, const ProblemDomain &a_domain, BCHolder a_bc, const Copier &a_exchange, const CFRegion &a_cfregion) | 
|   | 
| void  | define (const DisjointBoxLayout &a_grids, const Real &a_dx, const ProblemDomain &a_domain, BCHolder a_bc) | 
|   | 
| void  | define (const DisjointBoxLayout &a_grids, const DisjointBoxLayout *a_baseBAPtr, Real a_dxLevel, int a_refRatio, const ProblemDomain &a_domain, BCHolder a_bc) | 
|   | Full define function that mimics the old PoissonOp.  More...
  | 
|   | 
| virtual void  | residual (LevelData< FArrayBox > &a_lhs, const LevelData< FArrayBox > &a_phi, const LevelData< FArrayBox > &a_rhs, bool a_homogeneous=false) | 
|   | 
| virtual void  | residualNF (LevelData< FArrayBox > &a_lhs, LevelData< FArrayBox > &a_phi, const LevelData< FArrayBox > *a_phiCoarse, const LevelData< FArrayBox > &a_rhs, bool a_homogeneous=false) | 
|   | Residual which uses coarse-level boundary conditions, but ignores finer levels.  More...
  | 
|   | 
| virtual void  | applyOp (LevelData< FArrayBox > &a_lhs, const LevelData< FArrayBox > &a_phi, bool a_homogeneous=false) | 
|   | 
| virtual void  | create (LevelData< FArrayBox > &a_lhs, const LevelData< FArrayBox > &a_rhs) | 
|   | 
| virtual void  | createCoarsened (LevelData< FArrayBox > &a_lhs, const LevelData< FArrayBox > &a_rhs, const int &a_refRat) | 
|   | 
| virtual void  | assign (LevelData< FArrayBox > &a_lhs, const LevelData< FArrayBox > &a_rhs) | 
|   | 
| virtual void  | assignLocal (LevelData< FArrayBox > &a_lhs, const LevelData< FArrayBox > &a_rhs) | 
|   | 
| virtual void  | buildCopier (Copier &a_copier, const LevelData< FArrayBox > &a_lhs, const LevelData< FArrayBox > &a_rhs) | 
|   | 
| virtual void  | assignCopier (LevelData< FArrayBox > &a_lhs, const LevelData< FArrayBox > &a_rhs, const Copier &a_copier) | 
|   | 
| virtual void  | zeroCovered (LevelData< FArrayBox > &a_lhs, LevelData< FArrayBox > &a_rhs, const Copier &a_copier) | 
|   | 
| virtual Real  | dotProduct (const LevelData< FArrayBox > &a_1, const LevelData< FArrayBox > &a_2) | 
|   | 
| virtual void  | mDotProduct (const LevelData< FArrayBox > &a_1, const int a_sz, const LevelData< FArrayBox > a_2[], Real a_mdots[]) | 
|   | 
| virtual void  | incr (LevelData< FArrayBox > &a_lhs, const LevelData< FArrayBox > &a_x, Real a_scale) | 
|   | 
| virtual void  | axby (LevelData< FArrayBox > &a_lhs, const LevelData< FArrayBox > &a_x, const LevelData< FArrayBox > &a_y, Real a_a, Real a_b) | 
|   | 
| virtual void  | scale (LevelData< FArrayBox > &a_lhs, const Real &a_scale) | 
|   | 
| virtual Real  | norm (const LevelData< FArrayBox > &a_x, int a_ord) | 
|   | 
| virtual Real  | localMaxNorm (const LevelData< FArrayBox > &a_x) | 
|   | 
| virtual void  | setToZero (LevelData< FArrayBox > &a_x) | 
|   | 
| virtual void  | relax (LevelData< FArrayBox > &a_e, const LevelData< FArrayBox > &a_residual, int a_iterations) | 
|   | 
| virtual void  | relaxNF (LevelData< FArrayBox > &a_phi, const LevelData< FArrayBox > *a_phiCoarse, const LevelData< FArrayBox > &a_rhs, int a_iterations) | 
|   | Do CF interpolation then relax as normal.  More...
  | 
|   | 
| virtual void  | createCoarser (LevelData< FArrayBox > &a_coarse, const LevelData< FArrayBox > &a_fine, bool a_ghosted) | 
|   | 
| virtual void  | prolongIncrement (LevelData< FArrayBox > &a_phiThisLevel, const LevelData< FArrayBox > &a_correctCoarse) | 
|   | 
| virtual int  | refToCoarser () | 
|   | 
| virtual void  | AMRResidual (LevelData< FArrayBox > &a_residual, const LevelData< FArrayBox > &a_phiFine, const LevelData< FArrayBox > &a_phi, const LevelData< FArrayBox > &a_phiCoarse, const LevelData< FArrayBox > &a_rhs, bool a_homogeneousPhysBC, AMRLevelOp< LevelData< FArrayBox > > *a_finerOp) | 
|   | 
| virtual void  | AMRResidualNC (LevelData< FArrayBox > &a_residual, const LevelData< FArrayBox > &a_phiFine, const LevelData< FArrayBox > &a_phi, const LevelData< FArrayBox > &a_rhs, bool a_homogeneousPhysBC, AMRLevelOp< LevelData< FArrayBox > > *a_finerOp) | 
|   | 
| virtual void  | AMRResidualNF (LevelData< FArrayBox > &a_residual, const LevelData< FArrayBox > &a_phi, const LevelData< FArrayBox > &a_phiCoarse, const LevelData< FArrayBox > &a_rhs, bool a_homogeneousPhysBC) | 
|   | 
| virtual void  | AMROperator (LevelData< FArrayBox > &a_LofPhi, const LevelData< FArrayBox > &a_phiFine, const LevelData< FArrayBox > &a_phi, const LevelData< FArrayBox > &a_phiCoarse, bool a_homogeneousDomBC, AMRLevelOp< LevelData< FArrayBox > > *a_finerOp) | 
|   | 
| virtual void  | AMROperatorNC (LevelData< FArrayBox > &a_LofPhi, const LevelData< FArrayBox > &a_phiFine, const LevelData< FArrayBox > &a_phi, bool a_homogeneousBC, AMRLevelOp< LevelData< FArrayBox > > *a_finerOp) | 
|   | 
| virtual void  | AMROperatorNF (LevelData< FArrayBox > &a_LofPhi, const LevelData< FArrayBox > &a_phi, const LevelData< FArrayBox > &a_phiCoarse, bool a_homogeneousBC) | 
|   | 
| virtual void  | AMRRestrict (LevelData< FArrayBox > &a_resCoarse, const LevelData< FArrayBox > &a_residual, const LevelData< FArrayBox > &a_correction, const LevelData< FArrayBox > &a_coarseCorrection, bool a_skip_res=false) | 
|   | 
| virtual void  | AMRRestrictS (LevelData< FArrayBox > &a_resCoarse, const LevelData< FArrayBox > &a_residual, const LevelData< FArrayBox > &a_correction, const LevelData< FArrayBox > &a_coarseCorrection, LevelData< FArrayBox > &a_scratch, bool a_skip_res=false) | 
|   | 
| virtual void  | AMRProlong (LevelData< FArrayBox > &a_correction, const LevelData< FArrayBox > &a_coarseCorrection) | 
|   | 
| virtual void  | AMRProlongS (LevelData< FArrayBox > &a_correction, const LevelData< FArrayBox > &a_coarseCorrection, LevelData< FArrayBox > &a_temp, const Copier &a_copier) | 
|   | 
| virtual void  | AMRProlongS_2 (LevelData< FArrayBox > &a_correction, const LevelData< FArrayBox > &a_coarseCorrection, LevelData< FArrayBox > &a_temp, const Copier &a_copier, const Copier &a_cornerCopier, const AMRLevelOp< LevelData< FArrayBox > > *a_crsOp) | 
|   | 
| virtual void  | AMRUpdateResidual (LevelData< FArrayBox > &a_residual, const LevelData< FArrayBox > &a_correction, const LevelData< FArrayBox > &a_coarseCorrection) | 
|   | 
| virtual Real  | AMRNorm (const LevelData< FArrayBox > &a_coarseResid, const LevelData< FArrayBox > &a_fineResid, const int &a_refRat, const int &a_ord) | 
|   | 
| virtual void  | setBC (const BCHolder &a_bc) | 
|   | Change boundary conditions.  More...
  | 
|   | 
| virtual void  | fillGrad (const LevelData< FArrayBox > &a_phi) | 
|   | These functions are part of the LevelTGA interface......  More...
  | 
|   | 
| virtual void  | write (const LevelData< FArrayBox > *a_data, const char *a_filename) | 
|   | 
|   | LevelTGAHelmOp () | 
|   | 
|   | LevelTGAHelmOp (bool a_isTimeIndependent) | 
|   | 
| virtual  | ~LevelTGAHelmOp () | 
|   | Destructor.  More...
  | 
|   | 
|   | TGAHelmOp () | 
|   | 
|   | TGAHelmOp (bool a_isTimeDependent) | 
|   | 
| virtual  | ~TGAHelmOp () | 
|   | Destructor.  More...
  | 
|   | 
| virtual void  | diagonalScale (LevelData< FArrayBox > &a_rhs) | 
|   | 
| virtual void  | kappaScale (LevelData< FArrayBox > &a_rhs) | 
|   | for eb only. kappa weight the rhs but do not multiply by the identity coefficient  More...
  | 
|   | 
| virtual void  | setTime (Real a_oldTime, Real a_mu, Real a_dt) | 
|   | 
| bool  | isTimeDependent () const | 
|   | Returns true if the operator is time-dependent, false otherwise.  More...
  | 
|   | 
| virtual void  | dumpAMR (Vector< LevelData< FArrayBox > * > &a_data, string name) | 
|   | 
| virtual void  | dumpLevel (LevelData< FArrayBox > &a_data, string name) | 
|   | 
|   | AMRLevelOp () | 
|   | Constructor.  More...
  | 
|   | 
| virtual void  | dumpStuff (Vector< LevelData< FArrayBox > * > data, string filename) | 
|   | 
| virtual  | ~AMRLevelOp () | 
|   | Destructor.  More...
  | 
|   | 
| virtual void  | outputLevel (LevelData< FArrayBox > &a_rhs, string &a_name) | 
|   | 
| virtual void  | outputAMR (Vector< LevelData< FArrayBox > * > &a_rhs, string &a_name) | 
|   | 
| virtual unsigned int  | orderOfAccuracy (void) const | 
|   | 
| virtual void  | enforceCFConsistency (LevelData< FArrayBox > &a_coarseCorrection, const LevelData< FArrayBox > &a_correction) | 
|   | This routine is for operators with orderOfAccuracy()>2.  More...
  | 
|   | 
|   | MGLevelOp () | 
|   | Constructor.  More...
  | 
|   | 
| virtual  | ~MGLevelOp () | 
|   | Destructor.  More...
  | 
|   | 
| virtual void  | restrictResidual (LevelData< FArrayBox > &a_resCoarse, LevelData< FArrayBox > &a_phiFine, const LevelData< FArrayBox > *a_phiCoarse, const LevelData< FArrayBox > &a_rhsFine, bool homogeneous) | 
|   | full-multigrid version of restrictResidual, useful for FAS-type schemes. Defaults to standard restriction  More...
  | 
|   | 
| virtual void  | restrictR (LevelData< FArrayBox > &a_phiCoarse, const LevelData< FArrayBox > &a_phiFine) | 
|   | simple restriction function  More...
  | 
|   | 
| void  | addObserver (MGLevelOpObserver< LevelData< FArrayBox > > *a_observer) | 
|   | 
| virtual void  | applyOpMg (LevelData< FArrayBox > &a_lhs, LevelData< FArrayBox > &a_phi, LevelData< FArrayBox > *a_phiCoarse, bool a_homogeneous) | 
|   | Apply an operator.  More...
  | 
|   | 
| void  | removeObserver (MGLevelOpObserver< LevelData< FArrayBox > > *a_observer) | 
|   | 
| void  | addCoarserObserver (MGLevelOp< LevelData< FArrayBox > > *a_operator, int a_coarseningFactor) | 
|   | 
| void  | notifyObserversOfChange () | 
|   | This should be called whenever the operator's data is updated.  More...
  | 
|   | 
| int  | numObservers () const | 
|   | Returns the number of objects observing this operator.  More...
  | 
|   | 
| virtual  | ~LinearOp () | 
|   | 
| virtual void  | clear (LevelData< FArrayBox > &a_lhs) | 
|   | 
|   | MGLevelOpObserver () | 
|   | Base level Constructor. Called by all subclasses.  More...
  | 
|   | 
| virtual  | ~MGLevelOpObserver () | 
|   | Destructor.  More...
  | 
|   | 
| virtual void  | operatorChanged (const MGLevelOp< LevelData< FArrayBox > > &a_operator) | 
|   | 
| void  | setObservee (MGLevelOp< LevelData< FArrayBox > > *a_observee) | 
|   | 
| void  | clearObservee () | 
|   | 
Operator for solving variable-coefficient (alpha * aCoef(x) * I - beta * Div(bCoef(x) . Grad)) phi = rho over an AMR hierarchy.