KASKADE 7 development version
Modules | Namespaces | Classes | Typedefs | Functions | Variables
Adaptivity

Tools for error estimation and local mesh refinement. More...

Modules

 Refinement Criteria
 Tools for selecting cells for refinement.
 

Namespaces

namespace  Kaskade::FunctionViews
 Namespace of views on a FunctionSpaceElement Views on Function SpaceElements can be used in a restricted sense like FunctionSpaceElements. The idea is to transform a given function to another function while evaluating it at a certain point. Such a view has provide certain functionality:
 

Classes

class  Kaskade::FunctionViews::Difference< Function1, Function2 >
 
class  Kaskade::LocalIntegral< Space >
 Create a CellData by computing local integrals over each Cell. More...
 
class  Kaskade::HigherOrderRecovery< Grid, Space >
 Construct a higher order estimate for the finite element solution from gradient information. More...
 
struct  Kaskade::HigherOrderRecovery< Grid, Space >::HigherOrderRecoveryFunctional< RType, Variables >::DomainCache
 
struct  Kaskade::HigherOrderRecovery< Grid, Space >::HigherOrderRecoveryFunctional< RType, Variables >::BoundaryCache
 
struct  Kaskade::HigherOrderRecovery< Grid, Space >::HigherOrderRecoveryFunctional< RType, Variables >::D2< row, col >
 
struct  Kaskade::EstimatorDescription< Id, PDEId, SpaceId, components >
 
struct  Kaskade::SystDim< dim >
 
struct  Kaskade::SystDimFull< dim >
 
struct  Kaskade::HalfGradientJump< LocalInd, RT, Cache, dim, Evaluators >
 
struct  Kaskade::StrongBoundaryValues< LocalInd, RT, Cache, BoundaryCache, dim, Evaluators >
 
struct  Kaskade::WeakResiduum< LocalRHS, RT, Cache, Evaluators >
 
struct  Kaskade::WeakResiduumMainPart< LocalRHS, RT, Cache, Evaluators >
 
struct  Kaskade::GradientAverage< LocalInd, RT, Cache, dim, Evaluators >
 
struct  Kaskade::WeakBoundaryValues< LocalInd, RT, Cache, BoundaryCache, dim, Evaluators >
 
struct  Kaskade::SolveLocalSystem< LocalVector, LocalMatrix >
 
struct  Kaskade::ScatterLocalSolution< LocalSolution, Evaluators, GlobalSolution >
 
struct  Kaskade::LocalNormalMatrixBlock< LocalMatrix, Evaluators, RT, Cache, Row >
 
struct  Kaskade::LocalNormalMatrixRow< LocalMatrix, Evaluators, RT, Cache, VarDesc >
 
struct  Kaskade::WeakResiduumFull< LocalRHS, RT, Cache, Evaluators >
 
struct  Kaskade::ScatterFullLocalSolution< LocalSolution, Evaluators, GlobalSolution >
 
struct  Kaskade::GradientAverageFull< LocalInd, RT, Cache, dim, Evaluators >
 
struct  Kaskade::WeakBoundaryValuesFull< LocalInd, RT, Cache, BoundaryCache, dim, Evaluators >
 
class  Kaskade::BWErrorFunction< Description, Grid, Functional, FunctionalSimpl >
 Obtain an error function by solving local Neumann problems in the flavour of Bank/Weiser. More...
 
class  Kaskade::CellData< Grd, T >
 Class that stores information for each cell of a grid. More...
 
class  Kaskade::EmbeddedErrorEstimator< VariableSetDescription, Scaling >
 Embedded error estimation and mesh refinement. More...
 
class  Kaskade::HierarchicErrorEstimator< LinearFunctional, ExtensionAnsatzVariables, ExtensionTestVariables, D2BlockInfo >
 Defines assembly of hierarchically extended problems for defining DLY style error estimators. More...
 

Typedefs

typedef Function1::Space Kaskade::FunctionViews::Difference< Function1, Function2 >::Space
 
typedef Function1::ValueType Kaskade::FunctionViews::Difference< Function1, Function2 >::ValueType
 
typedef Function1::DerivativeType Kaskade::FunctionViews::Difference< Function1, Function2 >::DerivativeType
 
typedef Function1::Scalar Kaskade::FunctionViews::Difference< Function1, Function2 >::Scalar
 
typedef DiscontSpace Kaskade::HigherOrderRecovery< Grid, Space >::ErrorGradientFunctionSpace
 
typedef Space Kaskade::HigherOrderRecovery< Grid, Space >::ErrorFunctionSpace
 
typedef ErrorGradientFunctionSpace::template Element< Grid::dimension >::type Kaskade::HigherOrderRecovery< Grid, Space >::ErrorGradientFunction
 
typedef ErrorFunctionSpace::template Element< 1 >::type Kaskade::HigherOrderRecovery< Grid, Space >::ErrorFunction
 
typedef RType Kaskade::HigherOrderRecovery< Grid, Space >::HigherOrderRecoveryFunctional< RType, Variables >::RT
 
typedef Variables Kaskade::HigherOrderRecovery< Grid, Space >::HigherOrderRecoveryFunctional< RType, Variables >::TestVars
 
typedef Variables Kaskade::HigherOrderRecovery< Grid, Space >::HigherOrderRecoveryFunctional< RType, Variables >::AnsatzVars
 
typedef FEFunctionSpace< DiscontinuousLagrangeMapper< double, Grid > > Kaskade::BWErrorFunction< Description, Grid, Functional, FunctionalSimpl >::RecoverySpace
 
typedef boost::fusion::vector< RecoverySpace const * > Kaskade::BWErrorFunction< Description, Grid, Functional, FunctionalSimpl >::RecoverySpaces
 
typedef VariableSetDescription< RecoverySpaces, Description > Kaskade::BWErrorFunction< Description, Grid, Functional, FunctionalSimpl >::RecoveryVariableSet
 
typedef RecoveryVariableSet::VariableSet Kaskade::BWErrorFunction< Description, Grid, Functional, FunctionalSimpl >::RecoveryRepresentation
 
typedef FEFunctionSpace< ContinuousLagrangeMapper< double, Grid > > Kaskade::BWErrorFunction< Description, Grid, Functional, FunctionalSimpl >::ContRecoverySpace
 
typedef boost::fusion::vector< ContRecoverySpace const * > Kaskade::BWErrorFunction< Description, Grid, Functional, FunctionalSimpl >::ContRecoverySpaces
 
typedef VariableSetDescription< ContRecoverySpaces, Description > Kaskade::BWErrorFunction< Description, Grid, Functional, FunctionalSimpl >::ContRecoveryVariableSet
 
typedef ContRecoveryVariableSet::VariableSet Kaskade::BWErrorFunction< Description, Grid, Functional, FunctionalSimpl >::ContRecoveryRepresentation
 
typedef GridManager< typename VariableSetDescription::GridKaskade::EmbeddedErrorEstimator< VariableSetDescription, Scaling >::GManager
 
typedef EmbeddedErrorEstimator< VariableSetDescription, ScalingKaskade::EmbeddedErrorEstimator< VariableSetDescription, Scaling >::Self
 

Functions

template<class SFS >
int Kaskade::FunctionViews::Difference< Function1, Function2 >::order (SFS const &sfs) const
 
Space const & Kaskade::FunctionViews::Difference< Function1, Function2 >::space () const
 
 Kaskade::FunctionViews::Difference< Function1, Function2 >::Difference (Function1 const &f1_, Function2 const &f2_)
 
ValueType Kaskade::FunctionViews::Difference< Function1, Function2 >::value (typename Function1::Space::Evaluator eval) const
 
template<class EPtr , class V >
ValueType Kaskade::FunctionViews::Difference< Function1, Function2 >::value (EPtr const &ci, V const &v) const
 
DerivativeType Kaskade::FunctionViews::Difference< Function1, Function2 >::derivative (typename Function1::Space::Evaluator eval) const
 
void Kaskade::LocalIntegral< Space >::LocalIntegrator::operator() (typename Cell::Entity const &ci, QuadPoint const &q, ValueType v)
 
CellData< Grid, ValueType >::CellDataVector & Kaskade::LocalIntegral< Space >::LocalIntegrator::getLocalIntegral ()
 
template<typename Function >
CellData< Grid, ValueType >::CellDataVector Kaskade::LocalIntegral< Space >::operator() (Function f, Space s)
 Perform local integration for WeakFunctionViews (less efficient) More...
 
template<typename Function >
CellData< Grid, ValueType >::CellDataVector Kaskade::LocalIntegral< Space >::operator() (Function f)
 Perform local integration for FunctionSpaceElement or FunctionViews (more efficient) More...
 
template<class Function >
CellData< typenameFunction::Space::Grid, typenameFunction::ValueType >::CellDataVector Kaskade::gradientAveraging (Function const &f)
 Perform gradient averaging in order to construct an error estimator. More...
 
template<class GradientError , class Function >
void Kaskade::gradientAveraging (GradientError &dx, Function const &x)
 Perform gradient averaging in order to construct a representation of the gradient error. More...
 
template<class Function >
CellData< typenameFunction::Space::Grid, typenameFunction::ValueType >::CellDataVector Kaskade::lowOrderInterpolation (Function const &f)
 Perform lower order interpolation in order to construct an error estimator. More...
 
template<class Arg >
bool Kaskade::HigherOrderRecovery< Grid, Space >::HigherOrderRecoveryFunctional< RType, Variables >::inDomain (Arg const &a) const
 
 Kaskade::HigherOrderRecovery< Grid, Space >::HigherOrderRecoveryFunctional< RType, Variables >::HigherOrderRecoveryFunctional (ErrorGradientFunction const &x_)
 
 Kaskade::HigherOrderRecovery< Grid, Space >::HigherOrderRecoveryFunctional< RType, Variables >::DomainCache::DomainCache (ErrorGradientFunction const &u_)
 
template<class Position , class Evaluators >
void Kaskade::HigherOrderRecovery< Grid, Space >::HigherOrderRecoveryFunctional< RType, Variables >::DomainCache::evaluateAt (Position const &x, Evaluators const &evaluators)
 
RT Kaskade::HigherOrderRecovery< Grid, Space >::HigherOrderRecoveryFunctional< RType, Variables >::DomainCache::d0 () const
 
template<int row, int dim>
Dune::FieldVector< RT, 1 > Kaskade::HigherOrderRecovery< Grid, Space >::HigherOrderRecoveryFunctional< RType, Variables >::DomainCache::d1 (VariationalArg< RT, dim > const &arg) const
 
template<int row, int col, int dim>
Dune::FieldMatrix< RT, 1, 1 > Kaskade::HigherOrderRecovery< Grid, Space >::HigherOrderRecoveryFunctional< RType, Variables >::DomainCache::d2 (VariationalArg< RT, dim > const &arg1, VariationalArg< RT, dim > const &arg2) const
 
DomainCache Kaskade::HigherOrderRecovery< Grid, Space >::HigherOrderRecoveryFunctional< RType, Variables >::createDomainCache (int flags=7) const
 
BoundaryCache Kaskade::HigherOrderRecovery< Grid, Space >::HigherOrderRecoveryFunctional< RType, Variables >::createBoundaryCache (int flags=7) const
 
template<class Cell >
int Kaskade::HigherOrderRecovery< Grid, Space >::HigherOrderRecoveryFunctional< RType, Variables >::integrationOrder (Cell const &, int shapeFunctionOrder, bool boundary) const
 
