//---------------------------------------------------------------------------
// $Id$
//
-// Copyright (C) 2006, 2007, 2008, 2009, 2010 by the deal.II authors
+// Copyright (C) 2006, 2007, 2008, 2009, 2010, 2011 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
//codimension 1
-template <>
-inline
-void
-FE_Poly<TensorProductPolynomials<1>,1,2>::fill_fe_subface_values (const Mapping<1,2> &,
- const Triangulation<1,2>::cell_iterator &,
- const unsigned int,
- const unsigned int,
- const Quadrature<0> &,
- Mapping<1,2>::InternalDataBase &,
- Mapping<1,2>::InternalDataBase &,
- FEValuesData<1,2> &) const
-{
- AssertThrow(false, ExcNotImplemented());
-}
-
-
-template <>
-inline
-void
-FE_Poly<TensorProductPolynomials<2>,2,3>::fill_fe_subface_values (const Mapping<2,3> &,
- const Triangulation<2,3>::cell_iterator &,
- const unsigned int,
- const unsigned int,
- const Quadrature<1> &,
- Mapping<2,3>::InternalDataBase &,
- Mapping<2,3>::InternalDataBase &,
- FEValuesData<2,3> &) const
-{
- AssertThrow(false, ExcNotImplemented());
-}
-
-
-template <>
-inline
-void
-FE_Poly<PolynomialSpace<1>,1,2>::fill_fe_subface_values (const Mapping<1,2> &,
- const Triangulation<1,2>::cell_iterator &,
- const unsigned int,
- const unsigned int,
- const Quadrature<0> &,
- Mapping<1,2>::InternalDataBase &,
- Mapping<1,2>::InternalDataBase &,
- FEValuesData<1,2> &) const
-{
- AssertThrow(false, ExcNotImplemented());
-}
-
-
-template <>
-inline
-void
-FE_Poly<PolynomialSpace<2>,2,3>::fill_fe_subface_values (const Mapping<2,3> &,
- const Triangulation<2,3>::cell_iterator &,
- const unsigned int,
- const unsigned int,
- const Quadrature<1> &,
- Mapping<2,3>::InternalDataBase &,
- Mapping<2,3>::InternalDataBase &,
- FEValuesData<2,3> &) const
-{
- AssertThrow(false, ExcNotImplemented());
-}
+// template <>
+// inline
+// void
+// FE_Poly<TensorProductPolynomials<1>,1,2>::fill_fe_subface_values (const Mapping<1,2> &,
+// const Triangulation<1,2>::cell_iterator &,
+// const unsigned int,
+// const unsigned int,
+// const Quadrature<0> &,
+// Mapping<1,2>::InternalDataBase &,
+// Mapping<1,2>::InternalDataBase &,
+// FEValuesData<1,2> &) const
+// {
+// AssertThrow(false, ExcNotImplemented());
+// }
+
+
+// template <>
+// inline
+// void
+// FE_Poly<TensorProductPolynomials<2>,2,3>::fill_fe_subface_values (const Mapping<2,3> &,
+// const Triangulation<2,3>::cell_iterator &,
+// const unsigned int,
+// const unsigned int,
+// const Quadrature<1> &,
+// Mapping<2,3>::InternalDataBase &,
+// Mapping<2,3>::InternalDataBase &,
+// FEValuesData<2,3> &) const
+// {
+// AssertThrow(false, ExcNotImplemented());
+// }
+
+
+// template <>
+// inline
+// void
+// FE_Poly<PolynomialSpace<1>,1,2>::fill_fe_subface_values (const Mapping<1,2> &,
+// const Triangulation<1,2>::cell_iterator &,
+// const unsigned int,
+// const unsigned int,
+// const Quadrature<0> &,
+// Mapping<1,2>::InternalDataBase &,
+// Mapping<1,2>::InternalDataBase &,
+// FEValuesData<1,2> &) const
+// {
+// AssertThrow(false, ExcNotImplemented());
+// }
+
+
+// template <>
+// inline
+// void
+// FE_Poly<PolynomialSpace<2>,2,3>::fill_fe_subface_values (const Mapping<2,3> &,
+// const Triangulation<2,3>::cell_iterator &,
+// const unsigned int,
+// const unsigned int,
+// const Quadrature<1> &,
+// Mapping<2,3>::InternalDataBase &,
+// Mapping<2,3>::InternalDataBase &,
+// FEValuesData<2,3> &) const
+// {
+// AssertThrow(false, ExcNotImplemented());
+// }
static void estimate (const Mapping<1,spacedim> &mapping,
const DH &dof,
const Quadrature<0> &quadrature,
- const FunctionMap<1>::type &neumann_bc,
+ const typename FunctionMap<spacedim>::type &neumann_bc,
const InputVector &solution,
Vector<float> &error,
const std::vector<bool> &component_mask = std::vector<bool>(),
- const Function<1> *coefficients = 0,
+ const Function<spacedim> *coefficients = 0,
const unsigned int n_threads = multithread_info.n_default_threads,
const types::subdomain_id_t subdomain_id = types::invalid_subdomain_id,
const unsigned int material_id = numbers::invalid_unsigned_int);
template <typename InputVector, class DH>
static void estimate (const DH &dof,
const Quadrature<0> &quadrature,
- const FunctionMap<1>::type &neumann_bc,
+ const typename FunctionMap<spacedim>::type &neumann_bc,
const InputVector &solution,
Vector<float> &error,
const std::vector<bool> &component_mask = std::vector<bool>(),
- const Function<1> *coefficients = 0,
+ const Function<spacedim> *coefficients = 0,
const unsigned int n_threads = multithread_info.n_default_threads,
const types::subdomain_id_t subdomain_id = types::invalid_subdomain_id,
const unsigned int material_id = numbers::invalid_unsigned_int);
static void estimate (const Mapping<1,spacedim> &mapping,
const DH &dof,
const Quadrature<0> &quadrature,
- const FunctionMap<1>::type &neumann_bc,
+ const typename FunctionMap<spacedim>::type &neumann_bc,
const std::vector<const InputVector *> &solutions,
std::vector<Vector<float>*> &errors,
const std::vector<bool> &component_mask = std::vector<bool>(),
- const Function<1> *coefficients = 0,
+ const Function<spacedim> *coefficients = 0,
const unsigned int n_threads = multithread_info.n_default_threads,
const types::subdomain_id_t subdomain_id = types::invalid_subdomain_id,
const unsigned int material_id = numbers::invalid_unsigned_int);
template <typename InputVector, class DH>
static void estimate (const DH &dof,
const Quadrature<0> &quadrature,
- const FunctionMap<1>::type &neumann_bc,
+ const typename FunctionMap<spacedim>::type &neumann_bc,
const std::vector<const InputVector *> &solutions,
std::vector<Vector<float>*> &errors,
const std::vector<bool> &component_mask = std::vector<bool>(),
- const Function<1> *coefficients = 0,
+ const Function<spacedim> *coefficients = 0,
const unsigned int n_threads = multithread_info.n_default_threads,
const types::subdomain_id_t subdomain_id = types::invalid_subdomain_id,
const unsigned int material_id = numbers::invalid_unsigned_int);
static void estimate (const Mapping<1,spacedim> &mapping,
const DH &dof,
const hp::QCollection<0> &quadrature,
- const typename FunctionMap<1>::type &neumann_bc,
+ const typename FunctionMap<spacedim>::type &neumann_bc,
const InputVector &solution,
Vector<float> &error,
const std::vector<bool> &component_mask = std::vector<bool>(),
- const Function<1> *coefficients = 0,
+ const Function<spacedim> *coefficients = 0,
const unsigned int n_threads = multithread_info.n_default_threads,
const types::subdomain_id_t subdomain_id = types::invalid_subdomain_id,
const unsigned int material_id = numbers::invalid_unsigned_int);
template <typename InputVector, class DH>
static void estimate (const DH &dof,
const hp::QCollection<0> &quadrature,
- const typename FunctionMap<1>::type &neumann_bc,
+ const typename FunctionMap<spacedim>::type &neumann_bc,
const InputVector &solution,
Vector<float> &error,
const std::vector<bool> &component_mask = std::vector<bool>(),
- const Function<1> *coefficients = 0,
+ const Function<spacedim> *coefficients = 0,
const unsigned int n_threads = multithread_info.n_default_threads,
const types::subdomain_id_t subdomain_id = types::invalid_subdomain_id,
const unsigned int material_id = numbers::invalid_unsigned_int);
static void estimate (const Mapping<1,spacedim> &mapping,
const DH &dof,
const hp::QCollection<0> &quadrature,
- const typename FunctionMap<1>::type &neumann_bc,
+ const typename FunctionMap<spacedim>::type &neumann_bc,
const std::vector<const InputVector *> &solutions,
std::vector<Vector<float>*> &errors,
const std::vector<bool> &component_mask = std::vector<bool>(),
- const Function<1> *coefficients = 0,
+ const Function<spacedim> *coefficients = 0,
const unsigned int n_threads = multithread_info.n_default_threads,
const types::subdomain_id_t subdomain_id = types::invalid_subdomain_id,
const unsigned int material_id = numbers::invalid_unsigned_int);
template <typename InputVector, class DH>
static void estimate (const DH &dof,
const hp::QCollection<0> &quadrature,
- const typename FunctionMap<1>::type &neumann_bc,
+ const typename FunctionMap<spacedim>::type &neumann_bc,
const std::vector<const InputVector *> &solutions,
std::vector<Vector<float>*> &errors,
const std::vector<bool> &component_mask = std::vector<bool>(),
- const Function<1> *coefficients = 0,
+ const Function<spacedim> *coefficients = 0,
const unsigned int n_threads = multithread_info.n_default_threads,
const types::subdomain_id_t subdomain_id = types::invalid_subdomain_id,
const unsigned int material_id = numbers::invalid_unsigned_int);
estimate (const Mapping<1,spacedim> &mapping,
const DH &dof_handler,
const Quadrature<0> &quadrature,
- const FunctionMap<1>::type &neumann_bc,
+ const typename FunctionMap<spacedim>::type &neumann_bc,
const InputVector &solution,
Vector<float> &error,
const std::vector<bool> &component_mask,
- const Function<1> *coefficients,
+ const Function<spacedim> *coefficients,
const unsigned int n_threads,
const types::subdomain_id_t subdomain_id,
const unsigned int material_id)
KellyErrorEstimator<1,spacedim>::
estimate (const DH &dof_handler,
const Quadrature<0> &quadrature,
- const FunctionMap<1>::type &neumann_bc,
+ const typename FunctionMap<spacedim>::type &neumann_bc,
const InputVector &solution,
Vector<float> &error,
const std::vector<bool> &component_mask,
- const Function<1> *coefficients,
+ const Function<spacedim> *coefficients,
const unsigned int n_threads,
const types::subdomain_id_t subdomain_id,
const unsigned int material_id)
KellyErrorEstimator<1,spacedim>::
estimate (const DH &dof_handler,
const Quadrature<0> &quadrature,
- const FunctionMap<1>::type &neumann_bc,
+ const typename FunctionMap<spacedim>::type &neumann_bc,
const std::vector<const InputVector*> &solutions,
std::vector<Vector<float>*> &errors,
const std::vector<bool> &component_mask,
- const Function<1> *coefficients,
+ const Function<spacedim> *coefficients,
const unsigned int n_threads,
const types::subdomain_id_t subdomain_id,
const unsigned int material_id)
estimate (const Mapping<1,spacedim> &mapping,
const DH &dof_handler,
const hp::QCollection<0> &quadrature,
- const FunctionMap<1>::type &neumann_bc,
+ const typename FunctionMap<spacedim>::type &neumann_bc,
const InputVector &solution,
Vector<float> &error,
const std::vector<bool> &component_mask,
- const Function<1> *coefficients,
+ const Function<spacedim> *coefficients,
const unsigned int n_threads,
const types::subdomain_id_t subdomain_id,
const unsigned int material_id)
KellyErrorEstimator<1,spacedim>::
estimate (const DH &dof_handler,
const hp::QCollection<0> &quadrature,
- const FunctionMap<1>::type &neumann_bc,
+ const typename FunctionMap<spacedim>::type &neumann_bc,
const InputVector &solution,
Vector<float> &error,
const std::vector<bool> &component_mask,
- const Function<1> *coefficients,
+ const Function<spacedim> *coefficients,
const unsigned int n_threads,
const types::subdomain_id_t subdomain_id,
const unsigned int material_id)
KellyErrorEstimator<1,spacedim>::
estimate (const DH &dof_handler,
const hp::QCollection<0> &quadrature,
- const FunctionMap<1>::type &neumann_bc,
+ const typename FunctionMap<spacedim>::type &neumann_bc,
const std::vector<const InputVector*> &solutions,
std::vector<Vector<float>*> &errors,
const std::vector<bool> &component_mask,
- const Function<1> *coefficients,
+ const Function<spacedim> *coefficients,
const unsigned int n_threads,
const types::subdomain_id_t subdomain_id,
const unsigned int material_id)
estimate (const Mapping<1,spacedim> &/*mapping*/,
const DH &/*dof_handler*/,
const hp::QCollection<0> &,
- const FunctionMap<1>::type &/*neumann_bc*/,
+ const typename FunctionMap<spacedim>::type &/*neumann_bc*/,
const std::vector<const InputVector *> &/*solutions*/,
std::vector<Vector<float>*> &/*errors*/,
const std::vector<bool> &/*component_mask_*/,
- const Function<1> */*coefficient*/,
+ const Function<spacedim> */*coefficient*/,
const unsigned int,
const types::subdomain_id_t /*subdomain_id*/,
const unsigned int /*material_id*/)
estimate (const Mapping<1,spacedim> &mapping,
const DH &dof_handler,
const Quadrature<0> &,
- const FunctionMap<1>::type &neumann_bc,
+ const typename FunctionMap<spacedim>::type &neumann_bc,
const std::vector<const InputVector *> &solutions,
std::vector<Vector<float>*> &errors,
const std::vector<bool> &component_mask_,
- const Function<1> *coefficient,
+ const Function<spacedim> *coefficient,
const unsigned int,
const types::subdomain_id_t subdomain_id_,
const unsigned int material_id)
Assert (neumann_bc.find(255) == neumann_bc.end(),
ExcInvalidBoundaryIndicator());
- for (FunctionMap<1>::type::const_iterator i=neumann_bc.begin();
+ for (typename FunctionMap<spacedim>::type::const_iterator i=neumann_bc.begin();
i!=neumann_bc.end(); ++i)
Assert (i->second->n_components == n_components, ExcInvalidBoundaryFunction());
(coefficient->n_components == 1),
ExcInvalidCoefficient());
- for (FunctionMap<1>::type::const_iterator i=neumann_bc.begin();
+ for (typename FunctionMap<spacedim>::type::const_iterator i=neumann_bc.begin();
i!=neumann_bc.end(); ++i)
Assert (i->second->n_components == n_components,
ExcInvalidBoundaryFunction());
// need several auxiliary fields,
// depending on the way we get it
// (see below)
- std::vector<std::vector<std::vector<Tensor<1,1> > > >
+ std::vector<std::vector<std::vector<Tensor<1,spacedim> > > >
gradients_here (n_solution_vectors,
- std::vector<std::vector<Tensor<1,1> > >(2, std::vector<Tensor<1,1> >(n_components)));
- std::vector<std::vector<std::vector<Tensor<1,1> > > >
+ std::vector<std::vector<Tensor<1,spacedim> > >(2, std::vector<Tensor<1,spacedim> >(n_components)));
+ std::vector<std::vector<std::vector<Tensor<1,spacedim> > > >
gradients_neighbor (gradients_here);
std::vector<Vector<double> >
grad_neighbor (n_solution_vectors, Vector<double>(n_components));
const unsigned int , \
const unsigned int);\
-#if deal_II_dimension == 2
+#if deal_II_dimension == 2 || deal_II_dimension == 1
#define INSTANTIATE_CODIM(InputVector,DH,Q) \
template \