]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Remove FEValuesBase::get_all_normal_vectors 9742/head
authorDaniel Arndt <arndtd@ornl.gov>
Thu, 26 Mar 2020 16:23:09 +0000 (12:23 -0400)
committerDaniel Arndt <arndtd@ornl.gov>
Thu, 26 Mar 2020 22:43:00 +0000 (18:43 -0400)
18 files changed:
doc/news/changes/incompatibilities/20200326DanielArndt [new file with mode: 0644]
include/deal.II/fe/fe_values.h
include/deal.II/numerics/error_estimator.templates.h
include/deal.II/numerics/vector_tools.templates.h
source/fe/fe_values.cc
source/numerics/data_out_faces.cc
source/numerics/error_estimator_1d.cc
tests/bits/step-12.cc
tests/codim_one/bem.cc
tests/codim_one/bem_integration.cc
tests/codim_one/gradients.cc
tests/codim_one/surface.cc
tests/fe/fe_nedelec_sz_non_rect_face.cc
tests/fe/fe_q_dg0.cc
tests/fe/nedelec_non_rect_face.cc
tests/hp/step-12.cc
tests/mappings/mapping.cc
tests/mappings/mapping_c1.cc

diff --git a/doc/news/changes/incompatibilities/20200326DanielArndt b/doc/news/changes/incompatibilities/20200326DanielArndt
new file mode 100644 (file)
index 0000000..3599a22
--- /dev/null
@@ -0,0 +1,4 @@
+Removed: The deprecated FEValuesBase::get_all_normal_vectors() function has been
+removed. Use FEValuesBase::get_normal_vectors() instead.
+<br>
+(Daniel Arndt, 2020/03/26)
index 7d377fdc182840631c486573609b392fc8aa5fd0..9488af2116f499f534ce2136737fc7c7ec1b5cdb 100644 (file)
@@ -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<Tensor<1, spacedim>> &
-  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
index 815a42eed76587f5986a5640a3a09f7a4dc54998..fadd5516c895b6cc98c33be70a702089809be955 100644 (file)
@@ -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);
index 229f111e82f90cedc0ea8a59c90e5287a49341be..f9077dcf9f92767cda6bc317e421c39ad734dc1e 100644 (file)
@@ -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<Tensor<1, 2>> &normals =
-        fe_values.get_all_normal_vectors();
+      const FiniteElement<2> &         fe      = cell->get_fe();
+      const std::vector<Tensor<1, 2>> &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<Tensor<1, 3>> &normals =
-        fe_values.get_all_normal_vectors();
+      const FiniteElement<3> &         fe      = cell->get_fe();
+      const std::vector<Tensor<1, 3>> &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}};
index 2df4697bdca794aa3e9fd31b4afadf3753568bc2..7749fbb96f11ada56af6cd22f80c90d1aa345d46 100644 (file)
@@ -4194,18 +4194,6 @@ FEValuesBase<dim, spacedim>::get_cell() const
 
 
 
-template <int dim, int spacedim>
-const std::vector<Tensor<1, spacedim>> &
-FEValuesBase<dim, spacedim>::get_all_normal_vectors() const
-{
-  Assert(this->update_flags & update_normal_vectors,
-         (typename FEValuesBase<dim, spacedim>::ExcAccessToUninitializedField(
-           "update_normal_vectors")));
-  return get_normal_vectors();
-}
-
-
-
 template <int dim, int spacedim>
 const std::vector<Tensor<1, spacedim>> &
 FEValuesBase<dim, spacedim>::get_normal_vectors() const