void Kaskade::HigherOrderRecovery< Grid, Space >::getErrorFunction (ErrorFunction &ex, ErrorGradientFunction const &gex)
 
 Kaskade::HalfGradientJump< LocalInd, RT, Cache, dim, Evaluators >::HalfGradientJump (LocalInd &localInd_, Dune::FieldVector< RT, dim >const &outernormal, Cache const &cache_, Cache const &cacheNeigh_, Evaluators const &evaluators_)
 
template<class Variable >
void Kaskade::HalfGradientJump< LocalInd, RT, Cache, dim, Evaluators >::operator() (Variable const &) const
 
 Kaskade::StrongBoundaryValues< LocalInd, RT, Cache, BoundaryCache, dim, Evaluators >::StrongBoundaryValues (LocalInd &localInd_, RT &integrationElement, Dune::FieldVector< RT, dim >const &outernormal, Cache const &cache_, BoundaryCache const &cacheBoundary_, Evaluators const &evaluators_)
 
template<class Variable >
void Kaskade::StrongBoundaryValues< LocalInd, RT, Cache, BoundaryCache, dim, Evaluators >::operator() (Variable const &) const
 
 Kaskade::WeakResiduum< LocalRHS, RT, Cache, Evaluators >::WeakResiduum (LocalRHS &localRHS_, RT intEl_, Cache const &cache_, Evaluators const &evaluators_)
 
template<class Variable >
void Kaskade::WeakResiduum< LocalRHS, RT, Cache, Evaluators >::operator() (Variable const &) const
 
 Kaskade::WeakResiduumMainPart< LocalRHS, RT, Cache, Evaluators >::WeakResiduumMainPart (LocalRHS &localRHS_, RT intEl_, Cache const &cache_, Evaluators const &evaluators_)
 
template<class Variable >
void Kaskade::WeakResiduumMainPart< LocalRHS, RT, Cache, Evaluators >::operator() (Variable const &) const
 
 Kaskade::GradientAverage< LocalInd, RT, Cache, dim, Evaluators >::GradientAverage (LocalInd &localInd_, Dune::FieldVector< RT, dim >const &outernormal, Cache const &cache_, Cache const &cacheNeigh_, Evaluators const &evaluators_)
 
template<class Variable >
void Kaskade::GradientAverage< LocalInd, RT, Cache, dim, Evaluators >::operator() (Variable const &) const
 
 Kaskade::WeakBoundaryValues< LocalInd, RT, Cache, BoundaryCache, dim, Evaluators >::WeakBoundaryValues (LocalInd &localInd_, RT &integrationElement, Dune::FieldVector< RT, dim >const &outernormal, Cache const &cache_, BoundaryCache const &cacheBoundary_, Evaluators const &evaluators_)
 
template<class Variable >
void Kaskade::WeakBoundaryValues< LocalInd, RT, Cache, BoundaryCache, dim, Evaluators >::operator() (Variable const &) const
 
 Kaskade::SolveLocalSystem< LocalVector, LocalMatrix >::SolveLocalSystem (LocalVector &c_, LocalMatrix &A_, LocalVector &b_)
 
template<class Variable >
void Kaskade::SolveLocalSystem< LocalVector, LocalMatrix >::operator() (Variable const &) const
 
template<class LocalMatrix , class Evaluators , class RT , class Cache >
void Kaskade::localNormalMatrix (LocalMatrix &localmatrix, RT intEl, Evaluators const &evaluators, Cache const &cache)
 
template<class LocalVector , class Evaluators , class RT >
void Kaskade::rank1KernelVector (LocalVector &localvector, RT intEl, Evaluators const &evaluators)
 
 Kaskade::ScatterLocalSolution< LocalSolution, Evaluators, GlobalSolution >::ScatterLocalSolution (LocalSolution const &localSolution_, Evaluators const &evaluators_, GlobalSolution &globalSolution_)
 
template<class Variable >
void Kaskade::ScatterLocalSolution< LocalSolution, Evaluators, GlobalSolution >::operator() (Variable const &) const
 
template<class VariableDescriptions , int sysdim, class Result , class F , class Spaces , class ExtendedSpaces >
void Kaskade::edgeAveraging (Result &result, F const &f, Spaces const &spaces, ExtendedSpaces const &extendedSpaces)
 Computes an error representation function, which is useful for goal oriented adaptivity. More...
 
 Kaskade::LocalNormalMatrixBlock< LocalMatrix, Evaluators, RT, Cache, Row >::LocalNormalMatrixBlock (LocalMatrix &localmatrix_, RT intEl_, Evaluators const &evaluators_, Cache const &cache_)
 
template<class Col >
void Kaskade::LocalNormalMatrixBlock< LocalMatrix, Evaluators, RT, Cache, Row >::operator() (Col const &) const
 
 Kaskade::LocalNormalMatrixRow< LocalMatrix, Evaluators, RT, Cache, VarDesc >::LocalNormalMatrixRow (LocalMatrix &localmatrix_, RT intEl_, Evaluators const &evaluators_, Cache const &cache_)
 
template<class Row >
void Kaskade::LocalNormalMatrixRow< LocalMatrix, Evaluators, RT, Cache, VarDesc >::operator() (Row const &) const
 
template<class LocalVector , class LocalMatrix >
void Kaskade::solveLocalFullSystem (LocalVector &c, LocalMatrix &A, LocalVector &b)
 
 Kaskade::WeakResiduumFull< LocalRHS, RT, Cache, Evaluators >::WeakResiduumFull (LocalRHS &localRHS_, RT intEl_, Cache const &cache_, Evaluators const &evaluators_)
 
template<class Variable >
void Kaskade::WeakResiduumFull< LocalRHS, RT, Cache, Evaluators >::operator() (Variable const &) const
 
 Kaskade::ScatterFullLocalSolution< LocalSolution, Evaluators, GlobalSolution >::ScatterFullLocalSolution (LocalSolution const &localSolution_, Evaluators const &evaluators_, GlobalSolution &globalSolution_)
 
template<class Variable >
void Kaskade::ScatterFullLocalSolution< LocalSolution, Evaluators, GlobalSolution >::operator() (Variable const &) const
 
 Kaskade::GradientAverageFull< LocalInd, RT, Cache, dim, Evaluators >::GradientAverageFull (LocalInd &localInd_, Dune::FieldVector< RT, dim >const &outernormal, Cache const &cache_, Cache const &cacheNeigh_, Evaluators const &evaluators_)
 
template<class Variable >
void Kaskade::GradientAverageFull< LocalInd, RT, Cache, dim, Evaluators >::operator() (Variable const &) const
 
 Kaskade::WeakBoundaryValuesFull< LocalInd, RT, Cache, BoundaryCache, dim, Evaluators >::WeakBoundaryValuesFull (LocalInd &localInd_, RT &integrationElement, Dune::FieldVector< RT, dim >const &outernormal, Cache const &cache_, BoundaryCache const &cacheBoundary_, Evaluators const &evaluators_)
 
template<class Variable >
void Kaskade::WeakBoundaryValuesFull< LocalInd, RT, Cache, BoundaryCache, dim, Evaluators >::operator() (Variable const &) const
 
template<class VariableDescriptions , int sysdim, class Result , class F , class FS , class Spaces , class ExtendedSpaces >
void Kaskade::edgeAveragingFull (Result &result, F const &f, FS const &fs, Spaces const &spaces, ExtendedSpaces const &extendedSpaces)
 Computes an error representation function, which is useful for goal oriented adaptivity. More...
 
template<class Spaces >
void Kaskade::BWErrorFunction< Description, Grid, Functional, FunctionalSimpl >::getErrorFunction (RecoveryRepresentation &recovery, Spaces const &spaces, FunctionalSimpl const &vf)
 
template<class Spaces >
void Kaskade::BWErrorFunction< Description, Grid, Functional, FunctionalSimpl >::getFullErrorFunction (RecoveryRepresentation &recovery, Spaces const &spaces, Functional const &vf, FunctionalSimpl const &vfs)
 
template<class Description , class Function , class Functional >
CellData< typenameFunction::Grid >::CellDataVector Kaskade::BWErrorIndicator (Function const &f, Functional const &vf)
 Construct an error indicator in the flavour of Bank/Weiser. More...
 
template<class VariableSetDescription , class Scaling >
void Kaskade::coarsening (VariableSetDescription const &varDesc, typename VariableSetDescription::VariableSet const &sol, Scaling const &scaling, std::vector< std::pair< double, double > > const &tol, GridManager< typename VariableSetDescription::Grid > &gridManager, int verbosity=1, int minRefLevel=0)
 
template<class VariableSetDescription , class Scaling >
void Kaskade::coarsening (VariableSetDescription const &varDesc, typename VariableSetDescription::VariableSet const &sol, Scaling const &scaling, std::vector< std::pair< double, double > > const &tol, GridManager< typename VariableSetDescription::Grid > &gridManager, std::vector< bool > &coarsenedCells, int verbosity=1, int minRefLevel=0)
 coarsening routine More...
 
template<class VariableSetDescription >
void Kaskade::projectHierarchically (VariableSet< VariableSetDescription > &f)
 Projects the given FE function onto the the polynomial ansatz subspace of one order lower. This relies on the hierarchic projection defined by the shape function sets on each cell. More...
 
template<class VariableSet , class GridManager >
std::array< size_t, 3 > Kaskade::uniformEmbeddedErrorEstimation (VariableSet const &u, Dune::FieldVector< double, VariableSet::Descriptions::noOfVariables > const &tol, GridManager &gridManager, double rhoMin=0.1, double rhoMax=0.9)
 Embedded error estimation and simultaneous mesh refinement/coarsening. More...
 
 Kaskade::EmbeddedErrorEstimator< VariableSetDescription, Scaling >::EmbeddedErrorEstimator (GManager &gridManager_, VariableSetDescription const &varDesc_, Scaling const &scaling_=Scaling())
 Constructor. More...
 
bool Kaskade::EmbeddedErrorEstimator< VariableSetDescription, Scaling >::estimate (typename VariableSetDescription::VariableSet const &err, typename VariableSetDescription::VariableSet const &sol) const
 perform error estimation More...
 
SelfKaskade::EmbeddedErrorEstimator< VariableSetDescription, Scaling >::setTolerances (std::vector< std::pair< double, double > > const &tol_)
 set the tolerances More...
 
SelfKaskade::EmbeddedErrorEstimator< VariableSetDescription, Scaling >::setScaling (Scaling const &scaling_)
 set the scaling More...
 
SelfKaskade::EmbeddedErrorEstimator< VariableSetDescription, Scaling >::setCriterion (RefinementCriterion const &criterion_)
 set the refinement criterion More...
 
SelfKaskade::EmbeddedErrorEstimator< VariableSetDescription, Scaling >::setVerbosity (int verbosity_)
 set the verbosity level More...
 
template<class VariableSetDescription , class Scaling >
bool Kaskade::embeddedErrorEstimator (VariableSetDescription const &varDesc, typename VariableSetDescription::VariableSet const &err, typename VariableSetDescription::VariableSet const &sol, Scaling const &scaling, std::vector< std::pair< double, double > > const &tol, GridManager< typename VariableSetDescription::Grid > &gridManager, int verbosity=1)
 Embedded error estimation and mesh refinement. More...
 
template<class ExtensionVariables , class LinearFunctional >
HierarchicErrorEstimator< LinearFunctional, ExtensionVariables > Kaskade::hierarchicErrorEstimator (LinearFunctional const &lf, typename LinearFunctional::AnsatzVars::VariableSet const &u)
 
