]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Remove deprecated functions with names that contain cell_normal.
authorWolfgang Bangerth <bangerth@math.tamu.edu>
Thu, 8 Jan 2015 21:32:35 +0000 (15:32 -0600)
committerWolfgang Bangerth <bangerth@math.tamu.edu>
Sat, 10 Jan 2015 22:19:43 +0000 (16:19 -0600)
doc/news/changes.h
include/deal.II/fe/fe_values.h
source/fe/fe_values.cc
tests/codim_one/bem.cc
tests/codim_one/gradients.cc
tests/codim_one/mapping_01.cc
tests/codim_one/mapping_02.cc
tests/codim_one/surface.cc

index eeafdafe44fb2ad03458ae8b9919e17f68f90e77..48ddc448aabd6c8dfb8532328332830e31b2d17b 100644 (file)
@@ -112,7 +112,10 @@ inconvenience this causes.
   term <code>2nd_derivatives</code> were removed in favor of those
   with names containing <code>hessian</code>. Similarly, functions
   with names including <code>function_grads</code> were removed in
-  favor of those called <code>function_gradients</code>.
+  favor of those called <code>function_gradients</code>. Finally,
+  the <code>cell_normal_vector</code> functions were replaced by
+  <code>normal_vector</code> ones. In all cases, the new functions
+  have been around for a while.
 
 <!-- ----------- GENERAL IMPROVEMENTS ----------------- -->
 
index abf488fb826948b0c5f63cefeecca18a4dd662cb..37278865a61c201149c41d4d982b57cd999dc231 100644 (file)
@@ -2171,21 +2171,6 @@ public:
                   const std::vector<Tensor<1,dim> > &original,
                   MappingType mapping) const;
 
-  /**
-   * @deprecated Use normal_vector() instead.
-   *
-   * Return the outward normal vector to the cell at the <tt>i</tt>th
-   * quadrature point. The length of the vector is normalized to one.
-   */
-  const Point<spacedim> &cell_normal_vector (const unsigned int i) const DEAL_II_DEPRECATED;
-
-  /**
-   * @deprecated Use get_normal_vectors() instead.
-   *
-   * Returns the vectors normal to the cell in each of the quadrature points.
-   */
-  const std::vector<Point<spacedim> > &get_cell_normal_vectors () const DEAL_II_DEPRECATED;
-
   //@}
 
   /// @name Extractors Methods to extract individual components
@@ -4081,17 +4066,6 @@ FEValuesBase<dim,spacedim>::normal_vector (const unsigned int i) const
 
 
 
-template <int dim, int spacedim>
-inline
-const Point<spacedim> &
-FEValuesBase<dim,spacedim>::cell_normal_vector (const unsigned int i) const
-{
-  return this->normal_vector(i);
-}
-
-
-
-
 /*------------------------ Inline functions: FEValues ----------------------------*/
 
 
index d0566b0d29bc0f7ca32e749bedad89e3bdcafb24..42e53aeef7733ea3e98c86fad6c74575815ab1f2 100644 (file)
@@ -3147,14 +3147,6 @@ FEValuesBase<dim,spacedim>::get_normal_vectors () const
 
 
 
-template <int dim, int spacedim>
-const std::vector<Point<spacedim> > &
-FEValuesBase<dim,spacedim>::get_cell_normal_vectors () const
-{
-  return this->get_normal_vectors ();
-}
-
-
 template <int dim, int spacedim>
 void
 FEValuesBase<dim,spacedim>::transform (
index 8d7894c1be2a89a7fd7fe601092cc5c160c226b9..3aeb12ab3888532b652e8af90fc67095c851dc3b 100644 (file)
@@ -246,11 +246,11 @@ BEM<spacedim>::assemble_system()
   FEValues<spacedim-1, spacedim>
   fe_values_i (fe, quadrature_formula,
                update_JxW_values |
-               update_cell_normal_vectors |
+               update_normal_vectors |
                update_quadrature_points ),
                                         fe_values_j (fe, quadrature_formula,
                                                      update_JxW_values |
-                                                     update_cell_normal_vectors |
+                                                     update_normal_vectors |
                                                      update_quadrature_points );
 
   const unsigned int        dofs_per_cell = fe.dofs_per_cell;
@@ -289,7 +289,7 @@ BEM<spacedim>::assemble_system()
     {
 
       fe_values_i.reinit (cell_i);
-      cell_normals_i = fe_values_i.get_cell_normal_vectors();
+      cell_normals_i = fe_values_i.get_normal_vectors();
       cell_i->get_dof_indices (local_dof_indices_i);
 
 //  if (cell_i->index()%100==0)
@@ -353,7 +353,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_cell_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)
@@ -568,7 +568,7 @@ BEM<spacedim>::solve()
                                                 q_iterated,
                                                 update_values |
                                                 update_gradients |
-                                                update_cell_normal_vectors );
+                                                update_normal_vectors );
 
   std::vector< Point<spacedim> > cell_normals(q_iterated.size());
   std::vector< Point<spacedim> > cell_tangentials(q_iterated.size());
