From: Wolfgang Bangerth Date: Mon, 2 Mar 2015 16:52:20 +0000 (-0600) Subject: Revert commit e86e602ae14. X-Git-Tag: v8.3.0-rc1~392^2 X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=refs%2Fpull%2F634%2Fhead;p=dealii.git Revert commit e86e602ae14. This undoes the changes of commit 13796ae50a7ac24 (through issue #621) that don't compile of their own. --- diff --git a/source/numerics/error_estimator.cc b/source/numerics/error_estimator.cc index 797776aa61..19ba50108a 100644 --- a/source/numerics/error_estimator.cc +++ b/source/numerics/error_estimator.cc @@ -96,7 +96,7 @@ namespace internal * resizing to a smaller size doesn't imply memory allocation, this is * fast. */ - template + template struct ParallelData { static const unsigned int dim = DH::dimension; @@ -128,7 +128,7 @@ namespace internal * particular in presence of multiple threads where synchronisation * makes things even slower. */ - std::vector > > phi; + std::vector > > phi; /** * A vector for the gradients of the finite element function on one cell @@ -138,12 +138,12 @@ namespace internal * the number of the quadrature point. The first index denotes the index * of the solution vector. */ - std::vector > > > psi; + std::vector > > > psi; /** * The same vector for a neighbor cell */ - std::vector > > > neighbor_psi; + std::vector > > > neighbor_psi; /** * The normal vectors of the finite element function on one face @@ -204,9 +204,9 @@ namespace internal }; - template + template template - ParallelData:: + ParallelData:: ParallelData (const FE &fe, const dealii::hp::QCollection &face_quadratures, const dealii::hp::MappingCollection &mapping, @@ -238,17 +238,17 @@ namespace internal face_quadratures, update_gradients), phi (n_solution_vectors, - std::vector > + std::vector > (face_quadratures.max_n_quadrature_points(), - std::vector (fe.n_components()))), + std::vector (fe.n_components()))), psi (n_solution_vectors, - std::vector > > + std::vector > > (face_quadratures.max_n_quadrature_points(), - std::vector > (fe.n_components()))), + std::vector > (fe.n_components()))), neighbor_psi (n_solution_vectors, - std::vector > > + std::vector > > (face_quadratures.max_n_quadrature_points(), - std::vector > (fe.n_components()))), + std::vector > (fe.n_components()))), normal_vectors (face_quadratures.max_n_quadrature_points()), coefficient_values1 (face_quadratures.max_n_quadrature_points()), coefficient_values (face_quadratures.max_n_quadrature_points(), @@ -263,9 +263,9 @@ namespace internal - template + template void - ParallelData::resize (const unsigned int active_fe_index) + ParallelData::resize (const unsigned int active_fe_index) { const unsigned int n_q_points = face_quadratures[active_fe_index].size(); const unsigned int n_components = finite_element.n_components(); @@ -332,9 +332,9 @@ namespace internal * Actually do the computation based on the evaluated gradients in * ParallelData. */ - template + template std::vector - integrate_over_face (ParallelData ¶llel_data, + integrate_over_face (ParallelData ¶llel_data, const typename DH::face_iterator &face, dealii::hp::FEFaceValues &fe_face_values_cell) { @@ -475,7 +475,7 @@ namespace internal template void integrate_over_regular_face (const std::vector &solutions, - ParallelData ¶llel_data, + ParallelData ¶llel_data, std::map > &local_face_integrals, const typename DH::active_cell_iterator &cell, const unsigned int face_no, @@ -551,7 +551,7 @@ namespace internal template void integrate_over_irregular_face (const std::vector &solutions, - ParallelData ¶llel_data, + ParallelData ¶llel_data, std::map > &local_face_integrals, const typename DH::active_cell_iterator &cell, const unsigned int face_no, @@ -643,7 +643,7 @@ namespace internal template void estimate_one_cell (const typename DH::active_cell_iterator &cell, - ParallelData ¶llel_data, + ParallelData ¶llel_data, std::map > &local_face_integrals, const std::vector &solutions) { @@ -961,7 +961,7 @@ estimate (const Mapping &mapping, // all the data needed in the error estimator by each of the threads is // gathered in the following structures const hp::MappingCollection mapping_collection(mapping); - const internal::ParallelData + const internal::ParallelData parallel_data (dof_handler.get_fe(), face_quadratures, mapping_collection,