template<class ErrorDescriptions , class F , class FS , class TestFunctions , class Spaces , class TestSpaces >
void Kaskade::residualTimesTestFunction (std::vector< Dune::FieldVector< typename SpaceType< Spaces, 0 >::type::RT, boost::fusion::result_of::size< ErrorDescriptions >::type::value > > &ind, ErrorDescriptions const &varDesc, F const &f, FS const &fs, TestFunctions const &tf, Spaces const &spaces, TestSpaces const &testSpaces)
 Evaluates strong residual, applied to some test-function <f(x), tf> More...
 

Variables

static ProblemType const Kaskade::HigherOrderRecovery< Grid, Space >::HigherOrderRecoveryFunctional< RType, Variables >::type = VariationalFunctional
 
ErrorGradientFunction const & Kaskade::HigherOrderRecovery< Grid, Space >::HigherOrderRecoveryFunctional< RType, Variables >::x
 
static bool const Kaskade::HigherOrderRecovery< Grid, Space >::HigherOrderRecoveryFunctional< RType, Variables >::D2< row, col >::present = true
 
static bool const Kaskade::HigherOrderRecovery< Grid, Space >::HigherOrderRecoveryFunctional< RType, Variables >::D2< row, col >::lumped = false
 
static bool const Kaskade::HigherOrderRecovery< Grid, Space >::HigherOrderRecoveryFunctional< RType, Variables >::D2< row, col >::symmetric = true
 
static int const Kaskade::EstimatorDescription< Id, PDEId, SpaceId, components >::id = Id
 
static int const Kaskade::EstimatorDescription< Id, PDEId, SpaceId, components >::pdeid = PDEId
 
static int const Kaskade::EstimatorDescription< Id, PDEId, SpaceId, components >::spaceIndex = SpaceId
 
static int const Kaskade::EstimatorDescription< Id, PDEId, SpaceId, components >::m = components
 
static const int Kaskade::SystDim< dim >::value = (dim+1)+3*(dim-1)
 
static const int Kaskade::SystDimFull< dim >::value = (dim+1)+3*(dim-1)
 
VariationalArg< RT, dim > Kaskade::HalfGradientJump< LocalInd, RT, Cache, dim, Evaluators >::modarg
 
LocalInd & Kaskade::HalfGradientJump< LocalInd, RT, Cache, dim, Evaluators >::localInd
 
Cache const & Kaskade::HalfGradientJump< LocalInd, RT, Cache, dim, Evaluators >::cache
 
Cache const & Kaskade::HalfGradientJump< LocalInd, RT, Cache, dim, Evaluators >::cacheNeigh
 
Evaluators const & Kaskade::HalfGradientJump< LocalInd, RT, Cache, dim, Evaluators >::evaluators
 
VariationalArg< RT, dim > Kaskade::StrongBoundaryValues< LocalInd, RT, Cache, BoundaryCache, dim, Evaluators >::modarg
 
VariationalArg< RT, dim > Kaskade::StrongBoundaryValues< LocalInd, RT, Cache, BoundaryCache, dim, Evaluators >::modargB
 
VariationalArg< RT, dim > Kaskade::StrongBoundaryValues< LocalInd, RT, Cache, BoundaryCache, dim, Evaluators >::modargTest
 
LocalInd & Kaskade::StrongBoundaryValues< LocalInd, RT, Cache, BoundaryCache, dim, Evaluators >::localInd
 
Cache const & Kaskade::StrongBoundaryValues< LocalInd, RT, Cache, BoundaryCache, dim, Evaluators >::cache
 
BoundaryCache const & Kaskade::StrongBoundaryValues< LocalInd, RT, Cache, BoundaryCache, dim, Evaluators >::boundaryCache
 
Evaluators const & Kaskade::StrongBoundaryValues< LocalInd, RT, Cache, BoundaryCache, dim, Evaluators >::evaluators
 
static const int Kaskade::WeakResiduum< LocalRHS, RT, Cache, Evaluators >::dim = boost::fusion::result_of::value_at_c<Evaluators,0>::type::Space::dim
 
LocalRHS & Kaskade::WeakResiduum< LocalRHS, RT, Cache, Evaluators >::localRHS
 
RT Kaskade::WeakResiduum< LocalRHS, RT, Cache, Evaluators >::intEl
 
Evaluators const & Kaskade::WeakResiduum< LocalRHS, RT, Cache, Evaluators >::evaluators
 
Cache const & Kaskade::WeakResiduum< LocalRHS, RT, Cache, Evaluators >::cache
 
static const int Kaskade::WeakResiduumMainPart< LocalRHS, RT, Cache, Evaluators >::dim = boost::fusion::result_of::value_at_c<Evaluators,0>::type::Space::dim
 
LocalRHS & Kaskade::WeakResiduumMainPart< LocalRHS, RT, Cache, Evaluators >::localRHS
 
RT Kaskade::WeakResiduumMainPart< LocalRHS, RT, Cache, Evaluators >::intEl
 
Evaluators const & Kaskade::WeakResiduumMainPart< LocalRHS, RT, Cache, Evaluators >::evaluators
 
Cache const & Kaskade::WeakResiduumMainPart< LocalRHS, RT, Cache, Evaluators >::cache
 
VariationalArg< RT, dim > Kaskade::GradientAverage< LocalInd, RT, Cache, dim, Evaluators >::modarg
 
LocalInd & Kaskade::GradientAverage< LocalInd, RT, Cache, dim, Evaluators >::localInd
 
Cache const & Kaskade::GradientAverage< LocalInd, RT, Cache, dim, Evaluators >::cache
 
Cache const & Kaskade::GradientAverage< LocalInd, RT, Cache, dim, Evaluators >::cacheNeigh
 
Evaluators const & Kaskade::GradientAverage< LocalInd, RT, Cache, dim, Evaluators >::evaluators
 
VariationalArg< RT, dim > Kaskade::WeakBoundaryValues< LocalInd, RT, Cache, BoundaryCache, dim, Evaluators >::modarg
 
VariationalArg< RT, dim > Kaskade::WeakBoundaryValues< LocalInd, RT, Cache, BoundaryCache, dim, Evaluators >::modargB
 
VariationalArg< RT, dim > Kaskade::WeakBoundaryValues< LocalInd, RT, Cache, BoundaryCache, dim, Evaluators >::modargTest
 
LocalInd & Kaskade::WeakBoundaryValues< LocalInd, RT, Cache, BoundaryCache, dim, Evaluators >::localInd
 
Cache const & Kaskade::WeakBoundaryValues< LocalInd, RT, Cache, BoundaryCache, dim, Evaluators >::cache
 
BoundaryCache const & Kaskade::WeakBoundaryValues< LocalInd, RT, Cache, BoundaryCache, dim, Evaluators >::boundaryCache
 
Evaluators const & Kaskade::WeakBoundaryValues< LocalInd, RT, Cache, BoundaryCache, dim, Evaluators >::evaluators
 
LocalVectorKaskade::SolveLocalSystem< LocalVector, LocalMatrix >::c
 
LocalMatrixKaskade::SolveLocalSystem< LocalVector, LocalMatrix >::A
 
LocalVectorKaskade::SolveLocalSystem< LocalVector, LocalMatrix >::b
 
LocalSolution const & Kaskade::ScatterLocalSolution< LocalSolution, Evaluators, GlobalSolution >::localSolution
 
Evaluators const & Kaskade::ScatterLocalSolution< LocalSolution, Evaluators, GlobalSolution >::eval
 
GlobalSolution & Kaskade::ScatterLocalSolution< LocalSolution, Evaluators, GlobalSolution >::globalSolution
 
static const int Kaskade::LocalNormalMatrixBlock< LocalMatrix, Evaluators, RT, Cache, Row >::dim = boost::fusion::result_of::value_at_c<Evaluators,0>::type::Space::dim
 
LocalMatrixKaskade::LocalNormalMatrixBlock< LocalMatrix, Evaluators, RT, Cache, Row >::localmatrix
 
RT Kaskade::LocalNormalMatrixBlock< LocalMatrix, Evaluators, RT, Cache, Row >::intEl
 
Evaluators const & Kaskade::LocalNormalMatrixBlock< LocalMatrix, Evaluators, RT, Cache, Row >::evaluators
 
Cache const & Kaskade::LocalNormalMatrixBlock< LocalMatrix, Evaluators, RT, Cache, Row >::cache
 
static const int Kaskade::LocalNormalMatrixRow< LocalMatrix, Evaluators, RT, Cache, VarDesc >::dim = boost::fusion::result_of::value_at_c<Evaluators,0>::type::Space::dim
 
VarDesc Kaskade::LocalNormalMatrixRow< LocalMatrix, Evaluators, RT, Cache, VarDesc >::varDesc
 
LocalMatrixKaskade::LocalNormalMatrixRow< LocalMatrix, Evaluators, RT, Cache, VarDesc >::localmatrix
 
RT Kaskade::LocalNormalMatrixRow< LocalMatrix, Evaluators, RT, Cache, VarDesc >::intEl
 
Evaluators const & Kaskade::LocalNormalMatrixRow< LocalMatrix, Evaluators, RT, Cache, VarDesc >::evaluators
 
Cache const & Kaskade::LocalNormalMatrixRow< LocalMatrix, Evaluators, RT, Cache, VarDesc >::cache
 
LocalRHS & Kaskade::WeakResiduumFull< LocalRHS, RT, Cache, Evaluators >::localRHS
 
RT Kaskade::WeakResiduumFull< LocalRHS, RT, Cache, Evaluators >::intEl
 
Evaluators const & Kaskade::WeakResiduumFull< LocalRHS, RT, Cache, Evaluators >::evaluators
 
Cache const & Kaskade::WeakResiduumFull< LocalRHS, RT, Cache, Evaluators >::cache
 
LocalSolution const & Kaskade::ScatterFullLocalSolution< LocalSolution, Evaluators, GlobalSolution >::localSolution
 
Evaluators const & Kaskade::ScatterFullLocalSolution< LocalSolution, Evaluators, GlobalSolution >::eval
 
GlobalSolution & Kaskade::ScatterFullLocalSolution< LocalSolution, Evaluators, GlobalSolution >::globalSolution
 
VariationalArg< RT, dim > Kaskade::GradientAverageFull< LocalInd, RT, Cache, dim, Evaluators >::modarg
 
LocalInd & Kaskade::GradientAverageFull< LocalInd, RT, Cache, dim, Evaluators >::localInd
 
Cache const & Kaskade::GradientAverageFull< LocalInd, RT, Cache, dim, Evaluators >::cache
 
Cache const & Kaskade::GradientAverageFull< LocalInd, RT, Cache, dim, Evaluators >::cacheNeigh
 
Evaluators const & Kaskade::GradientAverageFull< LocalInd, RT, Cache, dim, Evaluators >::evaluators
 
VariationalArg< RT, dim > Kaskade::WeakBoundaryValuesFull< LocalInd, RT, Cache, BoundaryCache, dim, Evaluators >::modarg
 
VariationalArg< RT, dim > Kaskade::WeakBoundaryValuesFull< LocalInd, RT, Cache, BoundaryCache, dim, Evaluators >::modargB
 
VariationalArg< RT, dim > Kaskade::WeakBoundaryValuesFull< LocalInd, RT, Cache, BoundaryCache, dim, Evaluators >::modargTest
 
LocalInd & Kaskade::WeakBoundaryValuesFull< LocalInd, RT, Cache, BoundaryCache, dim, Evaluators >::localInd
 
Cache const & Kaskade::WeakBoundaryValuesFull< LocalInd, RT, Cache, BoundaryCache, dim, Evaluators >::cache
 
BoundaryCache const & Kaskade::WeakBoundaryValuesFull< LocalInd, RT, Cache, BoundaryCache, dim, Evaluators >::boundaryCache
 
