From: Daniel Arndt Date: Thu, 26 Mar 2020 16:23:09 +0000 (-0400) Subject: Remove FEValuesBase::get_all_normal_vectors X-Git-Tag: v9.2.0-rc1~356^2 X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=refs%2Fpull%2F9742%2Fhead;p=dealii.git Remove FEValuesBase::get_all_normal_vectors --- diff --git a/doc/news/changes/incompatibilities/20200326DanielArndt b/doc/news/changes/incompatibilities/20200326DanielArndt new file mode 100644 index 0000000000..3599a229e6 --- /dev/null +++ b/doc/news/changes/incompatibilities/20200326DanielArndt @@ -0,0 +1,4 @@ +Removed: The deprecated FEValuesBase::get_all_normal_vectors() function has been +removed. Use FEValuesBase::get_normal_vectors() instead. +
+(Daniel Arndt, 2020/03/26) diff --git a/include/deal.II/fe/fe_values.h b/include/deal.II/fe/fe_values.h index 7d377fdc18..9488af2116 100644 --- a/include/deal.II/fe/fe_values.h +++ b/include/deal.II/fe/fe_values.h @@ -3132,20 +3132,6 @@ public: const Tensor<1, spacedim> & normal_vector(const unsigned int i) const; - /** - * Return the normal vectors at all quadrature points represented by - * this object. See the normal_vector() function for what the normal - * vectors represent. - * - * @dealiiRequiresUpdateFlags{update_normal_vectors} - * - * @deprecated Use get_normal_vectors() instead, which returns the exact - * same thing. - */ - DEAL_II_DEPRECATED - const std::vector> & - get_all_normal_vectors() const; - /** * Return the normal vectors at all quadrature points represented by * this object. See the normal_vector() function for what the normal diff --git a/include/deal.II/numerics/error_estimator.templates.h b/include/deal.II/numerics/error_estimator.templates.h index 815a42eed7..fadd5516c8 100644 --- a/include/deal.II/numerics/error_estimator.templates.h +++ b/include/deal.II/numerics/error_estimator.templates.h @@ -364,7 +364,7 @@ namespace internal // change the sign. We take the outward normal. parallel_data.normal_vectors = - fe_face_values_cell.get_present_fe_values().get_all_normal_vectors(); + fe_face_values_cell.get_present_fe_values().get_normal_vectors(); for (unsigned int n = 0; n < n_solution_vectors; ++n) for (unsigned int component = 0; component < n_components; ++component) @@ -769,8 +769,7 @@ namespace internal } parallel_data.neighbor_normal_vectors = - fe_face_values_neighbor.get_present_fe_values() - .get_all_normal_vectors(); + fe_face_values_neighbor.get_present_fe_values().get_normal_vectors(); } else { @@ -881,7 +880,7 @@ namespace internal // call generic evaluate function parallel_data.neighbor_normal_vectors = - fe_subface_values.get_present_fe_values().get_all_normal_vectors(); + fe_subface_values.get_present_fe_values().get_normal_vectors(); local_face_integrals[neighbor_child->face(neighbor_neighbor)] = integrate_over_face(parallel_data, face, fe_face_values); diff --git a/include/deal.II/numerics/vector_tools.templates.h b/include/deal.II/numerics/vector_tools.templates.h index 229f111e82..f9077dcf9f 100644 --- a/include/deal.II/numerics/vector_tools.templates.h +++ b/include/deal.II/numerics/vector_tools.templates.h @@ -6403,9 +6403,8 @@ namespace VectorTools // the boundary function times the normal components of the shape // functions supported on the boundary. const FEValuesExtractors::Vector vec(first_vector_component); - const FiniteElement<2> & fe = cell->get_fe(); - const std::vector> &normals = - fe_values.get_all_normal_vectors(); + const FiniteElement<2> & fe = cell->get_fe(); + const std::vector> &normals = fe_values.get_normal_vectors(); const unsigned int face_coordinate_direction[GeometryInfo<2>::faces_per_cell] = {1, 1, @@ -6506,9 +6505,8 @@ namespace VectorTools // the boundary function times the normal components of the shape // functions supported on the boundary. const FEValuesExtractors::Vector vec(first_vector_component); - const FiniteElement<3> & fe = cell->get_fe(); - const std::vector> &normals = - fe_values.get_all_normal_vectors(); + const FiniteElement<3> & fe = cell->get_fe(); + const std::vector> &normals = fe_values.get_normal_vectors(); const unsigned int face_coordinate_directions[GeometryInfo<3>::faces_per_cell][2] = { {1, 2}, {1, 2}, {2, 0}, {2, 0}, {0, 1}, {0, 1}}; diff --git a/source/fe/fe_values.cc b/source/fe/fe_values.cc index 2df4697bdc..7749fbb96f 100644 --- a/source/fe/fe_values.cc +++ b/source/fe/fe_values.cc @@ -4194,18 +4194,6 @@ FEValuesBase::get_cell() const -template -const std::vector> & -FEValuesBase::get_all_normal_vectors() const -{ - Assert(this->update_flags & update_normal_vectors, - (typename FEValuesBase::ExcAccessToUninitializedField( - "update_normal_vectors"))); - return get_normal_vectors(); -} - - - template const std::vector> & FEValuesBase::get_normal_vectors() const diff --git a/source/numerics/data_out_faces.cc b/source/numerics/data_out_faces.cc index 46e27e839e..e40bda2f1b 100644 --- a/source/numerics/data_out_faces.cc +++ b/source/numerics/data_out_faces.cc @@ -190,7 +190,7 @@ DataOutFaces::build_one_patch( if (update_flags & update_normal_vectors) data.patch_values_scalar.normals = - this_fe_patch_values.get_all_normal_vectors(); + this_fe_patch_values.get_normal_vectors(); const typename DoFHandlerType::active_cell_iterator dh_cell( &cell_and_face->first->get_triangulation(), @@ -234,7 +234,7 @@ DataOutFaces::build_one_patch( if (update_flags & update_normal_vectors) data.patch_values_system.normals = - this_fe_patch_values.get_all_normal_vectors(); + this_fe_patch_values.get_normal_vectors(); const typename DoFHandlerType::active_cell_iterator dh_cell( &cell_and_face->first->get_triangulation(), diff --git a/source/numerics/error_estimator_1d.cc b/source/numerics/error_estimator_1d.cc index b63f26045e..aa59e3f508 100644 --- a/source/numerics/error_estimator_1d.cc +++ b/source/numerics/error_estimator_1d.cc @@ -460,8 +460,8 @@ KellyErrorEstimator<1, spacedim>::estimate( neighbor = neighbor->child(n == 0 ? 1 : 0); fe_face_values.reinit(cell, n); - Tensor<1, spacedim> normal = fe_face_values.get_present_fe_values() - .get_all_normal_vectors()[0]; + Tensor<1, spacedim> normal = + fe_face_values.get_present_fe_values().get_normal_vectors()[0]; if (neighbor.state() == IteratorState::valid) { @@ -474,7 +474,7 @@ KellyErrorEstimator<1, spacedim>::estimate( fe_face_values.reinit(neighbor, n == 0 ? 1 : 0); Tensor<1, spacedim> neighbor_normal = fe_face_values.get_present_fe_values() - .get_all_normal_vectors()[0]; + .get_normal_vectors()[0]; // extract the gradient in normal direction of all the // components. diff --git a/tests/bits/step-12.cc b/tests/bits/step-12.cc index 48133a0738..3a06ab383b 100644 --- a/tests/bits/step-12.cc +++ b/tests/bits/step-12.cc @@ -216,7 +216,7 @@ DGTransportEquation::assemble_boundary_term( Vector & cell_vector) const { const std::vector & JxW = fe_v.get_JxW_values(); - const std::vector> &normals = fe_v.get_all_normal_vectors(); + const std::vector> &normals = fe_v.get_normal_vectors(); std::vector> beta(fe_v.n_quadrature_points); std::vector g(fe_v.n_quadrature_points); @@ -249,7 +249,7 @@ DGTransportEquation::assemble_face_term1( FullMatrix & ue_vi_matrix) const { const std::vector & JxW = fe_v.get_JxW_values(); - const std::vector> &normals = fe_v.get_all_normal_vectors(); + const std::vector> &normals = fe_v.get_normal_vectors(); std::vector> beta(fe_v.n_quadrature_points); beta_function.value_list(fe_v.get_quadrature_points(), beta); @@ -282,7 +282,7 @@ DGTransportEquation::assemble_face_term2( FullMatrix & ue_ve_matrix) const { const std::vector & JxW = fe_v.get_JxW_values(); - const std::vector> &normals = fe_v.get_all_normal_vectors(); + const std::vector> &normals = fe_v.get_normal_vectors(); std::vector> beta(fe_v.n_quadrature_points); diff --git a/tests/codim_one/bem.cc b/tests/codim_one/bem.cc index 7ca7726b66..e89274b5af 100644 --- a/tests/codim_one/bem.cc +++ b/tests/codim_one/bem.cc @@ -212,7 +212,7 @@ BEM::assemble_system() for (; cell_i != endc; ++cell_i) { fe_values_i.reinit(cell_i); - cell_normals_i = fe_values_i.get_all_normal_vectors(); + cell_normals_i = fe_values_i.get_normal_vectors(); cell_i->get_dof_indices(local_dof_indices_i); cell_DLP_matrix = 0.; @@ -248,7 +248,7 @@ BEM::assemble_system() for (cell_j = dof_handler.begin_active(); cell_j != endc; ++cell_j) { fe_values_j.reinit(cell_j); - cell_normals_j = fe_values_j.get_all_normal_vectors(); + cell_normals_j = fe_values_j.get_normal_vectors(); cell_j->get_dof_indices(local_dof_indices_j); if (cell_j != cell_i) @@ -369,7 +369,7 @@ BEM::solve() fe_values_q.reinit(cell); cell->get_dof_indices(local_dof_indices); - cell_normals = fe_values_q.get_all_normal_vectors(); + cell_normals = fe_values_q.get_normal_vectors(); for (unsigned int i = 0; i < q_iterated.size(); ++i) { cell_tangentials[i][0] = cell_normals[i][1]; diff --git a/tests/codim_one/bem_integration.cc b/tests/codim_one/bem_integration.cc index 9cab80f8e4..38bea51b31 100644 --- a/tests/codim_one/bem_integration.cc +++ b/tests/codim_one/bem_integration.cc @@ -127,7 +127,7 @@ LaplaceKernelIntegration<2>::compute_SD_integral_on_cell( Assert(dst.size() == 2, ExcDimensionMismatch(dst.size(), 2)); fe_values->reinit(cell); vector> jacobians = fe_values->get_jacobians(); - vector> normals = fe_values->get_all_normal_vectors(); + vector> normals = fe_values->get_normal_vectors(); Tensor<1, 3> n, n_c; Tensor<1, 3> r_c = point - cell->center(); diff --git a/tests/codim_one/gradients.cc b/tests/codim_one/gradients.cc index c706b68c48..c48be3601e 100644 --- a/tests/codim_one/gradients.cc +++ b/tests/codim_one/gradients.cc @@ -133,7 +133,7 @@ test(std::string filename) { fe_values.reinit(cell); cell->get_dof_indices(local_dof_indices); - cell_normals = fe_values.get_all_normal_vectors(); + cell_normals = fe_values.get_normal_vectors(); // The cell tangential is calculated // in the midpoint of the cell. For diff --git a/tests/codim_one/surface.cc b/tests/codim_one/surface.cc index d6c1878473..e100b76563 100644 --- a/tests/codim_one/surface.cc +++ b/tests/codim_one/surface.cc @@ -76,7 +76,7 @@ test(std::string filename) { fe_values.reinit(cell); const std::vector> &cellnormals = - fe_values.get_all_normal_vectors(); + fe_values.get_normal_vectors(); const std::vector> &quad_points = fe_values.get_quadrature_points(); diff --git a/tests/fe/fe_nedelec_sz_non_rect_face.cc b/tests/fe/fe_nedelec_sz_non_rect_face.cc index 5d9fcf4342..11edbf8edb 100644 --- a/tests/fe/fe_nedelec_sz_non_rect_face.cc +++ b/tests/fe/fe_nedelec_sz_non_rect_face.cc @@ -353,7 +353,7 @@ namespace Maxwell std::vector> neumann_value_list( n_face_q_points, Vector(fe.n_components())); std::vector> normal_vector_list( - fe_face_values.get_all_normal_vectors()); + fe_face_values.get_normal_vectors()); Tensor<1, dim> neumann_value_vector; Tensor<1, dim> neumann_value; Tensor<1, dim> normal_vector; diff --git a/tests/fe/fe_q_dg0.cc b/tests/fe/fe_q_dg0.cc index 259496587b..308321cc38 100644 --- a/tests/fe/fe_q_dg0.cc +++ b/tests/fe/fe_q_dg0.cc @@ -602,7 +602,7 @@ namespace Step22 fe_v_face.reinit(cell, face_no); const std::vector> &normals = - fe_v_face.get_all_normal_vectors(); + fe_v_face.get_normal_vectors(); const std::vector> &quad_points = fe_v_face.get_quadrature_points(); diff --git a/tests/fe/nedelec_non_rect_face.cc b/tests/fe/nedelec_non_rect_face.cc index 5b4e7b3127..5a1c8df778 100644 --- a/tests/fe/nedelec_non_rect_face.cc +++ b/tests/fe/nedelec_non_rect_face.cc @@ -354,7 +354,7 @@ namespace Maxwell std::vector> neumann_value_list( n_face_q_points, Vector(fe.n_components())); std::vector> normal_vector_list( - fe_face_values.get_all_normal_vectors()); + fe_face_values.get_normal_vectors()); Tensor<1, dim> neumann_value_vector; Tensor<1, dim> neumann_value; Tensor<1, dim> normal_vector; diff --git a/tests/hp/step-12.cc b/tests/hp/step-12.cc index 63ebe590ee..c09c1a3e85 100644 --- a/tests/hp/step-12.cc +++ b/tests/hp/step-12.cc @@ -232,7 +232,7 @@ DGTransportEquation::assemble_boundary_term( const std::vector &JxW = fe_v.get_present_fe_values().get_JxW_values(); const std::vector> &normals = - fe_v.get_present_fe_values().get_all_normal_vectors(); + fe_v.get_present_fe_values().get_normal_vectors(); std::vector> beta( fe_v.get_present_fe_values().n_quadrature_points); @@ -279,7 +279,7 @@ DGTransportEquation::assemble_face_term1( const std::vector &JxW = fe_v.get_present_fe_values().get_JxW_values(); const std::vector> &normals = - fe_v.get_present_fe_values().get_all_normal_vectors(); + fe_v.get_present_fe_values().get_normal_vectors(); std::vector> beta( fe_v.get_present_fe_values().n_quadrature_points); @@ -328,7 +328,7 @@ DGTransportEquation::assemble_face_term2( const std::vector &JxW = fe_v.get_present_fe_values().get_JxW_values(); const std::vector> &normals = - fe_v.get_present_fe_values().get_all_normal_vectors(); + fe_v.get_present_fe_values().get_normal_vectors(); std::vector> beta( fe_v.get_present_fe_values().n_quadrature_points); diff --git a/tests/mappings/mapping.cc b/tests/mappings/mapping.cc index 18cf78958d..d4d8a628f4 100644 --- a/tests/mappings/mapping.cc +++ b/tests/mappings/mapping.cc @@ -155,7 +155,7 @@ plot_subfaces(Mapping & mapping, fe_values.reinit(cell, face_nr, sub_nr); const std::vector> &normals = - fe_values.get_all_normal_vectors(); + fe_values.get_normal_vectors(); unsigned int k = 0; for (unsigned int ny = 0; ny < ((dim > 2) ? nq : 1); ++ny) diff --git a/tests/mappings/mapping_c1.cc b/tests/mappings/mapping_c1.cc index c1b45780eb..d1d144d604 100644 --- a/tests/mappings/mapping_c1.cc +++ b/tests/mappings/mapping_c1.cc @@ -100,7 +100,7 @@ main() // there should now be two // normal vectors, one for // each vertex of the face - Assert(c1_values.get_all_normal_vectors().size() == 2, + Assert(c1_values.get_normal_vectors().size() == 2, ExcInternalError()); // check that these two