From: buerg Date: Sat, 11 Jan 2014 15:57:13 +0000 (+0000) Subject: Revert to r32190. X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=274d8d88dd5d8a462311e7b9e864898705cda179;p=dealii-svn.git Revert to r32190. git-svn-id: https://svn.dealii.org/trunk@32195 0785d39b-7218-0410-832d-ea1e28bc413d --- diff --git a/deal.II/include/deal.II/fe/fe.h b/deal.II/include/deal.II/fe/fe.h index 3c80c906e9..fda2a7fef3 100644 --- a/deal.II/include/deal.II/fe/fe.h +++ b/deal.II/include/deal.II/fe/fe.h @@ -1749,8 +1749,7 @@ protected: const unsigned int offset, typename Mapping::InternalDataBase &mapping_internal, InternalDataBase &fe_internal, - FEValuesData &data, - const MappingType mapping_type = mapping_covariant) const; + FEValuesData &data) const; /** * Given the pattern of nonzero components for each shape function, compute diff --git a/deal.II/source/fe/fe_poly_tensor.cc b/deal.II/source/fe/fe_poly_tensor.cc index d3bbdb807c..4735a210ef 100644 --- a/deal.II/source/fe/fe_poly_tensor.cc +++ b/deal.II/source/fe/fe_poly_tensor.cc @@ -585,29 +585,9 @@ FE_PolyTensor::fill_fe_values ( } if (flags & update_hessians && cell_similarity != CellSimilarity::translation) - { - if (mapping_type == mapping_nedelec) - { - this->compute_2nd (mapping, cell, - typename QProjector::DataSetDescriptor().cell(), - mapping_data, fe_data, data, mapping_covariant_gradient); - - for (unsigned int i = 0; i < this->dofs_per_cell; ++i) - { - const unsigned int first = data.shape_function_to_row_table[i * this->n_components() + - this->get_nonzero_components(i).first_selected_component()]; - - for (unsigned int k = 0; k < n_q_points; ++k) - for (unsigned int d = 0; d < dim; ++d) - data.shape_hessians[first + d][k] *= sign_change[i]; - } - } - - else - this->compute_2nd (mapping, cell, + this->compute_2nd (mapping, cell, typename QProjector::DataSetDescriptor().cell(), mapping_data, fe_data, data); - } } @@ -811,25 +791,7 @@ FE_PolyTensor::fill_fe_face_values ( } if (flags & update_hessians) - { - if (mapping_type == mapping_nedelec) - { - this->compute_2nd (mapping, cell, offset, mapping_data, fe_data, data, mapping_covariant_gradient); - - for (unsigned int i = 0; i < this->dofs_per_cell; ++i) - { - const unsigned int first = data.shape_function_to_row_table[i * this->n_components() + - this->get_nonzero_components(i).first_selected_component()]; - - for (unsigned int k = 0; k < n_q_points; ++k) - for (unsigned int d = 0; d < dim; ++d) - data.shape_hessians[first + d][k] *= sign_change[i]; - } - } - - else - this->compute_2nd (mapping, cell, offset, mapping_data, fe_data, data); - } + this->compute_2nd (mapping, cell, offset, mapping_data, fe_data, data); } @@ -1039,25 +1001,7 @@ FE_PolyTensor::fill_fe_subface_values ( } if (flags & update_hessians) - { - if (mapping_type == mapping_nedelec) - { - this->compute_2nd (mapping, cell, offset, mapping_data, fe_data, data, mapping_covariant_gradient); - - for (unsigned int i = 0; i < this->dofs_per_cell; ++i) - { - const unsigned int first = data.shape_function_to_row_table[i * this->n_components() + - this->get_nonzero_components(i).first_selected_component()]; - - for (unsigned int k = 0; k < n_q_points; ++k) - for (unsigned int d = 0; d < dim; ++d) - data.shape_hessians[first + d][k] *= sign_change[i]; - } - } - - else - this->compute_2nd (mapping, cell, offset, mapping_data, fe_data, data); - } + this->compute_2nd (mapping, cell, offset, mapping_data, fe_data, data); }