Evaluators const & Kaskade::WeakBoundaryValuesFull< LocalInd, RT, Cache, BoundaryCache, dim, Evaluators >::evaluators
 
static int const Kaskade::BWErrorFunction< Description, Grid, Functional, FunctionalSimpl >::syst = SystDim<RecoverySpace::dim>::value
 
static int const Kaskade::BWErrorFunction< Description, Grid, Functional, FunctionalSimpl >::systFull = SystDimFull<RecoverySpace::dim>::value
 

Detailed Description

Tools for error estimation and local mesh refinement.

The issue of adaptivity is currently in a rather experimental state with several ideas coexisting.

Typedef Documentation

◆ AnsatzVars

template<class Grid , class Space >
template<class RType , class Variables >
typedef Variables Kaskade::HigherOrderRecovery< Grid, Space >::HigherOrderRecoveryFunctional< RType, Variables >::AnsatzVars

Definition at line 265 of file averaging_errorest.hh.

◆ ContRecoveryRepresentation

template<class Description , class Grid , class Functional , class FunctionalSimpl >
typedef ContRecoveryVariableSet::VariableSet Kaskade::BWErrorFunction< Description, Grid, Functional, FunctionalSimpl >::ContRecoveryRepresentation

Definition at line 886 of file bank_weiser_est.hh.

◆ ContRecoverySpace

template<class Description , class Grid , class Functional , class FunctionalSimpl >
typedef FEFunctionSpace<ContinuousLagrangeMapper<double,Grid> > Kaskade::BWErrorFunction< Description, Grid, Functional, FunctionalSimpl >::ContRecoverySpace

Definition at line 883 of file bank_weiser_est.hh.

◆ ContRecoverySpaces

template<class Description , class Grid , class Functional , class FunctionalSimpl >
typedef boost::fusion::vector<ContRecoverySpace const*> Kaskade::BWErrorFunction< Description, Grid, Functional, FunctionalSimpl >::ContRecoverySpaces

Definition at line 884 of file bank_weiser_est.hh.

◆ ContRecoveryVariableSet

template<class Description , class Grid , class Functional , class FunctionalSimpl >
typedef VariableSetDescription<ContRecoverySpaces,Description> Kaskade::BWErrorFunction< Description, Grid, Functional, FunctionalSimpl >::ContRecoveryVariableSet

Definition at line 885 of file bank_weiser_est.hh.

◆ DerivativeType

template<typename Function1 , typename Function2 >
typedef Function1::DerivativeType Kaskade::FunctionViews::Difference< Function1, Function2 >::DerivativeType

Definition at line 78 of file averaging_errorest.hh.

◆ ErrorFunction

template<class Grid , class Space >
typedef ErrorFunctionSpace::template Element<1>::type Kaskade::HigherOrderRecovery< Grid, Space >::ErrorFunction

Definition at line 250 of file averaging_errorest.hh.

◆ ErrorFunctionSpace

template<class Grid , class Space >
typedef Space Kaskade::HigherOrderRecovery< Grid, Space >::ErrorFunctionSpace

Definition at line 247 of file averaging_errorest.hh.

◆ ErrorGradientFunction

template<class Grid , class Space >
typedef ErrorGradientFunctionSpace::template Element<Grid::dimension>::type Kaskade::HigherOrderRecovery< Grid, Space >::ErrorGradientFunction

Definition at line 249 of file averaging_errorest.hh.

◆ ErrorGradientFunctionSpace

template<class Grid , class Space >
typedef DiscontSpace Kaskade::HigherOrderRecovery< Grid, Space >::ErrorGradientFunctionSpace

Definition at line 246 of file averaging_errorest.hh.

◆ GManager

Definition at line 318 of file embedded_errorest.hh.

◆ RecoveryRepresentation

template<class Description , class Grid , class Functional , class FunctionalSimpl >
typedef RecoveryVariableSet::VariableSet Kaskade::BWErrorFunction< Description, Grid, Functional, FunctionalSimpl >::RecoveryRepresentation

Definition at line 879 of file bank_weiser_est.hh.

◆ RecoverySpace

template<class Description , class Grid , class Functional , class FunctionalSimpl >
typedef FEFunctionSpace<DiscontinuousLagrangeMapper<double,Grid> > Kaskade::BWErrorFunction< Description, Grid, Functional, FunctionalSimpl >::RecoverySpace

Definition at line 876 of file bank_weiser_est.hh.

◆ RecoverySpaces

template<class Description , class Grid , class Functional , class FunctionalSimpl >
typedef boost::fusion::vector<RecoverySpace const*> Kaskade::BWErrorFunction< Description, Grid, Functional, FunctionalSimpl >::RecoverySpaces

Definition at line 877 of file bank_weiser_est.hh.

◆ RecoveryVariableSet

template<class Description , class Grid , class Functional , class FunctionalSimpl >
typedef VariableSetDescription<RecoverySpaces,Description> Kaskade::BWErrorFunction< Description, Grid, Functional, FunctionalSimpl >::RecoveryVariableSet

Definition at line 878 of file bank_weiser_est.hh.

◆ RT

template<class Grid , class Space >
template<class RType , class Variables >
typedef RType Kaskade::HigherOrderRecovery< Grid, Space >::HigherOrderRecoveryFunctional< RType, Variables >::RT

Definition at line 263 of file averaging_errorest.hh.

◆ Scalar

template<typename Function1 , typename Function2 >
typedef Function1::Scalar Kaskade::FunctionViews::Difference< Function1, Function2 >::Scalar

Definition at line 79 of file averaging_errorest.hh.

◆ Self

Definition at line 319 of file embedded_errorest.hh.

◆ Space

template<typename Function1 , typename Function2 >
typedef Function1::Space Kaskade::FunctionViews::Difference< Function1, Function2 >::Space

Definition at line 76 of file averaging_errorest.hh.

◆ TestVars

template<class Grid , class Space >
template<class RType , class Variables >
typedef Variables Kaskade::HigherOrderRecovery< Grid, Space >::HigherOrderRecoveryFunctional< RType, Variables >::TestVars

Definition at line 264 of file averaging_errorest.hh.

◆ ValueType

template<typename Function1 , typename Function2 >
typedef Function1::ValueType Kaskade::FunctionViews::Difference< Function1, Function2 >::ValueType

Definition at line 77 of file averaging_errorest.hh.

Function Documentation

◆ BWErrorIndicator()

template<class Description , class Function , class Functional >
CellData< typenameFunction::Grid >::CellDataVector Kaskade::BWErrorIndicator ( Function const &  f,
Functional const &  vf 
)

Construct an error indicator in the flavour of Bank/Weiser.

Definition at line 904 of file bank_weiser_est.hh.

◆ coarsening() [1/2]

template<class VariableSetDescription , class Scaling >
void Kaskade::coarsening ( VariableSetDescription const &  varDesc,
typename VariableSetDescription::VariableSet const &  sol,
Scaling const &  scaling,
std::vector< std::pair< double, double > > const &  tol,
GridManager< typename VariableSetDescription::Grid > &  gridManager,
int  verbosity = 1,
int  minRefLevel = 0 
)

In order to maintain compatibility with existing code, this overload is needed, as non const reference parameters (coarsenedCells) can not have default values. All it does is call the original method with a temporary parameter.

Definition at line 263 of file coarsening.hh.

Referenced by Kaskade::coarsening().

◆ coarsening() [2/2]

template<class VariableSetDescription , class Scaling >
void Kaskade::coarsening ( VariableSetDescription const &  varDesc,
typename VariableSetDescription::VariableSet const &  sol,
Scaling const &  scaling,
std::vector< std::pair< double, double > > const &  tol,
GridManager< typename VariableSetDescription::Grid > &  gridManager,
std::vector< bool > &  coarsenedCells,
int  verbosity = 1,
int  minRefLevel = 0 
)

coarsening routine

Perform a projection from a fine grid onto a coarser grid. If the error is small, locally coarsen the grid there.

Parameters
varDesc
sol
scaling
tol
gridManager
coarsenedCells
verbosity
minRefLeveldo not coarse cells that are on this level or below.

Definition at line 289 of file coarsening.hh.

◆ createBoundaryCache()

template<class Grid , class Space >
template<class RType , class Variables >
BoundaryCache Kaskade::HigherOrderRecovery< Grid, Space >::HigherOrderRecoveryFunctional< RType, Variables >::createBoundaryCache ( int  flags = 7) const
inline

Definition at line 308 of file averaging_errorest.hh.

◆ createDomainCache()

template<class Grid , class Space >
template<class RType , class Variables >
DomainCache Kaskade::HigherOrderRecovery< Grid, Space >::HigherOrderRecoveryFunctional< RType, Variables >::createDomainCache ( int  flags = 7) const
inline

Definition at line 307 of file averaging_errorest.hh.

◆ d0()

template<class Grid , class Space >
template<class RType , class Variables >
RT Kaskade::HigherOrderRecovery< Grid, Space >::HigherOrderRecoveryFunctional< RType, Variables >::DomainCache::d0 ( ) const
inline

Definition at line 288 of file averaging_errorest.hh.

◆ d1()

template<class Grid , class Space >
template<class RType , class Variables >
template<int row, int dim>
Dune::FieldVector< RT, 1 > Kaskade::HigherOrderRecovery< Grid, Space >::HigherOrderRecoveryFunctional< RType, Variables >::DomainCache::d1 ( VariationalArg< RT, dim > const &  arg) const
inline

Definition at line 290 of file averaging_errorest.hh.

◆ d2()

template<class Grid , class Space >
template<class RType , class Variables >
template<int row, int col, int dim>
Dune::FieldMatrix< RT, 1, 1 > Kaskade::HigherOrderRecovery< Grid, Space >::HigherOrderRecoveryFunctional< RType, Variables >::DomainCache::d2 ( VariationalArg< RT, dim > const &  arg1,
VariationalArg< RT, dim > const &  arg2 
) const
inline

Definition at line 293 of file averaging_errorest.hh.

◆ derivative()

template<typename Function1 , typename Function2 >
DerivativeType Kaskade::FunctionViews::Difference< Function1, Function2 >::derivative ( typename Function1::Space::Evaluator  eval) const
inline

Definition at line 99 of file averaging_errorest.hh.

◆ Difference()

template<typename Function1 , typename Function2 >
Kaskade::FunctionViews::Difference< Function1, Function2 >::Difference ( Function1 const &  f1_,
Function2 const &  f2_ 
)
inline

Definition at line 86 of file averaging_errorest.hh.

◆ DomainCache()

template<class Grid , class Space >
template<class RType , class Variables >
Kaskade::HigherOrderRecovery< Grid, Space >::HigherOrderRecoveryFunctional< RType, Variables >::DomainCache::DomainCache ( ErrorGradientFunction const &  u_)
inline

Definition at line 277 of file averaging_errorest.hh.

◆ edgeAveraging()

template<class VariableDescriptions , int sysdim, class Result , class F , class Spaces , class ExtendedSpaces >
void Kaskade::edgeAveraging ( Result &  result,
F const &  f,
Spaces const &  spaces,
ExtendedSpaces const &  extendedSpaces 
)

Computes an error representation function, which is useful for goal oriented adaptivity.

Arguments

  • result : output: variable set of error functions
  • varDesc : description of the testfunctions
  • f : functional, the residual of which is evaluated
  • spaces : spaces of the ansatz functions x, neede for the evaluation of f
  • extended spaces: spaces, where the error functions live
Attention
: this routine is not yet fully general

Definition at line 385 of file bank_weiser_est.hh.

◆ edgeAveragingFull()

