From 415dcc0399f87bd2467866971beb930d45aedc5f Mon Sep 17 00:00:00 2001 From: Wolfgang Bangerth Date: Thu, 3 Sep 2015 10:46:52 -0500 Subject: [PATCH] Remove a whole bunch of code. None of this is needed any more now that the InternalData class has been largely separated. --- include/deal.II/fe/mapping_q.h | 11 ----------- include/deal.II/fe/mapping_q1.h | 6 ------ source/fe/mapping_q.cc | 18 +++++++++--------- source/fe/mapping_q1.cc | 9 ++------- 4 files changed, 11 insertions(+), 33 deletions(-) diff --git a/include/deal.II/fe/mapping_q.h b/include/deal.II/fe/mapping_q.h index 2d4914eaaf..e183478934 100644 --- a/include/deal.II/fe/mapping_q.h +++ b/include/deal.II/fe/mapping_q.h @@ -441,17 +441,6 @@ protected: */ const unsigned int n_outer; - /** - * Pointer to the @p dim-dimensional tensor product polynomials used as - * shape functions for the Qp mapping of cells at the boundary. - */ - const TensorProductPolynomials *tensor_pols; - - /** - * Number of the Qp tensor product shape functions. - */ - const unsigned int n_shape_functions; - /** * If this flag is set @p true then @p MappingQ is used on all cells, not * only on boundary cells. diff --git a/include/deal.II/fe/mapping_q1.h b/include/deal.II/fe/mapping_q1.h index 0bd58ab147..bf07fa14b9 100644 --- a/include/deal.II/fe/mapping_q1.h +++ b/include/deal.II/fe/mapping_q1.h @@ -538,12 +538,6 @@ protected: virtual void compute_mapping_support_points( const typename Triangulation::cell_iterator &cell, std::vector > &a) const; - - /** - * Number of shape functions. Is simply the number of vertices per cell for - * the Q1 mapping. - */ - static const unsigned int n_shape_functions = GeometryInfo::vertices_per_cell; }; diff --git a/source/fe/mapping_q.cc b/source/fe/mapping_q.cc index 0a957cc02d..dc81742075 100644 --- a/source/fe/mapping_q.cc +++ b/source/fe/mapping_q.cc @@ -64,13 +64,13 @@ MappingQ::MappingQ (const unsigned int p, ((dim==2) ? 4+4*(degree-1) : 8+12*(degree-1)+6*(degree-1)*(degree-1))), - n_shape_functions(Utilities::fixed_power(degree+1)), use_mapping_q_on_all_cells (use_mapping_q_on_all_cells || (dim != spacedim)), feq(degree), line_support_points(degree+1) { - Assert(n_inner+n_outer==n_shape_functions, ExcInternalError()); + Assert(n_inner+n_outer==Utilities::fixed_power(degree+1), + ExcInternalError()); // build laplace_on_quad_vector if (degree>1) @@ -90,7 +90,6 @@ MappingQ::MappingQ (const MappingQ &mapping) degree(mapping.degree), n_inner(mapping.n_inner), n_outer(mapping.n_outer), - n_shape_functions(mapping.n_shape_functions), use_mapping_q_on_all_cells (mapping.use_mapping_q_on_all_cells), feq(degree), line_support_points(degree+1) @@ -481,7 +480,8 @@ MappingQ::compute_laplace_vector(Table<2,double> &lvs) const const unsigned int n_q_points=quadrature.size(); InternalData quadrature_data(degree); - quadrature_data.shape_derivatives.resize(n_shape_functions * n_q_points); + quadrature_data.shape_derivatives.resize(quadrature_data.n_shape_functions * + n_q_points); quadrature_data.compute_shape_function_values(quadrature.get_points()); // Compute the stiffness matrix of the inner dofs @@ -880,7 +880,7 @@ transform (const VectorSlice > > input, } // Now, q1_data should have the right tensors in it and we call the base - // classes transform function + // class's transform function MappingQ1::transform(input, mapping_type, *q1_data, output); } @@ -910,7 +910,7 @@ transform (const VectorSlice } // Now, q1_data should have the right tensors in it and we call the base - // classes transform function + // class's transform function MappingQ1::transform(input, mapping_type, *q1_data, output); } @@ -938,7 +938,7 @@ transform (const VectorSlice > > input, } // Now, q1_data should have the right tensors in it and we call the base - // classes transform function + // class's transform function MappingQ1::transform(input, mapping_type, *q1_data, output); } @@ -968,7 +968,7 @@ transform (const VectorSlice } // Now, q1_data should have the right tensors in it and we call the base - // classes transform function + // class's transform function MappingQ1::transform(input, mapping_type, *q1_data, output); } @@ -996,7 +996,7 @@ transform (const VectorSlice > > input, } // Now, q1_data should have the right tensors in it and we call the base - // classes transform function + // class's transform function MappingQ1::transform(input, mapping_type, *q1_data, output); } diff --git a/source/fe/mapping_q1.cc b/source/fe/mapping_q1.cc index 96ab2065de..d4f83839d3 100644 --- a/source/fe/mapping_q1.cc +++ b/source/fe/mapping_q1.cc @@ -17,6 +17,8 @@ #include #include #include +#include +#include #include #include #include @@ -28,8 +30,6 @@ #include #include #include -#include -#include #include #include @@ -38,11 +38,6 @@ DEAL_II_NAMESPACE_OPEN -template -const unsigned int MappingQ1::n_shape_functions; - - - template MappingQ1::InternalData::InternalData (const unsigned int polynomial_degree) : -- 2.39.5