index 46e27e839e67e9537056bff63a6e394b4a37398a..e40bda2f1bad17a05e7a12e7901240aa25872d1b 100644 (file)
@@ -190,7 +190,7 @@ DataOutFaces<dim, DoFHandlerType>::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<dim, DoFHandlerType>::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(),
index b63f26045e09dede451c03bb4c45d8d10761f22f..aa59e3f5081f80f5a78a238a34d425b2da663caa 100644 (file)
@@ -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.
index 48133a0738e4fdd2c3b0ea7bf6cc9378c0bd197c..3a06ab383b20ddbe801a80d2acb724f0a15b545c 100644 (file)
@@ -216,7 +216,7 @@ DGTransportEquation<dim>::assemble_boundary_term(
   Vector<double> &         cell_vector) const
 {
   const std::vector<double> &        JxW     = fe_v.get_JxW_values();
-  const std::vector<Tensor<1, dim>> &normals = fe_v.get_all_normal_vectors();
+  const std::vector<Tensor<1, dim>> &normals = fe_v.get_normal_vectors();
 
   std::vector<Point<dim>> beta(fe_v.n_quadrature_points);
   std::vector<double>     g(fe_v.n_quadrature_points);
@@ -249,7 +249,7 @@ DGTransportEquation<dim>::assemble_face_term1(
   FullMatrix<double> &         ue_vi_matrix) const
 {
   const std::vector<double> &        JxW     = fe_v.get_JxW_values();
-  const std::vector<Tensor<1, dim>> &normals = fe_v.get_all_normal_vectors();
+  const std::vector<Tensor<1, dim>> &normals = fe_v.get_normal_vectors();
 
   std::vector<Point<dim>> beta(fe_v.n_quadrature_points);
   beta_function.value_list(fe_v.get_quadrature_points(), beta);
@@ -282,7 +282,7 @@ DGTransportEquation<dim>::assemble_face_term2(
   FullMatrix<double> &         ue_ve_matrix) const
 {
   const std::vector<double> &        JxW     = fe_v.get_JxW_values();
-  const std::vector<Tensor<1, dim>> &normals = fe_v.get_all_normal_vectors();
+  const std::vector<Tensor<1, dim>> &normals = fe_v.get_normal_vectors();
 
   std::vector<Point<dim>> beta(fe_v.n_quadrature_points);
 
index 7ca7726b66b399fb3686cfaafb26d886925143a3..e89274b5afdfc129cb93921152b5be41cdaf4eac 100644 (file)
@@ -212,7 +212,7 @@ BEM<spacedim>::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<spacedim>::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<spacedim>::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];
index 9cab80f8e4d2ba72b943c515ee556f13e39670b1..38bea51b31f996822ac1d254c59fbc7542b6ff6b 100644 (file)
@@ -127,7 +127,7 @@ LaplaceKernelIntegration<2>::compute_SD_integral_on_cell(
   Assert(dst.size() == 2, ExcDimensionMismatch(dst.size(), 2));
   fe_values->reinit(cell);
   vector<DerivativeForm<1, 2, 3>> jacobians = fe_values->get_jacobians();
-  vector<Tensor<1, 3>>            normals = fe_values->get_all_normal_vectors();
+  vector<Tensor<1, 3>>            normals   = fe_values->get_normal_vectors();
 
   Tensor<1, 3> n, n_c;
   Tensor<1, 3> r_c = point - cell->center();
index c706b68c4865ac2a53e1b4a5ea9916e2b16da7ad..c48be3601eb985a25339ef57a03d63b8b5e1a082 100644 (file)
@@ -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
index d6c1878473b917319aa81c95b78bb1521a1fe902..e100b76563f4f984db9614df22713a4e9b50e808 100644 (file)
@@ -76,7 +76,7 @@ test(std::string filename)
     {
       fe_values.reinit(cell);
       const std::vector<Tensor<1, spacedim>> &cellnormals =
-        fe_values.get_all_normal_vectors();
+        fe_values.get_normal_vectors();
       const std::vector<Point<spacedim>> &quad_points =
         fe_values.get_quadrature_points();
 
index 5d9fcf4342579323c9936f903dfff60e1bc8d7f5..11edbf8edb7d84bad19b995ea08758254789c0a7 100644 (file)
@@ -353,7 +353,7 @@ namespace Maxwell
     std::vector<Vector<double>> neumann_value_list(
       n_face_q_points, Vector<double>(fe.n_components()));
     std::vector<Tensor<1, dim>> 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;
index 259496587b8d65fd426658b27070a11ea6856dd3..308321cc385e271699570cab8172154bef55cc24 100644 (file)
@@ -602,7 +602,7 @@ namespace Step22
                     fe_v_face.reinit(cell, face_no);
 
                     const std::vector<Tensor<1, dim>> &normals =
-                      fe_v_face.get_all_normal_vectors();
+                      fe_v_face.get_normal_vectors();
                     const std::vector<Point<dim>> &quad_points =
                       fe_v_face.get_quadrature_points();
 
index 5b4e7b3127a41bdf88b22c9fac6ca387fedfd487..5a1c8df778dd518ba3bebc4e18bf5fceeec4efba 100644 (file)
@@ -354,7 +354,7 @@ namespace Maxwell
     std::vector<Vector<double>> neumann_value_list(
       n_face_q_points, Vector<double>(fe.n_components()));
     std::vector<Tensor<1, dim>> 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;
index 63ebe590eec2c2bd31285d3a31896d56a4e6c7a8..c09c1a3e856e6ff21be13105871e3dbce4c4acc9 100644 (file)
@@ -232,7 +232,7 @@ DGTransportEquation<dim>::assemble_boundary_term(
   const std::vector<double> &JxW =
     fe_v.get_present_fe_values().get_JxW_values();
   const std::vector<Tensor<1, dim>> &normals =
-    fe_v.get_present_fe_values().get_all_normal_vectors();
+    fe_v.get_present_fe_values().get_normal_vectors();
 
   std::vector<Point<dim>> beta(
     fe_v.get_present_fe_values().n_quadrature_points);
@@ -279,7 +279,7 @@ DGTransportEquation<dim>::assemble_face_term1(
   const std::vector<double> &JxW =
     fe_v.get_present_fe_values().get_JxW_values();
   const std::vector<Tensor<1, dim>> &normals =
-    fe_v.get_present_fe_values().get_all_normal_vectors();
+    fe_v.get_present_fe_values().get_normal_vectors();
 
   std::vector<Point<dim>> beta(
     fe_v.get_present_fe_values().n_quadrature_points);
@@ -328,7 +328,7 @@ DGTransportEquation<dim>::assemble_face_term2(
   const std::vector<double> &JxW =
     fe_v.get_present_fe_values().get_JxW_values();
   const std::vector<Tensor<1, dim>> &normals =
-    fe_v.get_present_fe_values().get_all_normal_vectors();
+    fe_v.get_present_fe_values().get_normal_vectors();
 
   std::vector<Point<dim>> beta(
     fe_v.get_present_fe_values().n_quadrature_points);
index 18cf78958dc3b05f0eab795d1ce5cb8390d9cfb8..d4d8a628f408fdc397e04e106ed9bdf93f9b4b65 100644 (file)
@@ -155,7 +155,7 @@ plot_subfaces(Mapping<dim> &                           mapping,
         fe_values.reinit(cell, face_nr, sub_nr);
 
         const std::vector<Tensor<1, dim>> &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)
index c1b45780eb1ecf4817554cccb31096d2429f2f68..d1d144d604a0be6292f6b7f50f7140896dcf9589 100644 (file)
@@ -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

In the beginning the Universe was created. This has made a lot of people very angry and has been widely regarded as a bad move.

Douglas Adams


Typeset in Trocchi and Trocchi Bold Sans Serif.