template<class VariableDescriptions , int sysdim, class Result , class F , class FS , class Spaces , class ExtendedSpaces >
void Kaskade::edgeAveragingFull ( Result &  result,
F const &  f,
FS const &  fs,
Spaces const &  spaces,
ExtendedSpaces const &  extendedSpaces 
)

Computes an error representation function, which is useful for goal oriented adaptivity.

Arguments

  • result : output: variable set of error functions
  • varDesc : description of the testfunctions
  • f : functional, the residual of which is evaluated
  • spaces : spaces of the ansatz functions x, neede for the evaluation of f
  • extended spaces: spaces, where the error functions live
Attention
: this routine is not yet fully general

Definition at line 733 of file bank_weiser_est.hh.

◆ EmbeddedErrorEstimator()

template<class VariableSetDescription , class Scaling = IdentityScaling>
Kaskade::EmbeddedErrorEstimator< VariableSetDescription, Scaling >::EmbeddedErrorEstimator ( GManager gridManager_,
VariableSetDescription const &  varDesc_,
Scaling const &  scaling_ = Scaling() 
)
inline

Constructor.

Both the grid manager and the variable set description objects need to exist until the error estimator is destructed.

Definition at line 327 of file embedded_errorest.hh.

◆ embeddedErrorEstimator()

template<class VariableSetDescription , class Scaling >
bool Kaskade::embeddedErrorEstimator ( VariableSetDescription const &  varDesc,
typename VariableSetDescription::VariableSet const &  err,
typename VariableSetDescription::VariableSet const &  sol,
Scaling const &  scaling,
std::vector< std::pair< double, double > > const &  tol,
GridManager< typename VariableSetDescription::Grid > &  gridManager,
int  verbosity = 1 
)

Embedded error estimation and mesh refinement.

Returns true if the error is below the tolerance, in which case no mesh refinement is performed.

Parameters
erran explicit representation of the estimated error
solthe (approximate) solution
scalingA pointwise nonlinear scaling to be applied before error estimation.

Definition at line 459 of file embedded_errorest.hh.

Referenced by Kaskade::Limex< Eq >::step().

◆ estimate()

template<class VariableSetDescription , class Scaling = IdentityScaling>
bool Kaskade::EmbeddedErrorEstimator< VariableSetDescription, Scaling >::estimate ( typename VariableSetDescription::VariableSet const &  err,
typename VariableSetDescription::VariableSet const &  sol 
) const
inline

perform error estimation

Definition at line 334 of file embedded_errorest.hh.

Referenced by Kaskade::embeddedErrorEstimator().

◆ evaluateAt()

template<class Grid , class Space >
template<class RType , class Variables >
template<class Position , class Evaluators >
void Kaskade::HigherOrderRecovery< Grid, Space >::HigherOrderRecoveryFunctional< RType, Variables >::DomainCache::evaluateAt ( Position const &  x,
Evaluators const &  evaluators 
)
inline

Definition at line 282 of file averaging_errorest.hh.

◆ getErrorFunction() [1/2]

template<class Grid , class Space >
void Kaskade::HigherOrderRecovery< Grid, Space >::getErrorFunction ( ErrorFunction ex,
ErrorGradientFunction const &  gex 
)
inline

Definition at line 333 of file averaging_errorest.hh.

◆ getErrorFunction() [2/2]

template<class Description , class Grid , class Functional , class FunctionalSimpl >
template<class Spaces >
void Kaskade::BWErrorFunction< Description, Grid, Functional, FunctionalSimpl >::getErrorFunction ( RecoveryRepresentation recovery,
Spaces const &  spaces,
FunctionalSimpl const &  vf 
)
inline

Definition at line 889 of file bank_weiser_est.hh.

◆ getFullErrorFunction()

template<class Description , class Grid , class Functional , class FunctionalSimpl >
template<class Spaces >
void Kaskade::BWErrorFunction< Description, Grid, Functional, FunctionalSimpl >::getFullErrorFunction ( RecoveryRepresentation recovery,
Spaces const &  spaces,
Functional const &  vf,
FunctionalSimpl const &  vfs 
)
inline

Definition at line 895 of file bank_weiser_est.hh.

◆ getLocalIntegral()

template<typename Space >
CellData< Grid, ValueType >::CellDataVector & Kaskade::LocalIntegral< Space >::LocalIntegrator::getLocalIntegral ( )
inline

Definition at line 149 of file averaging_errorest.hh.

◆ GradientAverage()

template<class LocalInd , class RT , class Cache , int dim, class Evaluators >
Kaskade::GradientAverage< LocalInd, RT, Cache, dim, Evaluators >::GradientAverage ( LocalInd &  localInd_,
Dune::FieldVector< RT, dim >const &  outernormal,
Cache const &  cache_,
Cache const &  cacheNeigh_,
Evaluators const &  evaluators_ 
)
inline

Definition at line 204 of file bank_weiser_est.hh.

◆ GradientAverageFull()

template<class LocalInd , class RT , class Cache , int dim, class Evaluators >
Kaskade::GradientAverageFull< LocalInd, RT, Cache, dim, Evaluators >::GradientAverageFull ( LocalInd &  localInd_,
Dune::FieldVector< RT, dim >const &  outernormal,
Cache const &  cache_,
Cache const &  cacheNeigh_,
Evaluators const &  evaluators_ 
)
inline

Definition at line 646 of file bank_weiser_est.hh.

◆ gradientAveraging() [1/2]

template<class Function >
CellData< typenameFunction::Space::Grid, typenameFunction::ValueType >::CellDataVector Kaskade::gradientAveraging ( Function const &  f)

Perform gradient averaging in order to construct an error estimator.

The result is a CellDataVector, from which an object of the class CellData can be constructed. With the functionality of this class an adaptive refinement procedure can be driven easily

Definition at line 180 of file averaging_errorest.hh.

◆ gradientAveraging() [2/2]

template<class GradientError , class Function >
void Kaskade::gradientAveraging ( GradientError &  dx,
Function const &  x 
)

Perform gradient averaging in order to construct a representation of the gradient error.

The result is a CellDataVector, from which an object of the class CellData can be constructed. With the functionality of this class an adaptive refinement procedure can be driven easily

Definition at line 200 of file averaging_errorest.hh.

◆ HalfGradientJump()

template<class LocalInd , class RT , class Cache , int dim, class Evaluators >
Kaskade::HalfGradientJump< LocalInd, RT, Cache, dim, Evaluators >::HalfGradientJump ( LocalInd &  localInd_,
Dune::FieldVector< RT, dim >const &  outernormal,
Cache const &  cache_,
Cache const &  cacheNeigh_,
Evaluators const &  evaluators_ 
)
inline

Definition at line 79 of file bank_weiser_est.hh.

◆ hierarchicErrorEstimator()

template<class ExtensionVariables , class LinearFunctional >
HierarchicErrorEstimator< LinearFunctional, ExtensionVariables > Kaskade::hierarchicErrorEstimator ( LinearFunctional const &  lf,
typename LinearFunctional::AnsatzVars::VariableSet const &  u 
)

Definition at line 465 of file fem/hierarchicErrorEstimator.hh.

◆ HigherOrderRecoveryFunctional()

template<class Grid , class Space >
template<class RType , class Variables >
Kaskade::HigherOrderRecovery< Grid, Space >::HigherOrderRecoveryFunctional< RType, Variables >::HigherOrderRecoveryFunctional ( ErrorGradientFunction const &  x_)
inline

Definition at line 273 of file averaging_errorest.hh.

◆ inDomain()

template<class Grid , class Space >
template<class RType , class Variables >
template<class Arg >
bool Kaskade::HigherOrderRecovery< Grid, Space >::HigherOrderRecoveryFunctional< RType, Variables >::inDomain ( Arg const &  a) const
inline

Definition at line 271 of file averaging_errorest.hh.

◆ integrationOrder()

template<class Grid , class Space >
template<class RType , class Variables >
template<class Cell >
int Kaskade::HigherOrderRecovery< Grid, Space >::HigherOrderRecoveryFunctional< RType, Variables >::integrationOrder ( Cell const &  ,
int  shapeFunctionOrder,
bool  boundary 
) const
inline

Definition at line 322 of file averaging_errorest.hh.

◆ localNormalMatrix()

template<class LocalMatrix , class Evaluators , class RT , class Cache >
void Kaskade::localNormalMatrix ( LocalMatrix localmatrix,
RT  intEl,
Evaluators const &  evaluators,
Cache const &  cache 
)

Definition at line 318 of file bank_weiser_est.hh.

◆ LocalNormalMatrixBlock()

template<class LocalMatrix , class Evaluators , class RT , class Cache , class Row >
Kaskade::LocalNormalMatrixBlock< LocalMatrix, Evaluators, RT, Cache, Row >::LocalNormalMatrixBlock ( LocalMatrix localmatrix_,
RT  intEl_,
Evaluators const &  evaluators_,
Cache const &  cache_ 
)
inline

Definition at line 528 of file bank_weiser_est.hh.

◆ LocalNormalMatrixRow()

template<class LocalMatrix , class Evaluators , class RT , class Cache , class VarDesc >
Kaskade::LocalNormalMatrixRow< LocalMatrix, Evaluators, RT, Cache, VarDesc >::LocalNormalMatrixRow ( LocalMatrix localmatrix_,
RT  intEl_,
Evaluators const &  evaluators_,
Cache const &  cache_ 
)
inline

Definition at line 557 of file bank_weiser_est.hh.

◆ lowOrderInterpolation()

template<class Function >
CellData< typenameFunction::Space::Grid, typenameFunction::ValueType >::CellDataVector Kaskade::lowOrderInterpolation ( Function const &  f)

Perform lower order interpolation in order to construct an error estimator.

The result is a CellDataVector, from which an object of the class CellData can be constructed. With the functionality of this class an adaptive refinement procedure can be driven easily

Definition at line 214 of file averaging_errorest.hh.

◆ operator()() [1/17]

template<class LocalMatrix , class Evaluators , class RT , class Cache , class Row >
template<class Col >
void Kaskade::LocalNormalMatrixBlock< LocalMatrix, Evaluators, RT, Cache, Row >::operator() ( Col const &  ) const
inline

Definition at line 534 of file bank_weiser_est.hh.

◆ operator()() [2/17]

template<typename Space >
template<typename Function >
CellData< Grid, ValueType >::CellDataVector Kaskade::LocalIntegral< Space >::operator() ( Function  f)
inline

Perform local integration for FunctionSpaceElement or FunctionViews (more efficient)

Definition at line 167 of file averaging_errorest.hh.

◆ operator()() [3/17]

template<typename Space >
template<typename Function >
CellData< Grid, ValueType >::CellDataVector Kaskade::LocalIntegral< Space >::operator() ( Function  f,
Space  s 
)
inline

Perform local integration for WeakFunctionViews (less efficient)

Definition at line 158 of file averaging_errorest.hh.

◆ operator()() [4/17]

template<class LocalMatrix , class Evaluators , class RT , class Cache , class VarDesc >
template<class Row >
void Kaskade::LocalNormalMatrixRow< LocalMatrix, Evaluators, RT, Cache, VarDesc >::operator() ( Row const &  ) const
inline

Definition at line 563 of file bank_weiser_est.hh.

◆ operator()() [5/17]

template<typename Space >
void Kaskade::LocalIntegral< Space >::LocalIntegrator::operator() ( typename Cell::Entity const &  ci,
QuadPoint const &  q,
ValueType  v 
)
inline

Definition at line 136 of file averaging_errorest.hh.

◆ operator()() [6/17]

template<class LocalInd , class RT , class Cache , int dim, class Evaluators >
template<class Variable >
void Kaskade::HalfGradientJump< LocalInd, RT, Cache, dim, Evaluators >::operator() ( Variable const &  ) const
inline

