cell_diameter
};
+
+
/**
* Implementation of the error estimator described above. You may give a
* coefficient, but there is a default value which denotes the constant
const types::material_id material_id = numbers::invalid_material_id,
const Strategy strategy = cell_diameter_over_24);
+
+
/**
* Call the @p estimate function, see above, with
* <tt>mapping=MappingQ1<1>()</tt>.
const types::material_id material_id = numbers::invalid_material_id,
const Strategy strategy = cell_diameter_over_24);
+
+
/**
* Same function as above, but accepts more than one solution vectors and
* returns one error vector for each solution vector. For the reason of
const types::material_id material_id = numbers::invalid_material_id,
const Strategy strategy = cell_diameter_over_24);
+
+
/**
* Call the @p estimate function, see above, with
* <tt>mapping=MappingQ1<1>()</tt>.
const Strategy strategy = cell_diameter_over_24);
+
/**
* Equivalent to the set of functions above, except that this one takes a
* quadrature collection for hp-finite element dof handlers.
const Strategy strategy = cell_diameter_over_24);
+
/**
* Equivalent to the set of functions above, except that this one takes a
* quadrature collection for hp-finite element dof handlers.
const Strategy strategy = cell_diameter_over_24);
+
/**
* Equivalent to the set of functions above, except that this one takes a
* quadrature collection for hp-finite element dof handlers.
const Strategy strategy = cell_diameter_over_24);
+
/**
* Equivalent to the set of functions above, except that this one takes a
* quadrature collection for hp-finite element dof handlers.
const types::material_id material_id = numbers::invalid_material_id,
const Strategy strategy = cell_diameter_over_24);
+
+
/**
* Exception
*/
"of vector components of the finite element in use "
"by the DoFHandler object. In the latter case, at "
"least one component needs to be selected.");
+
/**
* Exception
*/
"scalar (has one vector component) or has as many vector "
"components as there are in the finite element used by "
"the DoFHandler argument.");
+
/**
* Exception
*/
"element in use has "
<< arg3
<< " components, and these two numbers need to match.");
+
/**
* Exception
*/
<< " needs to be equal to the number of output vectors, "
<< arg2
<< ". This is not the case in your call of this function.");
+
/**
* Exception
*/
};
-
DEAL_II_NAMESPACE_CLOSE
#endif
DEAL_II_NAMESPACE_OPEN
-
template <int spacedim>
template <typename InputVector>
void
}
+
template <int spacedim>
template <typename InputVector>
void
-template <int spacedim>
-template <typename InputVector>
-void
-KellyErrorEstimator<1, spacedim>::estimate(
- const Mapping<1, spacedim> & /*mapping*/,
- const DoFHandler<1, spacedim> & /*dof_handler*/,
- const hp::QCollection<0> &,
- const std::map<types::boundary_id,
- const Function<spacedim, typename InputVector::value_type> *>
- & /*neumann_bc*/,
- const std::vector<const InputVector *> & /*solutions*/,
- std::vector<Vector<float> *> & /*errors*/,
- const ComponentMask & /*component_mask_*/,
- const Function<spacedim> * /*coefficient*/,
- const unsigned int,
- const types::subdomain_id /*subdomain_id*/,
- const types::material_id /*material_id*/,
- const Strategy /*strategy*/)
-{
- Assert(false, ExcInternalError());
-}
-
-
-
template <int spacedim>
template <typename InputVector>
void
KellyErrorEstimator<1, spacedim>::estimate(
const Mapping<1, spacedim> & mapping,
const DoFHandler<1, spacedim> &dof_handler,
- const Quadrature<0> &,
+ const hp::QCollection<0> &,
const std::map<types::boundary_id,
const Function<spacedim, typename InputVector::value_type> *>
& neumann_bc,
}
+
+template <int spacedim>
+template <typename InputVector>
+void
+KellyErrorEstimator<1, spacedim>::estimate(
+ const Mapping<1, spacedim> & mapping,
+ const DoFHandler<1, spacedim> &dof_handler,
+ const Quadrature<0> & quadrature,
+ const std::map<types::boundary_id,
+ const Function<spacedim, typename InputVector::value_type> *>
+ & neumann_bc,
+ const std::vector<const InputVector *> &solutions,
+ std::vector<Vector<float> *> & errors,
+ const ComponentMask & component_mask,
+ const Function<spacedim> * coefficients,
+ const unsigned int n_threads,
+ const types::subdomain_id subdomain_id,
+ const types::material_id material_id,
+ const Strategy strategy)
+{
+ const hp::QCollection<0> quadrature_collection(quadrature);
+ estimate(mapping,
+ dof_handler,
+ quadrature_collection,
+ neumann_bc,
+ solutions,
+ errors,
+ component_mask,
+ coefficients,
+ n_threads,
+ subdomain_id,
+ material_id,
+ strategy);
+}
+
+
+
// explicit instantiations
#include "error_estimator_1d.inst"