@@ -596,7 +596,7 @@ BEM<spacedim>::solve()
 //  std::cout<<std::endl;
 
 
-      cell_normals = fe_values_q.get_cell_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 fb121d95144510b097829d4add2235188f507f95..ffb47b0357ce057f1a3143f342c56e059d04f93d 100644 (file)
@@ -73,7 +73,7 @@ void test(std::string filename)
   FEValues<dim,spacedim> fe_values (fe, q_midpoint,
                                     update_values |
                                     update_JxW_values |
-                                    update_cell_normal_vectors |
+                                    update_normal_vectors |
                                     update_gradients);
 
   // finite elements used for the
@@ -83,7 +83,7 @@ void test(std::string filename)
   DoFHandler<dim,spacedim> dof_handler_help (triangulation);
   dof_handler_help.distribute_dofs (fe_help);
   FEValues<dim,spacedim> fe_values_help (fe_help, q_midpoint,
-                                         update_cell_normal_vectors);
+                                         update_normal_vectors);
 
   deallog
       << "no. of cells "<< triangulation.n_cells() <<std::endl;
@@ -140,7 +140,7 @@ void test(std::string filename)
 
       fe_values.reinit(cell);
       cell-> get_dof_indices (local_dof_indices);
-      cell_normals = fe_values.get_cell_normal_vectors();
+      cell_normals = fe_values.get_normal_vectors();
 
       // The cell tangential is calculated
       // in the midpoint of the cell. For
index d564a87e4d4782ba41ce7f9b721d015090665ede..c80bad5c1a54c66ef88667714f88e3f45120e084 100644 (file)
@@ -53,7 +53,7 @@ void test ()
   MappingQ1<dim-1,dim> mapping;
   FE_Q<dim-1,dim> fe (1);
 
-  FEValues<dim-1,dim> fe_values (mapping, fe, quadrature, update_cell_normal_vectors);
+  FEValues<dim-1,dim> fe_values (mapping, fe, quadrature, update_normal_vectors);
 
   for (typename Triangulation<dim-1,dim>::active_cell_iterator
        cell = boundary_mesh.begin_active(); cell != boundary_mesh.end();
@@ -66,7 +66,7 @@ void test ()
 
       for (unsigned int q=0; q<quadrature.size(); ++q)
         deallog << "  cell_normal[" << q << "] = "
-                << fe_values.cell_normal_vector(q)
+                << fe_values.normal_vector(q)
                 << std::endl;
     }
 }
index 900a671e3d52c3b635941764feafda415402a66e..d2c276c7204f60f170c37f9f1c31a2e8a1ae07f6 100644 (file)
@@ -50,7 +50,7 @@ void test ()
   MappingQ<dim-1,dim> mapping(2);
   FE_Q<dim-1,dim> fe (1);
 
-  FEValues<dim-1,dim> fe_values (mapping, fe, quadrature, update_cell_normal_vectors);
+  FEValues<dim-1,dim> fe_values (mapping, fe, quadrature, update_normal_vectors);
 
   for (typename Triangulation<dim-1,dim>::active_cell_iterator
        cell = boundary_mesh.begin_active(); cell != boundary_mesh.end();
@@ -63,7 +63,7 @@ void test ()
 
       for (unsigned int q=0; q<quadrature.size(); ++q)
         deallog << "  cell_normal[" << q << "] = "
-                << fe_values.cell_normal_vector(q)
+                << fe_values.normal_vector(q)
                 << std::endl;
     }
 }
index 4664e1215c080b0891fc400c42525d3658220b4e..c36a1352fe88004f0531d66e2e1bd1518a2db02e 100644 (file)
@@ -59,7 +59,7 @@ void test(std::string filename)
 
   FEValues<dim,spacedim> fe_values (dummy_fe, quadrature,
                                     update_JxW_values |
-                                    update_cell_normal_vectors |
+                                    update_normal_vectors |
                                     update_quadrature_points);
 
   dof_handler.distribute_dofs (dummy_fe);
@@ -76,7 +76,7 @@ void test(std::string filename)
   for (; cell!=endc; ++cell)
     {
       fe_values.reinit (cell);
-      const std::vector<Point<spacedim> > &cellnormals = fe_values.get_cell_normal_vectors();
+      const std::vector<Point<spacedim> > &cellnormals = fe_values.get_normal_vectors();
       const std::vector<Point<spacedim> > &quad_points = fe_values.get_quadrature_points();
 
       for (unsigned int i=0; i<fe_values.n_quadrature_points; ++i)

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.