Definition at line 91 of file bank_weiser_est.hh.

◆ operator()() [7/17]

template<class LocalInd , class RT , class Cache , class BoundaryCache , int dim, class Evaluators >
template<class Variable >
void Kaskade::StrongBoundaryValues< LocalInd, RT, Cache, BoundaryCache, dim, Evaluators >::operator() ( Variable const &  ) const
inline

Definition at line 126 of file bank_weiser_est.hh.

◆ operator()() [8/17]

template<class LocalRHS , class RT , class Cache , class Evaluators >
template<class Variable >
void Kaskade::WeakResiduum< LocalRHS, RT, Cache, Evaluators >::operator() ( Variable const &  ) const
inline

Definition at line 154 of file bank_weiser_est.hh.

◆ operator()() [9/17]

template<class LocalRHS , class RT , class Cache , class Evaluators >
template<class Variable >
void Kaskade::WeakResiduumMainPart< LocalRHS, RT, Cache, Evaluators >::operator() ( Variable const &  ) const
inline

Definition at line 181 of file bank_weiser_est.hh.

◆ operator()() [10/17]

template<class LocalInd , class RT , class Cache , int dim, class Evaluators >
template<class Variable >
void Kaskade::GradientAverage< LocalInd, RT, Cache, dim, Evaluators >::operator() ( Variable const &  ) const
inline

Definition at line 216 of file bank_weiser_est.hh.

◆ operator()() [11/17]

template<class LocalInd , class RT , class Cache , class BoundaryCache , int dim, class Evaluators >
template<class Variable >
void Kaskade::WeakBoundaryValues< LocalInd, RT, Cache, BoundaryCache, dim, Evaluators >::operator() ( Variable const &  ) const
inline

Definition at line 252 of file bank_weiser_est.hh.

◆ operator()() [12/17]

template<class LocalVector , class LocalMatrix >
template<class Variable >
void Kaskade::SolveLocalSystem< LocalVector, LocalMatrix >::operator() ( Variable const &  ) const
inline

Definition at line 288 of file bank_weiser_est.hh.

◆ operator()() [13/17]

template<class LocalSolution , class Evaluators , class GlobalSolution >
template<class Variable >
void Kaskade::ScatterLocalSolution< LocalSolution, Evaluators, GlobalSolution >::operator() ( Variable const &  ) const
inline

Definition at line 360 of file bank_weiser_est.hh.

◆ operator()() [14/17]

template<class LocalRHS , class RT , class Cache , class Evaluators >
template<class Variable >
void Kaskade::WeakResiduumFull< LocalRHS, RT, Cache, Evaluators >::operator() ( Variable const &  ) const
inline

Definition at line 604 of file bank_weiser_est.hh.

◆ operator()() [15/17]

template<class LocalSolution , class Evaluators , class GlobalSolution >
template<class Variable >
void Kaskade::ScatterFullLocalSolution< LocalSolution, Evaluators, GlobalSolution >::operator() ( Variable const &  ) const
inline

Definition at line 627 of file bank_weiser_est.hh.

◆ operator()() [16/17]

template<class LocalInd , class RT , class Cache , int dim, class Evaluators >
template<class Variable >
void Kaskade::GradientAverageFull< LocalInd, RT, Cache, dim, Evaluators >::operator() ( Variable const &  ) const
inline

Definition at line 658 of file bank_weiser_est.hh.

◆ operator()() [17/17]

template<class LocalInd , class RT , class Cache , class BoundaryCache , int dim, class Evaluators >
template<class Variable >
void Kaskade::WeakBoundaryValuesFull< LocalInd, RT, Cache, BoundaryCache, dim, Evaluators >::operator() ( Variable const &  ) const
inline

Definition at line 694 of file bank_weiser_est.hh.

◆ order()

template<typename Function1 , typename Function2 >
template<class SFS >
int Kaskade::FunctionViews::Difference< Function1, Function2 >::order ( SFS const &  sfs) const
inline

Definition at line 82 of file averaging_errorest.hh.

◆ projectHierarchically()

template<class VariableSetDescription >
void Kaskade::projectHierarchically ( VariableSet< VariableSetDescription > &  f)

Projects the given FE function onto the the polynomial ansatz subspace of one order lower. This relies on the hierarchic projection defined by the shape function sets on each cell.

For continuous spaces and order=1 the result is probably undefined.

Definition at line 100 of file embedded_errorest.hh.

Referenced by Kaskade::Limex< Eq >::step(), and Kaskade::uniformEmbeddedErrorEstimation().

◆ rank1KernelVector()

template<class LocalVector , class Evaluators , class RT >
void Kaskade::rank1KernelVector ( LocalVector localvector,
RT  intEl,
Evaluators const &  evaluators 
)

Definition at line 342 of file bank_weiser_est.hh.

◆ residualTimesTestFunction()

template<class ErrorDescriptions , class F , class FS , class TestFunctions , class Spaces , class TestSpaces >
void Kaskade::residualTimesTestFunction ( std::vector< Dune::FieldVector< typename SpaceType< Spaces, 0 >::type::RT, boost::fusion::result_of::size< ErrorDescriptions >::type::value > > &  ind,
ErrorDescriptions const &  varDesc,
F const &  f,
FS const &  fs,
TestFunctions const &  tf,
Spaces const &  spaces,
TestSpaces const &  testSpaces 
)

Evaluates strong residual, applied to some test-function <f(x), tf>

Arguments

  • ind : output vector: for each equation of the system and each cell the result of the computation
  • varDesc : description of the testfunctions
  • f : functional, the residual of which is evaluated
  • tf : testfunctions the residual is applied to
  • spaces : spaces of the ansatz functions x
  • testSpaces : spaces of the test functions tf

Definition at line 132 of file residual_errorest.hh.

◆ ScatterFullLocalSolution()

template<class LocalSolution , class Evaluators , class GlobalSolution >
Kaskade::ScatterFullLocalSolution< LocalSolution, Evaluators, GlobalSolution >::ScatterFullLocalSolution ( LocalSolution const &  localSolution_,
Evaluators const &  evaluators_,
GlobalSolution &  globalSolution_ 
)
inline

Definition at line 622 of file bank_weiser_est.hh.

◆ ScatterLocalSolution()

template<class LocalSolution , class Evaluators , class GlobalSolution >
Kaskade::ScatterLocalSolution< LocalSolution, Evaluators, GlobalSolution >::ScatterLocalSolution ( LocalSolution const &  localSolution_,
Evaluators const &  evaluators_,
GlobalSolution &  globalSolution_ 
)
inline

Definition at line 355 of file bank_weiser_est.hh.

◆ setCriterion()

template<class VariableSetDescription , class Scaling = IdentityScaling>
Self & Kaskade::EmbeddedErrorEstimator< VariableSetDescription, Scaling >::setCriterion ( RefinementCriterion const &  criterion_)
inline

set the refinement criterion

Definition at line 419 of file embedded_errorest.hh.

Referenced by Kaskade::embeddedErrorEstimator().

◆ setScaling()

template<class VariableSetDescription , class Scaling = IdentityScaling>
Self & Kaskade::EmbeddedErrorEstimator< VariableSetDescription, Scaling >::setScaling ( Scaling const &  scaling_)
inline

set the scaling

Definition at line 410 of file embedded_errorest.hh.

◆ setTolerances()

template<class VariableSetDescription , class Scaling = IdentityScaling>
Self & Kaskade::EmbeddedErrorEstimator< VariableSetDescription, Scaling >::setTolerances ( std::vector< std::pair< double, double > > const &  tol_)
inline

set the tolerances

The tolerance for each variable consists of an absolute part (aTOL) and a relative part (rTOL). Sufficient accuracy is assumed, if the error \( \epsilon \) of the approximate solution \( u \) satisfies

\[ \|\epsilon\|^2 \le \mathrm{aTOL}^2 + \mathrm{rTOL}^2 \|u\|^2. \]

Defaults to aTOL=0 and rTOL=0.01 for all variables.

Definition at line 401 of file embedded_errorest.hh.

Referenced by Kaskade::embeddedErrorEstimator().

◆ setVerbosity()

template<class VariableSetDescription , class Scaling = IdentityScaling>
Self & Kaskade::EmbeddedErrorEstimator< VariableSetDescription, Scaling >::setVerbosity ( int  verbosity_)
inline

set the verbosity level

Verbosity levels:

  • 0: no output
  • 1: squared norms of error and solution are written to standard output

Definition at line 432 of file embedded_errorest.hh.

Referenced by Kaskade::embeddedErrorEstimator().

◆ solveLocalFullSystem()

template<class LocalVector , class LocalMatrix >
void Kaskade::solveLocalFullSystem ( LocalVector c,
LocalMatrix A,
LocalVector b 
)

Definition at line 578 of file bank_weiser_est.hh.

Referenced by Kaskade::edgeAveragingFull().

◆ SolveLocalSystem()

template<class LocalVector , class LocalMatrix >
Kaskade::SolveLocalSystem< LocalVector, LocalMatrix >::SolveLocalSystem ( LocalVector c_,
LocalMatrix A_,
LocalVector b_ 
)
inline

Definition at line 280 of file bank_weiser_est.hh.

◆ space()

template<typename Function1 , typename Function2 >
Space const & Kaskade::FunctionViews::Difference< Function1, Function2 >::space ( ) const
inline

Definition at line 84 of file averaging_errorest.hh.

◆ StrongBoundaryValues()

template<class LocalInd , class RT , class Cache , class BoundaryCache , int dim, class Evaluators >
Kaskade::StrongBoundaryValues< LocalInd, RT, Cache, BoundaryCache, dim, Evaluators >::StrongBoundaryValues ( LocalInd &  localInd_,
RT &  integrationElement,
Dune::FieldVector< RT, dim >const &  outernormal,
Cache const &  cache_,
BoundaryCache const &  cacheBoundary_,
Evaluators const &  evaluators_ 
)
inline

Definition at line 109 of file bank_weiser_est.hh.

◆ uniformEmbeddedErrorEstimation()

template<class VariableSet , class GridManager >
std::array< size_t, 3 > Kaskade::uniformEmbeddedErrorEstimation ( VariableSet const &  u,
Dune::FieldVector< double, VariableSet::Descriptions::noOfVariables > const &  tol,
GridManager gridManager,
double  rhoMin = 0.1,
double  rhoMax = 0.9 
)

Embedded error estimation and simultaneous mesh refinement/coarsening.

This computes for all cells \( T \) the value \( \epsilon_T = \max_i \max_x |u_i(x)|/tol_i \) and marks all cells with \( \epsilon_T > \rho_{\max} \) for refinement, all cells with \( \epsilon_T < \rho_{\min} \) for coarsening, and unmarks all other cells.

Note that if performed in a loop, simultaneous refinement and coarsening can in some circumstances lead to non-termination by cycling through the same resulting grids. This is in particular the case if \( \rho_{\rm min} \) is too large. In such cases, reduce \( \rho_{\min} \) or consider a separation of refinement and coarsening.

Returns
a triple (a,b,c) with a the number of inacceptable cells with \( \epsilon_T > 1 \), b the number of cells marked for refinement, and c the number of cells marked for coarsening.

Definition at line 254 of file embedded_errorest.hh.

◆ value() [1/2]

template<typename Function1 , typename Function2 >
template<class EPtr , class V >
ValueType Kaskade::FunctionViews::Difference< Function1, Function2 >::value ( EPtr const &  ci,
V const &  v 
) const
inline

Definition at line 94 of file averaging_errorest.hh.

