From f8c1cca8b22211b7df2ea5c43d48fb905843de39 Mon Sep 17 00:00:00 2001 From: wolf Date: Mon, 14 Oct 2002 15:31:43 +0000 Subject: [PATCH] Ups. git-svn-id: https://svn.dealii.org/trunk@6646 0785d39b-7218-0410-832d-ea1e28bc413d --- .../source/numerics/error_estimator.cc | 45 +++---------------- 1 file changed, 7 insertions(+), 38 deletions(-) diff --git a/deal.II/deal.II/source/numerics/error_estimator.cc b/deal.II/deal.II/source/numerics/error_estimator.cc index ed0cb1f7e0..36eea502fc 100644 --- a/deal.II/deal.II/source/numerics/error_estimator.cc +++ b/deal.II/deal.II/source/numerics/error_estimator.cc @@ -47,46 +47,16 @@ double sqr (const double x) }; -#if deal_II_dimension == 1 - -// provide zero pointers to be used in the initialization of -// invalid references -namespace -{ - const Mapping<1> * const invalid_mapping = 0; - const DoFHandler<1> * const invalid_dof_handler = 0; - const Quadrature<0> * const invalid_face_quadrature = 0; - const FunctionMap<1>::type * const invalid_function_map = 0; - const std::vector *> * const invalid_solutions = 0; - std::map::face_iterator,std::vector > - * const invalid_face_integrals = 0; -} - - -template <> -KellyErrorEstimator<1>::PerThreadData:: -PerThreadData(const DoFHandler<1> &, - const Quadrature<0> &, - const unsigned int) -{ - Assert (false, ExcInternalError()); -} - -#else template KellyErrorEstimator::PerThreadData:: -PerThreadData(const DoFHandler &dof_handler, - const Quadrature &quadrature, - const unsigned int n_solution_vectors) +PerThreadData (const unsigned int n_solution_vectors, + const unsigned int n_components, + const unsigned int n_q_points) { - const unsigned int n_components = dof_handler.get_fe().n_components(); - // Init the size of a lot of vectors // needed in the calculations once // per thread. - const unsigned int n_q_points = quadrature.n_quadrature_points; - normal_vectors.resize(n_q_points); coefficient_values1.resize(n_q_points); coefficient_values.resize(n_q_points); @@ -114,7 +84,6 @@ PerThreadData(const DoFHandler &dof_handler, coefficient_values[qp].reinit(n_components); } -#endif @@ -652,9 +621,9 @@ KellyErrorEstimator::estimate (const Mapping &mapping // components std::vector data_structures (n_threads); for (unsigned int i=0; i &dof_handler, const typename DoFHandler::face_iterator face = cell->face(face_no); const unsigned int n_q_points = quadrature.n_quadrature_points, n_components = dof_handler.get_fe().n_components(), - n_solution_vectors = n_solution_vectors; + n_solution_vectors = solutions.size(); // initialize data of the restriction -- 2.39.5