]> https://gitweb.dealii.org/ - dealii.git/commitdiff
step-57: remove unused headers and code.
authorDavid Wells <drwells@email.unc.edu>
Sat, 27 Oct 2018 15:36:33 +0000 (11:36 -0400)
committerDavid Wells <drwells@email.unc.edu>
Sat, 27 Oct 2018 17:25:41 +0000 (13:25 -0400)
examples/step-57/step-57.cc

index e2255fe9778530b90c606c0569477182bf62ece1..48159b7cb0d1b6e811ed504c029372ff0136a327 100644 (file)
@@ -21,7 +21,6 @@
 // As usual, we start by including some well-known files:
 #include <deal.II/base/quadrature_lib.h>
 #include <deal.II/base/function.h>
-#include <deal.II/base/logstream.h>
 #include <deal.II/base/utilities.h>
 #include <deal.II/base/tensor.h>
 
 
 #include <deal.II/grid/tria.h>
 #include <deal.II/grid/grid_generator.h>
-#include <deal.II/grid/tria_accessor.h>
-#include <deal.II/grid/tria_iterator.h>
-#include <deal.II/grid/manifold_lib.h>
 #include <deal.II/grid/grid_refinement.h>
 #include <deal.II/grid/grid_tools.h>
 
 #include <deal.II/dofs/dof_handler.h>
 #include <deal.II/dofs/dof_renumbering.h>
-#include <deal.II/dofs/dof_accessor.h>
 #include <deal.II/dofs/dof_tools.h>
 
 #include <deal.II/fe/fe_q.h>
@@ -165,9 +160,6 @@ namespace Step57
     {}
     virtual double value(const Point<dim> & p,
                          const unsigned int component) const override;
-
-    virtual void vector_value(const Point<dim> &p,
-                              Vector<double> &  values) const override;
   };
 
   template <int dim>
@@ -182,15 +174,6 @@ namespace Step57
     return 0;
   }
 
-  template <int dim>
-  void BoundaryValues<dim>::vector_value(const Point<dim> &p,
-                                         Vector<double> &  values) const
-  {
-    for (unsigned int c = 0; c < this->n_components; ++c)
-      values(c) = BoundaryValues<dim>::value(p, c);
-  }
-
-
   // @sect3{BlockSchurPreconditioner for Navier Stokes equations}
   //
   // The block
@@ -424,11 +407,7 @@ namespace Step57
     std::vector<Tensor<2, dim>> grad_phi_u(dofs_per_cell);
     std::vector<double>         phi_p(dofs_per_cell);
 
-    typename DoFHandler<dim>::active_cell_iterator cell =
-                                                     dof_handler.begin_active(),
-                                                   endc = dof_handler.end();
-
-    for (; cell != endc; ++cell)
+    for (const auto &cell : dof_handler.active_cell_iterators())
       {
         fe_values.reinit(cell);
 

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.