◆ value() [2/2]

template<typename Function1 , typename Function2 >
ValueType Kaskade::FunctionViews::Difference< Function1, Function2 >::value ( typename Function1::Space::Evaluator  eval) const
inline

Definition at line 88 of file averaging_errorest.hh.

◆ WeakBoundaryValues()

template<class LocalInd , class RT , class Cache , class BoundaryCache , int dim, class Evaluators >
Kaskade::WeakBoundaryValues< LocalInd, RT, Cache, BoundaryCache, dim, Evaluators >::WeakBoundaryValues ( LocalInd &  localInd_,
RT &  integrationElement,
Dune::FieldVector< RT, dim >const &  outernormal,
Cache const &  cache_,
BoundaryCache const &  cacheBoundary_,
Evaluators const &  evaluators_ 
)
inline

Definition at line 235 of file bank_weiser_est.hh.

◆ WeakBoundaryValuesFull()

template<class LocalInd , class RT , class Cache , class BoundaryCache , int dim, class Evaluators >
Kaskade::WeakBoundaryValuesFull< LocalInd, RT, Cache, BoundaryCache, dim, Evaluators >::WeakBoundaryValuesFull ( LocalInd &  localInd_,
RT &  integrationElement,
Dune::FieldVector< RT, dim >const &  outernormal,
Cache const &  cache_,
BoundaryCache const &  cacheBoundary_,
Evaluators const &  evaluators_ 
)
inline

Definition at line 677 of file bank_weiser_est.hh.

◆ WeakResiduum()

template<class LocalRHS , class RT , class Cache , class Evaluators >
Kaskade::WeakResiduum< LocalRHS, RT, Cache, Evaluators >::WeakResiduum ( LocalRHS &  localRHS_,
RT  intEl_,
Cache const &  cache_,
Evaluators const &  evaluators_ 
)
inline

Definition at line 148 of file bank_weiser_est.hh.

◆ WeakResiduumFull()

template<class LocalRHS , class RT , class Cache , class Evaluators >
Kaskade::WeakResiduumFull< LocalRHS, RT, Cache, Evaluators >::WeakResiduumFull ( LocalRHS &  localRHS_,
RT  intEl_,
Cache const &  cache_,
Evaluators const &  evaluators_ 
)
inline

Definition at line 598 of file bank_weiser_est.hh.

◆ WeakResiduumMainPart()

template<class LocalRHS , class RT , class Cache , class Evaluators >
Kaskade::WeakResiduumMainPart< LocalRHS, RT, Cache, Evaluators >::WeakResiduumMainPart ( LocalRHS &  localRHS_,
RT  intEl_,
Cache const &  cache_,
Evaluators const &  evaluators_ 
)
inline

Definition at line 175 of file bank_weiser_est.hh.

Variable Documentation

◆ A

◆ b

◆ boundaryCache [1/3]

template<class LocalInd , class RT , class Cache , class BoundaryCache , int dim, class Evaluators >
BoundaryCache const& Kaskade::StrongBoundaryValues< LocalInd, RT, Cache, BoundaryCache, dim, Evaluators >::boundaryCache

◆ boundaryCache [2/3]

template<class LocalInd , class RT , class Cache , class BoundaryCache , int dim, class Evaluators >
BoundaryCache const& Kaskade::WeakBoundaryValues< LocalInd, RT, Cache, BoundaryCache, dim, Evaluators >::boundaryCache

◆ boundaryCache [3/3]

template<class LocalInd , class RT , class Cache , class BoundaryCache , int dim, class Evaluators >
BoundaryCache const& Kaskade::WeakBoundaryValuesFull< LocalInd, RT, Cache, BoundaryCache, dim, Evaluators >::boundaryCache

◆ c

◆ cache [1/11]

template<class LocalInd , class RT , class Cache , int dim, class Evaluators >
Cache const& Kaskade::HalfGradientJump< LocalInd, RT, Cache, dim, Evaluators >::cache

◆ cache [2/11]

template<class LocalInd , class RT , class Cache , class BoundaryCache , int dim, class Evaluators >
Cache const& Kaskade::StrongBoundaryValues< LocalInd, RT, Cache, BoundaryCache, dim, Evaluators >::cache

◆ cache [3/11]

template<class LocalRHS , class RT , class Cache , class Evaluators >
Cache const& Kaskade::WeakResiduum< LocalRHS, RT, Cache, Evaluators >::cache

◆ cache [4/11]

template<class LocalRHS , class RT , class Cache , class Evaluators >
Cache const& Kaskade::WeakResiduumMainPart< LocalRHS, RT, Cache, Evaluators >::cache

◆ cache [5/11]

template<class LocalInd , class RT , class Cache , int dim, class Evaluators >
Cache const& Kaskade::GradientAverage< LocalInd, RT, Cache, dim, Evaluators >::cache

◆ cache [6/11]

template<class LocalInd , class RT , class Cache , class BoundaryCache , int dim, class Evaluators >
Cache const& Kaskade::WeakBoundaryValues< LocalInd, RT, Cache, BoundaryCache, dim, Evaluators >::cache

◆ cache [7/11]

template<class LocalMatrix , class Evaluators , class RT , class Cache , class Row >
Cache const& Kaskade::LocalNormalMatrixBlock< LocalMatrix, Evaluators, RT, Cache, Row >::cache

◆ cache [8/11]

template<class LocalMatrix , class Evaluators , class RT , class Cache , class VarDesc >
Cache const& Kaskade::LocalNormalMatrixRow< LocalMatrix, Evaluators, RT, Cache, VarDesc >::cache

◆ cache [9/11]

template<class LocalRHS , class RT , class Cache , class Evaluators >
Cache const& Kaskade::WeakResiduumFull< LocalRHS, RT, Cache, Evaluators >::cache

◆ cache [10/11]

template<class LocalInd , class RT , class Cache , int dim, class Evaluators >
Cache const& Kaskade::GradientAverageFull< LocalInd, RT, Cache, dim, Evaluators >::cache

◆ cache [11/11]

template<class LocalInd , class RT , class Cache , class BoundaryCache , int dim, class Evaluators >
Cache const& Kaskade::WeakBoundaryValuesFull< LocalInd, RT, Cache, BoundaryCache, dim, Evaluators >::cache

◆ cacheNeigh [1/3]

template<class LocalInd , class RT , class Cache , int dim, class Evaluators >
Cache const& Kaskade::HalfGradientJump< LocalInd, RT, Cache, dim, Evaluators >::cacheNeigh

◆ cacheNeigh [2/3]

template<class LocalInd , class RT , class Cache , int dim, class Evaluators >
Cache const& Kaskade::GradientAverage< LocalInd, RT, Cache, dim, Evaluators >::cacheNeigh

◆ cacheNeigh [3/3]

template<class LocalInd , class RT , class Cache , int dim, class Evaluators >
Cache const& Kaskade::GradientAverageFull< LocalInd, RT, Cache, dim, Evaluators >::cacheNeigh

◆ dim [1/4]

template<class LocalRHS , class RT , class Cache , class Evaluators >
const int Kaskade::WeakResiduum< LocalRHS, RT, Cache, Evaluators >::dim = boost::fusion::result_of::value_at_c<Evaluators,0>::type::Space::dim
static

Definition at line 147 of file bank_weiser_est.hh.

◆ dim [2/4]

template<class LocalRHS , class RT , class Cache , class Evaluators >
const int Kaskade::WeakResiduumMainPart< LocalRHS, RT, Cache, Evaluators >::dim = boost::fusion::result_of::value_at_c<Evaluators,0>::type::Space::dim
static

Definition at line 174 of file bank_weiser_est.hh.

◆ dim [3/4]

template<class LocalMatrix , class Evaluators , class RT , class Cache , class Row >
const int Kaskade::LocalNormalMatrixBlock< LocalMatrix, Evaluators, RT, Cache, Row >::dim = boost::fusion::result_of::value_at_c<Evaluators,0>::type::Space::dim
static

Definition at line 527 of file bank_weiser_est.hh.

◆ dim [4/4]

template<class LocalMatrix , class Evaluators , class RT , class Cache , class VarDesc >
const int Kaskade::LocalNormalMatrixRow< LocalMatrix, Evaluators, RT, Cache, VarDesc >::dim = boost::fusion::result_of::value_at_c<Evaluators,0>::type::Space::dim
static

Definition at line 556 of file bank_weiser_est.hh.

◆ eval [1/2]

template<class LocalSolution , class Evaluators , class GlobalSolution >
Evaluators const& Kaskade::ScatterLocalSolution< LocalSolution, Evaluators, GlobalSolution >::eval

◆ eval [2/2]

template<class LocalSolution , class Evaluators , class GlobalSolution >
Evaluators const& Kaskade::ScatterFullLocalSolution< LocalSolution, Evaluators, GlobalSolution >::eval

◆ evaluators [1/11]

template<class LocalInd , class RT , class Cache , int dim, class Evaluators >
Evaluators const& Kaskade::HalfGradientJump< LocalInd, RT, Cache, dim, Evaluators >::evaluators

◆ evaluators [2/11]

template<class LocalInd , class RT , class Cache , class BoundaryCache , int dim, class Evaluators >
Evaluators const& Kaskade::StrongBoundaryValues< LocalInd, RT, Cache, BoundaryCache, dim, Evaluators >::evaluators

◆ evaluators [3/11]

template<class LocalRHS , class RT , class Cache , class Evaluators >
Evaluators const& Kaskade::WeakResiduum< LocalRHS, RT, Cache, Evaluators >::evaluators

◆ evaluators [4/11]

template<class LocalRHS , class RT , class Cache , class Evaluators >
Evaluators const& Kaskade::WeakResiduumMainPart< LocalRHS, RT, Cache, Evaluators >::evaluators

◆ evaluators [5/11]

template<class LocalInd , class RT , class Cache , int dim, class Evaluators >
Evaluators const& Kaskade::GradientAverage< LocalInd, RT, Cache, dim, Evaluators >::evaluators

◆ evaluators [6/11]

template<class LocalInd , class RT , class Cache , class BoundaryCache , int dim, class Evaluators >
Evaluators const& Kaskade::WeakBoundaryValues< LocalInd, RT, Cache, BoundaryCache, dim, Evaluators >::evaluators

◆ evaluators [7/11]

template<class LocalMatrix , class Evaluators , class RT , class Cache , class Row >
Evaluators const& Kaskade::LocalNormalMatrixBlock< LocalMatrix, Evaluators, RT, Cache, Row >::evaluators

◆ evaluators [8/11]

template<class LocalMatrix , class Evaluators , class RT , class Cache , class VarDesc >
Evaluators const& Kaskade::LocalNormalMatrixRow< LocalMatrix, Evaluators, RT, Cache, VarDesc >::evaluators

◆ evaluators [9/11]

template<class LocalRHS , class RT , class Cache , class Evaluators >
Evaluators const& Kaskade::WeakResiduumFull< LocalRHS, RT, Cache, Evaluators >::evaluators

◆ evaluators [10/11]

template<class LocalInd , class RT , class Cache , int dim, class Evaluators >
Evaluators const& Kaskade::GradientAverageFull< LocalInd, RT, Cache, dim, Evaluators >::evaluators

◆ evaluators [11/11]

template<class LocalInd , class RT , class Cache , class BoundaryCache , int dim, class Evaluators >
Evaluators const& Kaskade::WeakBoundaryValuesFull< LocalInd, RT, Cache, BoundaryCache, dim, Evaluators >::evaluators

◆ globalSolution [1/2]

template<class LocalSolution , class Evaluators , class GlobalSolution >
GlobalSolution& Kaskade::ScatterLocalSolution< LocalSolution, Evaluators, GlobalSolution >::globalSolution

◆ globalSolution [2/2]

template<class LocalSolution , class Evaluators , class GlobalSolution >
GlobalSolution& Kaskade::ScatterFullLocalSolution< LocalSolution, Evaluators, GlobalSolution >::globalSolution

◆ id

template<int Id, int PDEId, int SpaceId, int components>
int const Kaskade::EstimatorDescription< Id, PDEId, SpaceId, components >::id = Id
static

Definition at line 41 of file bank_weiser_est.hh.

◆ intEl [1/5]

template<class LocalRHS , class RT , class Cache , class Evaluators >
RT Kaskade::WeakResiduum< LocalRHS, RT, Cache, Evaluators >::intEl

◆ intEl [2/5]

template<class LocalRHS , class RT , class Cache , class Evaluators >
RT Kaskade::WeakResiduumMainPart< LocalRHS, RT, Cache, Evaluators >::intEl

◆ intEl [3/5]

template<class LocalMatrix , class Evaluators , class RT , class Cache , class Row >
RT Kaskade::LocalNormalMatrixBlock< LocalMatrix, Evaluators, RT, Cache, Row >::intEl

◆ intEl [4/5]

template<class LocalMatrix , class Evaluators , class RT , class Cache , class VarDesc >
RT Kaskade::LocalNormalMatrixRow< LocalMatrix, Evaluators, RT, Cache, VarDesc >::intEl

◆ intEl [5/5]

template<class LocalRHS , class RT , class Cache , class Evaluators >
RT Kaskade::WeakResiduumFull< LocalRHS, RT, Cache, Evaluators >::intEl

◆ localInd [1/6]

template<class LocalInd , class RT , class Cache , int dim, class Evaluators >
LocalInd& Kaskade::HalfGradientJump< LocalInd, RT, Cache, dim, Evaluators >::localInd

◆ localInd [2/6]

template<class LocalInd , class RT , class Cache , class BoundaryCache , int dim, class Evaluators >
LocalInd& Kaskade::StrongBoundaryValues< LocalInd, RT, Cache, BoundaryCache, dim, Evaluators >::localInd

◆ localInd [3/6]

template<class LocalInd , class RT , class Cache , int dim, class Evaluators >
LocalInd& Kaskade::GradientAverage< LocalInd, RT, Cache, dim, Evaluators >::localInd

◆ localInd [4/6]

template<class LocalInd , class RT , class Cache , class BoundaryCache , int dim, class Evaluators >
LocalInd& Kaskade::WeakBoundaryValues< LocalInd, RT, Cache, BoundaryCache, dim, Evaluators >::localInd

◆ localInd [5/6]

template<class LocalInd , class RT , class Cache , int dim, class Evaluators >
LocalInd& Kaskade::GradientAverageFull< LocalInd, RT, Cache, dim, Evaluators >::localInd

◆ localInd [6/6]

template<class LocalInd , class RT , class Cache , class BoundaryCache , int dim, class Evaluators >
LocalInd& Kaskade::WeakBoundaryValuesFull< LocalInd, RT, Cache, BoundaryCache, dim, Evaluators >::localInd

◆ localmatrix [1/2]

template<class LocalMatrix , class Evaluators , class RT , class Cache , class Row >
LocalMatrix& Kaskade::LocalNormalMatrixBlock< LocalMatrix, Evaluators, RT, Cache, Row >::localmatrix

◆ localmatrix [2/2]

template<class LocalMatrix , class Evaluators , class RT , class Cache , class VarDesc >
LocalMatrix& Kaskade::LocalNormalMatrixRow< LocalMatrix, Evaluators, RT, Cache, VarDesc >::localmatrix

◆ localRHS [1/3]

template<class LocalRHS , class RT , class Cache , class Evaluators >
LocalRHS& Kaskade::WeakResiduum< LocalRHS, RT, Cache, Evaluators >::localRHS

◆ localRHS [2/3]

template<class LocalRHS , class RT , class Cache , class Evaluators >
LocalRHS& Kaskade::WeakResiduumMainPart< LocalRHS, RT, Cache, Evaluators >::localRHS

◆ localRHS [3/3]

template<class LocalRHS , class RT , class Cache , class Evaluators >
LocalRHS& Kaskade::WeakResiduumFull< LocalRHS, RT, Cache, Evaluators >::localRHS

◆ localSolution [1/2]

template<class LocalSolution , class Evaluators , class GlobalSolution >
LocalSolution const& Kaskade::ScatterLocalSolution< LocalSolution, Evaluators, GlobalSolution >::localSolution

◆ localSolution [2/2]

template<class LocalSolution , class Evaluators , class GlobalSolution >
LocalSolution const& Kaskade::ScatterFullLocalSolution< LocalSolution, Evaluators, GlobalSolution >::localSolution

◆ lumped

template<class Grid , class Space >
template<class RType , class Variables >
template<int row, int col>
bool const Kaskade::HigherOrderRecovery< Grid, Space >::HigherOrderRecoveryFunctional< RType, Variables >::D2< row, col >::lumped = false
static

Definition at line 317 of file averaging_errorest.hh.

◆ m

template<int Id, int PDEId, int SpaceId, int components>
int const Kaskade::EstimatorDescription< Id, PDEId, SpaceId, components >::m = components
static

Definition at line 44 of file bank_weiser_est.hh.

◆ modarg [1/6]

template<class LocalInd , class RT , class Cache , int dim, class Evaluators >
VariationalArg<RT,dim> Kaskade::HalfGradientJump< LocalInd, RT, Cache, dim, Evaluators >::modarg

◆ modarg [2/6]

template<class LocalInd , class RT , class Cache , class BoundaryCache , int dim, class Evaluators >
VariationalArg<RT,dim> Kaskade::StrongBoundaryValues< LocalInd, RT, Cache, BoundaryCache, dim, Evaluators >::modarg

◆ modarg [3/6]

template<class LocalInd , class RT , class Cache , int dim, class Evaluators >
VariationalArg<RT,dim> Kaskade::GradientAverage< LocalInd, RT, Cache, dim, Evaluators >::modarg

◆ modarg [4/6]

template<class LocalInd , class RT , class Cache , class BoundaryCache , int dim, class Evaluators >
VariationalArg<RT,dim> Kaskade::WeakBoundaryValues< LocalInd, RT, Cache, BoundaryCache, dim, Evaluators >::modarg

◆ modarg [5/6]

template<class LocalInd , class RT , class Cache , int dim, class Evaluators >
VariationalArg<RT,dim> Kaskade::GradientAverageFull< LocalInd, RT, Cache, dim, Evaluators >::modarg

◆ modarg [6/6]

template<class LocalInd , class RT , class Cache , class BoundaryCache , int dim, class Evaluators >
VariationalArg<RT,dim> Kaskade::WeakBoundaryValuesFull< LocalInd, RT, Cache, BoundaryCache, dim, Evaluators >::modarg

◆ modargB [1/3]

template<class LocalInd , class RT , class Cache , class BoundaryCache , int dim, class Evaluators >
VariationalArg<RT,dim> Kaskade::StrongBoundaryValues< LocalInd, RT, Cache, BoundaryCache, dim, Evaluators >::modargB

◆ modargB [2/3]

template<class LocalInd , class RT , class Cache , class BoundaryCache , int dim, class Evaluators >
VariationalArg<RT,dim> Kaskade::WeakBoundaryValues< LocalInd, RT, Cache, BoundaryCache, dim, Evaluators >::modargB

◆ modargB [3/3]

template<class LocalInd , class RT , class Cache , class BoundaryCache , int dim, class Evaluators >
VariationalArg<RT,dim> Kaskade::WeakBoundaryValuesFull< LocalInd, RT, Cache, BoundaryCache, dim, Evaluators >::modargB

◆ modargTest [1/3]

template<class LocalInd , class RT , class Cache , class BoundaryCache , int dim, class Evaluators >
VariationalArg<RT,dim> Kaskade::StrongBoundaryValues< LocalInd, RT, Cache, BoundaryCache, dim, Evaluators >::modargTest

◆ modargTest [2/3]

template<class LocalInd , class RT , class Cache , class BoundaryCache , int dim, class Evaluators >
VariationalArg<RT,dim> Kaskade::WeakBoundaryValues< LocalInd, RT, Cache, BoundaryCache, dim, Evaluators >::modargTest

◆ modargTest [3/3]

template<class LocalInd , class RT , class Cache , class BoundaryCache , int dim, class Evaluators >
VariationalArg<RT,dim> Kaskade::WeakBoundaryValuesFull< LocalInd, RT, Cache, BoundaryCache, dim, Evaluators >::modargTest

◆ pdeid

template<int Id, int PDEId, int SpaceId, int components>
int const Kaskade::EstimatorDescription< Id, PDEId, SpaceId, components >::pdeid = PDEId
static

Definition at line 42 of file bank_weiser_est.hh.

◆ present

template<class Grid , class Space >
template<class RType , class Variables >
template<int row, int col>
bool const Kaskade::HigherOrderRecovery< Grid, Space >::HigherOrderRecoveryFunctional< RType, Variables >::D2< row, col >::present = true
static

Definition at line 316 of file averaging_errorest.hh.

◆ spaceIndex

template<int Id, int PDEId, int SpaceId, int components>
int const Kaskade::EstimatorDescription< Id, PDEId, SpaceId, components >::spaceIndex = SpaceId
static

Definition at line 43 of file bank_weiser_est.hh.

◆ symmetric

template<class Grid , class Space >
template<class RType , class Variables >
template<int row, int col>
bool const Kaskade::HigherOrderRecovery< Grid, Space >::HigherOrderRecoveryFunctional< RType, Variables >::D2< row, col >::symmetric = true
static

Definition at line 318 of file averaging_errorest.hh.

◆ syst

template<class Description , class Grid , class Functional , class FunctionalSimpl >
int const Kaskade::BWErrorFunction< Description, Grid, Functional, FunctionalSimpl >::syst = SystDim<RecoverySpace::dim>::value
static

Definition at line 880 of file bank_weiser_est.hh.

◆ systFull

template<class Description , class Grid , class Functional , class FunctionalSimpl >
int const Kaskade::BWErrorFunction< Description, Grid, Functional, FunctionalSimpl >::systFull = SystDimFull<RecoverySpace::dim>::value
static

Definition at line 881 of file bank_weiser_est.hh.

◆ type

template<class Grid , class Space >
template<class RType , class Variables >
ProblemType const Kaskade::HigherOrderRecovery< Grid, Space >::HigherOrderRecoveryFunctional< RType, Variables >::type = VariationalFunctional
static

Definition at line 266 of file averaging_errorest.hh.

◆ value [1/2]

template<int dim>
const int Kaskade::SystDim< dim >::value = (dim+1)+3*(dim-1)
static

Definition at line 66 of file bank_weiser_est.hh.

◆ value [2/2]

template<int dim>
const int Kaskade::SystDimFull< dim >::value = (dim+1)+3*(dim-1)
static

Definition at line 72 of file bank_weiser_est.hh.

◆ varDesc

template<class LocalMatrix , class Evaluators , class RT , class Cache , class VarDesc >
VarDesc Kaskade::LocalNormalMatrixRow< LocalMatrix, Evaluators, RT, Cache, VarDesc >::varDesc

◆ x

template<class Grid , class Space >
template<class RType , class Variables >
ErrorGradientFunction const& Kaskade::HigherOrderRecovery< Grid, Space >::HigherOrderRecoveryFunctional< RType, Variables >::x

Definition at line 310 of file averaging_errorest.hh.