]> https://gitweb.dealii.org/ - dealii.git/commitdiff
tests: favor auto & cell
authorMatthias Maier <tamiko@43-1.org>
Sun, 12 May 2019 04:18:48 +0000 (23:18 -0500)
committerMatthias Maier <tamiko@43-1.org>
Sun, 12 May 2019 15:35:21 +0000 (10:35 -0500)
55 files changed:
tests/bits/cone_04.cc
tests/data_out/data_out_12.cc
tests/data_out/data_out_13.cc
tests/dofs/dof_renumbering_10.cc
tests/dofs/dof_tools_04a.cc
tests/dofs/locally_owned_dofs_per_subdomain_01.cc
tests/dofs/range_based_for_step-6.cc
tests/dofs/range_based_for_tria.cc
tests/fe/fe_enriched_color_07.cc
tests/fe/fe_enriched_color_08.cc
tests/grid/accessor_01.cc
tests/grid/cell_id_05.cc
tests/grid/distributed_compute_point_locations_02.cc
tests/grid/distributed_compute_point_locations_03.cc
tests/grid/get_coarse_mesh_description_01.cc
tests/grid/grid_tools_propagate_manifold_ids_01.cc
tests/grid/merge_triangulations_04.cc
tests/grid/n_faces_01.cc
tests/grid/oned_vertex_manifold.cc
tests/grid/project_to_object_01.cc
tests/hp/fe_nothing_19.cc
tests/manifold/flat_manifold_09.cc
tests/manifold/spherical_manifold_09.cc
tests/manifold/spherical_manifold_10.cc
tests/manifold/spherical_manifold_12.cc
tests/manifold/transfinite_manifold_06.cc
tests/matrix_free/cell_categorization_02.cc
tests/matrix_free/dof_info_01.cc
tests/matrix_free/dof_info_02.cc
tests/mpi/hp_renumber_01.cc
tests/mpi/hp_unify_dof_indices_01.cc
tests/mpi/hp_unify_dof_indices_02.cc
tests/mpi/hp_unify_dof_indices_03.cc
tests/mpi/hp_unify_dof_indices_04.cc
tests/mpi/hp_unify_dof_indices_05.cc
tests/mpi/hp_unify_dof_indices_06.cc
tests/mpi/hp_unify_dof_indices_08.cc
tests/mpi/hp_unify_dof_indices_10.cc
tests/mpi/periodicity_06.cc
tests/mpi/periodicity_07.cc
tests/mpi/step-37.cc
tests/multigrid/renumbering_05.cc
tests/multigrid/renumbering_06.cc
tests/multigrid/renumbering_07.cc
tests/multigrid/renumbering_08.cc
tests/non_matching/coupling_05.cc
tests/non_matching/coupling_06.cc
tests/sharedtria/communicate_active_fe_indices_01.cc
tests/sharedtria/communicate_active_fe_indices_01a.cc
tests/sharedtria/communicate_active_fe_indices_01b.cc
tests/sharedtria/communicate_active_fe_indices_02.cc
tests/sharedtria/hp_no_cells_01.cc
tests/sharedtria/no_cells_01.cc
tests/trilinos/solver_control_06.cc
tests/vector_tools/integrate_difference_04_hp_02.cc

index be6477fcc228afdef6c7812a219e9df294adab5b..877bd0b9446a01a588ad5694d27c89e8336daf96 100644 (file)
@@ -39,7 +39,7 @@ check()
 
   triangulation.refine_global(2);
 
-  for (const auto cell : triangulation.active_cell_iterators())
+  for (const auto &cell : triangulation.active_cell_iterators())
     for (unsigned int face_no = 0; face_no < GeometryInfo<dim>::faces_per_cell;
          ++face_no)
       {
index d4a064a8bf8f2344c677d51a3ffbea36579c9751..598d45fbfd7703aed0287f3f4091b0ba855fb60f 100644 (file)
@@ -107,7 +107,7 @@ check()
 
   const Quadrature<dim> support_quadrature(fe.get_unit_support_points());
   FEValues<dim> fe_values(fe, support_quadrature, update_quadrature_points);
-  for (const auto cell : dof_handler.active_cell_iterators())
+  for (const auto &cell : dof_handler.active_cell_iterators())
     {
       fe_values.reinit(cell);
       const auto &qp = fe_values.get_quadrature_points();
index 582285c0d2181f10662f4cd18a050f17ef1bab06..1f888117b67349981c8d61896e2a5a72fa03f72e 100644 (file)
@@ -107,7 +107,7 @@ check()
 
   const Quadrature<dim> support_quadrature(fe.get_unit_support_points());
   FEValues<dim> fe_values(fe, support_quadrature, update_quadrature_points);
-  for (const auto cell : dof_handler.active_cell_iterators())
+  for (const auto &cell : dof_handler.active_cell_iterators())
     {
       fe_values.reinit(cell);
       const auto &qp = fe_values.get_quadrature_points();
index ff0204b5256757b8412fdeeacda20e6f42224975..e6d4a59a362d637a9c81d47a09e33eb66b47ac41 100644 (file)
@@ -50,12 +50,12 @@ test(const bool adaptive_ref = true)
   tria.refine_global(1);
   if (adaptive_ref)
     {
-      for (auto cell : tria.active_cell_iterators())
+      for (auto &cell : tria.active_cell_iterators())
         if (cell->is_locally_owned())
           if (cell->center().norm() < 0.5)
             cell->set_refine_flag();
       tria.execute_coarsening_and_refinement();
-      for (auto cell : tria.active_cell_iterators())
+      for (auto &cell : tria.active_cell_iterators())
         if (cell->is_locally_owned())
           if (cell->center()[0] < 0.2)
             cell->set_refine_flag();
index 2716d76cd0f5e4fd42aa1646c114ca86bf072f68..c786808a9a734ebf89939a99416228d735ccd7ae 100644 (file)
@@ -88,7 +88,7 @@ check(const FiniteElement<dim> &fe, const std::string &name)
   tria.refine_global(1);
   for (unsigned int ref = 0; ref < 2; ++ref)
     {
-      for (auto cell : tria.active_cell_iterators())
+      for (auto &cell : tria.active_cell_iterators())
         if (cell->is_locally_owned() && cell->center()(0) < .5 &&
             cell->center()(1) < .5)
           cell->set_refine_flag();
index fc143e0c0c82b407bdcb535ec03b5c2ea2e90c95..b13000808631358b03e0cc11ea8d1d61729f9c52 100644 (file)
@@ -58,7 +58,7 @@ main()
   GridTools::partition_triangulation(n_subdomains, tria);
 
   hp::DoFHandler<dim> hp_dof_handler(tria);
-  for (auto cell : hp_dof_handler.active_cell_iterators())
+  for (auto &cell : hp_dof_handler.active_cell_iterators())
     {
       if (cell == hp_dof_handler.begin_active())
         cell->set_active_fe_index(0); // FE_Q
index b3ec2c9b2a7aaef3e3132c4167fc6f06fa253935..6e7b342a4e288b574888ca8050bda548f22ca56f 100644 (file)
@@ -223,7 +223,7 @@ Step6<dim>::assemble_system()
   const Coefficient<dim> coefficient;
   std::vector<double>    coefficient_values(n_q_points);
 
-  for (auto cell : dof_handler.active_cell_iterators())
+  for (auto &cell : dof_handler.active_cell_iterators())
     {
       cell_matrix = 0;
       cell_rhs    = 0;
index 236c7c9ec26e426215339bf7797c642af7cb53a2..1e9876d9f6f8118a5c5090d8fd4c72e3b98412a8 100644 (file)
@@ -39,11 +39,11 @@ check()
   {
     // set flags on active cells
     tr.clear_user_flags();
-    for (auto cell : tr.active_cell_iterators())
+    for (auto &cell : tr.active_cell_iterators())
       cell->set_user_flag();
 
     // now verify that it is really only the active cells
-    for (auto cell : tr.cell_iterators())
+    for (auto &cell : tr.cell_iterators())
       AssertThrow(cell->user_flag_set() == !cell->has_children(),
                   ExcInternalError());
   }
@@ -52,14 +52,14 @@ check()
   for (unsigned int l = 0; l < tr.n_levels(); ++l)
     {
       tr.clear_user_flags();
-      for (auto cell : tr.active_cell_iterators_on_level(l))
+      for (auto &cell : tr.active_cell_iterators_on_level(l))
         cell->set_user_flag();
 
-      for (auto cell : tr.cell_iterators_on_level(l))
+      for (auto &cell : tr.cell_iterators_on_level(l))
         AssertThrow(cell->user_flag_set() == !cell->has_children(),
                     ExcInternalError());
 
-      for (auto cell : tr.cell_iterators())
+      for (auto &cell : tr.cell_iterators())
         AssertThrow((cell->user_flag_set() == !cell->has_children()) ||
                       (l != (unsigned int)cell->level()),
                     ExcInternalError());
index 1ff3fa834e051c4fd482b2b1d14da263c850d342..6a761f8d4a14e3376d384491469964769000e0a9 100644 (file)
@@ -934,7 +934,7 @@ plot_shape_function(hp::DoFHandler<dim> &dof_handler, unsigned int patches = 5)
 
   // find set of dofs which belong to enriched cells
   std::set<unsigned int> enriched_cell_dofs;
-  for (auto cell : dof_handler.active_cell_iterators())
+  for (auto &cell : dof_handler.active_cell_iterators())
     if (cell->active_fe_index() != 0)
       {
         unsigned int dofs_per_cell = cell->get_fe().dofs_per_cell;
@@ -1014,7 +1014,7 @@ plot_shape_function(hp::DoFHandler<dim> &dof_handler, unsigned int patches = 5)
 
   // get material ids:
   Vector<float> fe_index(dof_handler.get_triangulation().n_active_cells());
-  for (auto cell : dof_handler.active_cell_iterators())
+  for (auto &cell : dof_handler.active_cell_iterators())
     {
       fe_index[cell->active_cell_index()] = cell->active_fe_index();
     }
@@ -1500,7 +1500,7 @@ LaplaceProblem<dim>::assemble_system()
                                    update_JxW_values);
 
 
-  for (auto cell : dof_handler.active_cell_iterators())
+  for (auto &cell : dof_handler.active_cell_iterators())
     if (cell->subdomain_id() == this_mpi_process)
       {
         fe_values_hp.reinit(cell);
index 8457335bbc9b9678ac65629edba061dcb78661ce..9669a9e68ce336fb7581c429f3668fa6f10d39ca 100644 (file)
@@ -64,7 +64,7 @@ plot_shape_function(hp::DoFHandler<dim> &dof_handler, unsigned int patches = 5)
 
   // find set of dofs which belong to enriched cells
   std::set<unsigned int> enriched_cell_dofs;
-  for (auto cell : dof_handler.active_cell_iterators())
+  for (auto &cell : dof_handler.active_cell_iterators())
     if (cell->active_fe_index() != 0)
       {
         unsigned int dofs_per_cell = cell->get_fe().dofs_per_cell;
@@ -146,7 +146,7 @@ plot_shape_function(hp::DoFHandler<dim> &dof_handler, unsigned int patches = 5)
 
   // get material ids:
   Vector<float> fe_index(dof_handler.get_triangulation().n_active_cells());
-  for (auto cell : dof_handler.active_cell_iterators())
+  for (auto &cell : dof_handler.active_cell_iterators())
     {
       fe_index[cell->active_cell_index()] = cell->active_fe_index();
     }
index b340738dcf49f0b0d78953aa9aeb0620d0d1b3cd..285b9e23d1dda283c4bf693565becc1cc02bc37d 100644 (file)
@@ -42,7 +42,7 @@ test()
 
   std::map<typename Triangulation<dim, spacedim>::face_iterator, double> mymap;
 
-  for (auto cell : tria.active_cell_iterators())
+  for (auto &cell : tria.active_cell_iterators())
     {
       for (unsigned int i = 0; i < GeometryInfo<dim>::faces_per_cell; ++i)
         {
index 2f2ec9af1be8797c235ac6d3b64ad5c616daf13a..0ac68f8f96ebe1258c3c3f44354e6e1eee9d1d93 100644 (file)
@@ -35,7 +35,7 @@ test(const unsigned int &ref)
   GridGenerator::hyper_cube(tria);
   tria.refine_global(ref);
   std::vector<CellId> cell_ids;
-  for (auto cell : tria.active_cell_iterators())
+  for (auto &cell : tria.active_cell_iterators())
     {
       cell_ids.push_back(cell->id());
     }
@@ -46,7 +46,7 @@ test(const unsigned int &ref)
 
   unsigned int i  = 0;
   bool         ok = true;
-  for (auto cell : tria.active_cell_iterators())
+  for (auto &cell : tria.active_cell_iterators())
     {
       if (cell->id() != unpacked[i++])
         {
index 13a7377b3cad6b3ff11bee0c5ce8805e65fa14b2..bd7c0498afc7f1b2a00acf69a71fe918fa9a44cd 100644 (file)
@@ -86,7 +86,7 @@ test_compute_pt_loc(unsigned int ref_cube, unsigned int ref_sphere)
   std::vector<std::vector<unsigned int>> computed_ranks;
 
   unsigned int computed_pts = 0;
-  for (auto cell : sphere.active_cell_iterators())
+  for (auto &cell : sphere.active_cell_iterators())
     {
       // The points we consider are the cell centers
       auto center_pt = cell->center();
index 0475061708ecc0b0f793270d4a44f4ec7be3c793..ce5f8ac8a04541c1a8bb46d8381c888867d2817e 100644 (file)
@@ -62,7 +62,7 @@ test_distributed_cpt(unsigned int ref_cube)
   Triangulation<dim>      cube;
   GridGenerator::hyper_cube(cube);
   cube.refine_global(ref_cube);
-  for (auto cell : cube.active_cell_iterators())
+  for (auto &cell : cube.active_cell_iterators())
     test_points.emplace_back(cell->center());
 
   deallog << " Testing on " << test_points.size() << " points" << std::endl;
index 23980a44a1879d7acf4bec1f064f22b668981c4e..c7e21dc99ce2a93b1f5a540a45a7212ab6906262 100644 (file)
@@ -28,13 +28,13 @@ void setup_tria(Triangulation<1> &tria)
 {
   GridGenerator::subdivided_hyper_rectangle(
     tria, std::vector<unsigned int>(5u, 1), Point<1>(), Point<1>(1.5), true);
-  for (auto cell : tria.active_cell_iterators())
+  for (auto &cell : tria.active_cell_iterators())
     cell->set_material_id(
       static_cast<types::material_id>(10.0 * (3.0 + cell->center()[0])));
   for (auto face : tria.active_face_iterators())
     if (0.5 < face->center()[0])
       face->set_all_manifold_ids(42);
-  for (auto cell : tria.active_cell_iterators())
+  for (auto &cell : tria.active_cell_iterators())
     cell->set_manifold_id(
       static_cast<types::material_id>(10.0 * (2.0 + cell->center()[0])));
 }
@@ -51,7 +51,7 @@ setup_tria(Triangulation<dim> &tria)
   for (auto face : tria.active_face_iterators())
     if (face->at_boundary() && 0.0 < face->center()[0])
       face->set_boundary_id(42);
-  for (auto cell : tria.active_cell_iterators())
+  for (auto &cell : tria.active_cell_iterators())
     if (cell->center() != Point<dim>())
       {
         const double angle = std::atan2(cell->center()[0], cell->center()[1]);
@@ -63,7 +63,7 @@ setup_tria(Triangulation<dim> &tria)
   for (auto face : tria.active_face_iterators())
     if (-0.1 < face->center()[0])
       face->set_all_manifold_ids(42);
-  for (auto cell : tria.active_cell_iterators())
+  for (auto &cell : tria.active_cell_iterators())
     if (cell->center() != Point<dim>())
       {
         const double angle = std::atan2(cell->center()[0], cell->center()[1]);
index d6ab8c290dcfa9edad0840ca41c53bd72d797f28..e0e32fa3412215d2e86a98fa18d2032c3e3850ec 100644 (file)
@@ -44,7 +44,7 @@ test()
   };
 
   GridTools::assign_co_dimensional_manifold_indicators(tria, validate);
-  for (auto cell : tria.active_cell_iterators())
+  for (auto &cell : tria.active_cell_iterators())
     {
       deallog << "Cell: " << (int)cell->manifold_id() << std::endl;
       if (dim > 1)
index 7f56bb4707631a78e9a79ed1551cdb9c0af2eeb5..e1ecc17aa0302310c196d820a121d3fb18a24656 100644 (file)
@@ -36,7 +36,7 @@ main()
                                             Point<2>(2.2, 0.41));
   std::set<Triangulation<2>::active_cell_iterator> cells_to_remove;
   Tensor<1, 2> cylinder_triangulation_offset;
-  for (const auto cell : bulk_triangulation.active_cell_iterators())
+  for (const auto &cell : bulk_triangulation.active_cell_iterators())
     {
       if ((cell->center() - Point<2>(0.2, 0.2)).norm() < 0.15)
         cells_to_remove.insert(cell);
@@ -67,13 +67,13 @@ main()
                                                   0.41 / 4.0);
   GridTools::shift(cylinder_triangulation_offset, cylinder_triangulation);
   // dumb hack
-  for (const auto cell : cylinder_triangulation.active_cell_iterators())
+  for (const auto &cell : cylinder_triangulation.active_cell_iterators())
     cell->set_material_id(2);
 
   // merge them together
   auto minimal_line_length = [](const Triangulation<2> &tria) -> double {
     double min_line_length = std::numeric_limits<double>::max();
-    for (const auto cell : tria.active_cell_iterators())
+    for (const auto &cell : tria.active_cell_iterators())
       for (unsigned int line_n = 0; line_n < GeometryInfo<2>::lines_per_cell;
            ++line_n)
         min_line_length = std::min(min_line_length,
@@ -100,7 +100,7 @@ main()
 
   const types::manifold_id tfi_id   = 1;
   const types::manifold_id polar_id = 0;
-  for (const auto cell : result_2.active_cell_iterators())
+  for (const auto &cell : result_2.active_cell_iterators())
     {
       // set all non-boundary manifold ids to the new TFI manifold id.
       if (cell->material_id() == 2)
@@ -125,7 +125,7 @@ main()
   result_2.set_manifold(tfi_id, inner_manifold);
 
   std::vector<Point<2> *> inner_pointers;
-  for (const auto cell : result_2.active_cell_iterators())
+  for (const auto &cell : result_2.active_cell_iterators())
     {
       for (unsigned int face_n = 0; face_n < GeometryInfo<2>::faces_per_cell;
            ++face_n)
@@ -153,7 +153,7 @@ main()
     *ptr += Point<2>(0.2, 0.2) - center;
 
   result_2.refine_global(1);
-  for (const auto cell : result_2.active_cell_iterators())
+  for (const auto &cell : result_2.active_cell_iterators())
     {
       if (cell->at_boundary())
         {
index 802d35f06caec89a9e6e33592ccb84a1e0e8b493..f2851d6656908ed12ede6051f21395f21d71abe3 100644 (file)
@@ -42,7 +42,7 @@ test()
     mymap;
 
   unsigned int face_counter = 0;
-  for (auto cell : tria.active_cell_iterators())
+  for (auto &cell : tria.active_cell_iterators())
     {
       for (unsigned int i = 0; i < GeometryInfo<dim>::faces_per_cell; ++i)
         {
index 026f344efc71104e28af4ca111016d9873b243c0..7b254e6ee7b9e5660ff5bb280731f362a098558c 100644 (file)
@@ -38,7 +38,7 @@ main()
 
   triangulation.begin_active()->set_all_manifold_ids(spherical_manifold_id);
 
-  for (const auto cell : triangulation.active_cell_iterators())
+  for (const auto &cell : triangulation.active_cell_iterators())
     {
       deallog << "current cell manifold id: " << cell->manifold_id()
               << std::endl;
index 4c2addd3772dc6949ae318606ede763ea04cfd91..efdc426481a959856f3ef69663bfcf912944b48e 100644 (file)
@@ -225,7 +225,7 @@ main()
             << std::endl;
 
     MappingQGeneric<2, 3> mapping(6);
-    for (auto cell : triangulation.active_cell_iterators())
+    for (auto &cell : triangulation.active_cell_iterators())
       {
         const Point<3> projected_point =
           GridTools::project_to_object(cell, trial_point);
index dfc50eedb797c2836ce17645db79bddfc2a71c6c..c04a64efd63ad9a520665aa2a80a939b0d7fd190 100644 (file)
@@ -58,7 +58,7 @@ test()
   dof_handler.distribute_dofs(fe);
 
   deallog << "n_dofs=" << dof_handler.n_dofs() << std::endl;
-  for (auto cell : dof_handler.active_cell_iterators())
+  for (auto &cell : dof_handler.active_cell_iterators())
     {
       deallog << cell << ": ";
       std::vector<types::global_dof_index> dof_indices(
index c035ea4bceab2108dd29bdf0da5620516227f155..bbda5eea891d92663004cbb4b8344407fe4781b2 100644 (file)
@@ -134,7 +134,7 @@ test()
   for (unsigned int step = 0; step < 10; ++step)
     {
       std::cout << "step " << step << std::endl;
-      for (auto cell : tria.active_cell_iterators())
+      for (auto &cell : tria.active_cell_iterators())
         {
           for (unsigned int v = 0; v < GeometryInfo<dim>::vertices_per_cell;
                ++v)
index 2ad30e08a325b5d771c4c931090dd20d1c10932d..f84e406f410107983550463c83b4c84c43c7b7cc 100644 (file)
@@ -40,7 +40,7 @@ main()
   tria.set_all_manifold_ids(0);
   tria.set_manifold(0, spherical);
 
-  for (auto cell : tria.active_cell_iterators())
+  for (auto &cell : tria.active_cell_iterators())
     for (unsigned int f = 0; f < GeometryInfo<dim>::faces_per_cell; ++f)
       if (cell->at_boundary(f))
         {
@@ -79,7 +79,7 @@ main()
                 << std::endl;
             }
         }
-  for (auto cell : tria.active_cell_iterators())
+  for (auto &cell : tria.active_cell_iterators())
     for (unsigned int f = 0; f < GeometryInfo<dim>::faces_per_cell; ++f)
       if (cell->at_boundary(f))
         {
index 6bc472fd81a847e636d0c7679344fee1bb4a6326..0d78cbbd9f93e8090b157cf145884f6c7a3ed5c2 100644 (file)
@@ -54,7 +54,7 @@ main()
                               quadrature,
                               update_normal_vectors | update_quadrature_points);
 
-  for (auto cell : tria.active_cell_iterators())
+  for (auto &cell : tria.active_cell_iterators())
     for (unsigned int f = 0; f < GeometryInfo<dim>::faces_per_cell; ++f)
       {
         fe_values.reinit(cell, f);
index bd8a8c849c2326b2556f49d3d8c90eba797bee97..71c8f1706f6c27535c26662b942cbf61f1228ea7 100644 (file)
@@ -57,7 +57,7 @@ main()
                               quadrature,
                               update_normal_vectors | update_quadrature_points);
 
-  for (auto cell : tria.active_cell_iterators())
+  for (auto &cell : tria.active_cell_iterators())
     for (unsigned int f = 0; f < GeometryInfo<dim>::faces_per_cell; ++f)
       if (cell->at_boundary(f))
         {
index d189915b05cbab2f156203b898631ea4dc116934..af63cd4b19c0a2a0a70c3dcd206e45721fb3099c 100644 (file)
@@ -65,7 +65,7 @@ main()
 
   deallog.precision(10);
   deallog << "Cell centers" << std::endl;
-  for (auto cell : tria.cell_iterators())
+  for (auto &cell : tria.cell_iterators())
     deallog << cell->id() << " has center "
             << cell->center(/*respect_manifold*/ true) << std::endl;
 
index d893c3cbf417dafeb8828577e303772437d988f5..2f3ee24b42b64ccd271cbdb19096a9abffc0c5fe 100644 (file)
@@ -71,7 +71,7 @@ test()
                                               bottom_left,
                                               top_right);
 
-    for (auto cell : tria.active_cell_iterators())
+    for (auto &cell : tria.active_cell_iterators())
       {
         if (cell->center()[0] < 24.)
           cell->set_material_id(0);
index 462abcac78804a35ba08e5dffd67f82fbff26170..9596192e9d0de47c8e067f4278a8b7db8820cb70 100644 (file)
@@ -52,12 +52,12 @@ test(const bool adaptive_ref = true)
   tria.refine_global(1);
   if (adaptive_ref)
     {
-      for (auto cell : tria.active_cell_iterators())
+      for (auto &cell : tria.active_cell_iterators())
         if (cell->is_locally_owned())
           if (cell->center().norm() < 0.5)
             cell->set_refine_flag();
       tria.execute_coarsening_and_refinement();
-      for (auto cell : tria.active_cell_iterators())
+      for (auto &cell : tria.active_cell_iterators())
         if (cell->is_locally_owned())
           if (cell->center()[0] < 0.2)
             cell->set_refine_flag();
index a980641a68d4756255bc481903c8b8119157e5b2..70dbdc726b8cb7e883cf8376f98b4c59535edd72 100644 (file)
@@ -53,12 +53,12 @@ test(const bool adaptive_ref = true)
   tria.refine_global(1);
   if (adaptive_ref)
     {
-      for (auto cell : tria.active_cell_iterators())
+      for (auto &cell : tria.active_cell_iterators())
         if (cell->is_locally_owned())
           if (cell->center().norm() < 0.5)
             cell->set_refine_flag();
       tria.execute_coarsening_and_refinement();
-      for (auto cell : tria.active_cell_iterators())
+      for (auto &cell : tria.active_cell_iterators())
         if (cell->is_locally_owned())
           if (cell->center()[0] < 0.2)
             cell->set_refine_flag();
index 739b30609acf3661a47ce0080b1a4154611a9187..3edd3a12331beccd8e786599c2fdca0b8dde2b59 100644 (file)
@@ -68,7 +68,7 @@ test()
   fe.push_back(FE_Q<dim>(2));
 
   hp::DoFHandler<dim> dof_handler(triangulation);
-  for (auto cell : dof_handler.active_cell_iterators())
+  for (auto &cell : dof_handler.active_cell_iterators())
     {
       if (cell->is_locally_owned())
         {
@@ -94,7 +94,7 @@ test()
 
   deallog << "Processor: " << Utilities::MPI::this_mpi_process(MPI_COMM_WORLD)
           << std::endl;
-  for (auto cell : dof_handler.active_cell_iterators())
+  for (auto &cell : dof_handler.active_cell_iterators())
     {
       deallog << "  Cell: " << cell << std::endl;
 
index 100bdea0c4d6cb4d0054791faaae2dec19bbe262..d2d369a0c99d68a4a39af707680477b18a8adb32 100644 (file)
@@ -73,7 +73,7 @@ test()
 
   deallog << "Processor: " << Utilities::MPI::this_mpi_process(MPI_COMM_WORLD)
           << std::endl;
-  for (auto cell : dof_handler.active_cell_iterators())
+  for (auto &cell : dof_handler.active_cell_iterators())
     {
       deallog << "  Cell: " << cell << std::endl;
 
index f2da85198f81f389a54b4b1e8f9257fa76ab3ff2..d8f9b6d938c502fa39c8b34a4f599018955c992b 100644 (file)
@@ -71,7 +71,7 @@ test()
   fe.push_back(FE_Q<dim>(2));
 
   hp::DoFHandler<dim> dof_handler(triangulation);
-  for (auto cell : dof_handler.active_cell_iterators())
+  for (auto &cell : dof_handler.active_cell_iterators())
     {
       if (cell->is_locally_owned())
         {
@@ -89,7 +89,7 @@ test()
 
   deallog << "Processor: " << Utilities::MPI::this_mpi_process(MPI_COMM_WORLD)
           << std::endl;
-  for (auto cell : dof_handler.active_cell_iterators())
+  for (auto &cell : dof_handler.active_cell_iterators())
     {
       deallog << "  Cell: " << cell << std::endl;
 
index 2789e71f2449cb448d9c50f0a6ab26ea07a331c1..a0158909882bcea3bc99d7ea309fa778b3e6297b 100644 (file)
@@ -68,7 +68,7 @@ test()
   fe.push_back(FE_Q<dim>(2));
 
   hp::DoFHandler<dim> dof_handler(triangulation);
-  for (auto cell : dof_handler.active_cell_iterators())
+  for (auto &cell : dof_handler.active_cell_iterators())
     {
       if (cell->is_locally_owned())
         {
index 798d79f2203add9d4c53b8468ed54247cc3264cb..8dd4d5d60b116d9e514994940db6a2b326a03d11 100644 (file)
@@ -69,7 +69,7 @@ test()
   fe.push_back(FE_Q<dim>(2));
 
   hp::DoFHandler<dim> dof_handler(triangulation);
-  for (auto cell : dof_handler.active_cell_iterators())
+  for (auto &cell : dof_handler.active_cell_iterators())
     {
       if (cell->is_locally_owned())
         {
index 60360cec43154e4e9418d6e565c2576d98164ed7..76bf9896790d68be0725ffaee25c282cf6d5eb03 100644 (file)
@@ -69,7 +69,7 @@ test()
   fe.push_back(FE_Q<dim>(2));
 
   hp::DoFHandler<dim> dof_handler(triangulation);
-  for (auto cell : dof_handler.active_cell_iterators())
+  for (auto &cell : dof_handler.active_cell_iterators())
     {
       if (cell->is_locally_owned())
         {
index e71891d80d39cc77282c6eb36d9123536f27879f..de4d8602a6090b3418467eb9bd22f47771273750 100644 (file)
@@ -70,7 +70,7 @@ test()
 
 
   hp::DoFHandler<dim> dof_handler(triangulation);
-  for (auto cell : dof_handler.active_cell_iterators())
+  for (auto &cell : dof_handler.active_cell_iterators())
     {
       if (cell->is_locally_owned())
         {
index dd02c90afec81965bf6d71efdb8607c9778eec14..e6e43bf71b6783445066a41d070a262333cf669e 100644 (file)
@@ -88,7 +88,7 @@ test()
   // that to build a hash value from it that is then used to assign an
   // active_fe_index
   hp::DoFHandler<dim> dof_handler(triangulation);
-  for (auto cell : dof_handler.active_cell_iterators())
+  for (auto &cell : dof_handler.active_cell_iterators())
     if (cell->is_locally_owned())
       cell->set_active_fe_index(
         (cell->active_cell_index() +
index bb30a6297f4eebe444103f571efca54e5fa3eda6..9a9962dbe579d1ae9a01e128935324abfba94fde 100644 (file)
@@ -72,7 +72,7 @@ test()
   fe.push_back(FESystem<dim>(FE_Q<dim>(2), dim));
 
   hp::DoFHandler<dim> dof_handler(triangulation);
-  for (auto cell : dof_handler.active_cell_iterators())
+  for (auto &cell : dof_handler.active_cell_iterators())
     {
       if (cell->is_locally_owned())
         {
index cd86b29669995498e5b3b510e92c24fc6b558ec4..5fcc7a8b8dab5632f510c4884b63745c4d8e4b3c 100644 (file)
@@ -80,7 +80,7 @@ test(const unsigned numRefinementLevels = 2)
   GridGenerator::hyper_cube(triangulation, -L, L, /*colorize*/ false);
 
   // mark faces
-  for (auto cell : triangulation.active_cell_iterators())
+  for (auto &cell : triangulation.active_cell_iterators())
     for (unsigned int f = 0; f < GeometryInfo<dim>::faces_per_cell; ++f)
       {
         const Point<dim> &face_center = cell->face(f)->center();
@@ -122,7 +122,7 @@ test(const unsigned numRefinementLevels = 2)
   for (unsigned int ilevel = 0; ilevel < numRefinementLevels; ilevel++)
     {
       // pick an corner cell and refine
-      for (auto cell : triangulation.active_cell_iterators())
+      for (auto &cell : triangulation.active_cell_iterators())
         {
           try
             {
index 6b4b72fb4be078aac83414b83b79a0378fccb9e1..e38c8c37e0945818f03f602d2504af22846893a8 100644 (file)
@@ -53,7 +53,7 @@ test(const unsigned numRefinementLevels = 2)
   GridGenerator::hyper_cube(triangulation, -L, L, /*colorize*/ false);
 
   // mark faces
-  for (auto cell : triangulation.active_cell_iterators())
+  for (auto &cell : triangulation.active_cell_iterators())
     for (unsigned int f = 0; f < GeometryInfo<dim>::faces_per_cell; ++f)
       {
         const Point<dim> &face_center = cell->face(f)->center();
@@ -95,7 +95,7 @@ test(const unsigned numRefinementLevels = 2)
   for (unsigned int ilevel = 0; ilevel < numRefinementLevels; ilevel++)
     {
       // pick an corner cell and refine
-      for (auto cell : triangulation.active_cell_iterators())
+      for (auto &cell : triangulation.active_cell_iterators())
         {
           try
             {
index fbbc6261062d1c482db4dac4c364dcc15f293cda..85254190537d0a6c615d49dbd1841fde5973199c 100644 (file)
@@ -542,7 +542,7 @@ namespace Step37
           }
         else
           {
-            for (auto cell : triangulation.active_cell_iterators())
+            for (auto &cell : triangulation.active_cell_iterators())
               if (cell->is_locally_owned())
                 {
                   if ((cell->center()[0] < -8. && cell->center()[1] < 0) ||
index 3ed0f75f7cc376c264868e736f4f9d1e903a6e87..1cfee79575e261f57e80d4fb315437c996ebce74 100644 (file)
@@ -39,7 +39,7 @@ print_dof_numbers(const DoFHandler<dim> &dof)
 {
   std::vector<types::global_dof_index> dof_indices(dof.get_fe().dofs_per_cell);
   deallog << "DoF numbers on active cells" << std::endl;
-  for (auto cell : dof.active_cell_iterators())
+  for (auto &cell : dof.active_cell_iterators())
     if (!cell->is_artificial())
       {
         cell->get_dof_indices(dof_indices);
@@ -51,7 +51,7 @@ print_dof_numbers(const DoFHandler<dim> &dof)
   for (unsigned int l = 0; l < dof.get_triangulation().n_global_levels(); ++l)
     {
       deallog << "DoF numbers on level " << l << std::endl;
-      for (auto cell : dof.cell_iterators_on_level(l))
+      for (auto &cell : dof.cell_iterators_on_level(l))
         if (cell->level_subdomain_id() != numbers::artificial_subdomain_id)
           {
             cell->get_mg_dof_indices(dof_indices);
index 36fcd7d63dcf6eec4c195fa8bdd64e86b238d90e..3a89beacb3610684712091cc95577b81915e2509 100644 (file)
@@ -47,7 +47,7 @@ print_dof_numbers(const DoFHandler<dim> &dof)
 {
   std::vector<types::global_dof_index> dof_indices(dof.get_fe().dofs_per_cell);
   deallog << "DoF numbers on active cells" << std::endl;
-  for (auto cell : dof.active_cell_iterators())
+  for (auto &cell : dof.active_cell_iterators())
     if (!cell->is_artificial())
       {
         cell->get_dof_indices(dof_indices);
@@ -59,7 +59,7 @@ print_dof_numbers(const DoFHandler<dim> &dof)
   for (unsigned int l = 0; l < dof.get_triangulation().n_global_levels(); ++l)
     {
       deallog << "DoF numbers on level " << l << std::endl;
-      for (auto cell : dof.cell_iterators_on_level(l))
+      for (auto &cell : dof.cell_iterators_on_level(l))
         if (cell->level_subdomain_id() != numbers::artificial_subdomain_id)
           {
             cell->get_mg_dof_indices(dof_indices);
index 38f9a681cccce45bd93da153b02dd371868f2bde..43e86d1e45aa83248e062dbcff1c5dfcee9af888 100644 (file)
@@ -47,7 +47,7 @@ print_dof_numbers(const DoFHandler<dim> &dof)
 {
   std::vector<types::global_dof_index> dof_indices(dof.get_fe().dofs_per_cell);
   deallog << "DoF numbers on active cells" << std::endl;
-  for (auto cell : dof.active_cell_iterators())
+  for (auto &cell : dof.active_cell_iterators())
     if (!cell->is_artificial())
       {
         cell->get_dof_indices(dof_indices);
@@ -59,7 +59,7 @@ print_dof_numbers(const DoFHandler<dim> &dof)
   for (unsigned int l = 0; l < dof.get_triangulation().n_global_levels(); ++l)
     {
       deallog << "DoF numbers on level " << l << std::endl;
-      for (auto cell : dof.cell_iterators_on_level(l))
+      for (auto &cell : dof.cell_iterators_on_level(l))
         if (cell->level_subdomain_id() != numbers::artificial_subdomain_id)
           {
             cell->get_mg_dof_indices(dof_indices);
index 64d388beb44dcbeca3d5395b046516729d9052bd..0e94f8d0651089490bb3151aa0f64c20847c236a 100644 (file)
@@ -39,7 +39,7 @@ print_dof_numbers(const DoFHandler<dim> &dof)
 {
   std::vector<types::global_dof_index> dof_indices(dof.get_fe().dofs_per_cell);
   deallog << "DoF numbers on active cells" << std::endl;
-  for (auto cell : dof.active_cell_iterators())
+  for (auto &cell : dof.active_cell_iterators())
     if (!cell->is_artificial())
       {
         cell->get_dof_indices(dof_indices);
@@ -51,7 +51,7 @@ print_dof_numbers(const DoFHandler<dim> &dof)
   for (unsigned int l = 0; l < dof.get_triangulation().n_global_levels(); ++l)
     {
       deallog << "DoF numbers on level " << l << std::endl;
-      for (auto cell : dof.cell_iterators_on_level(l))
+      for (auto &cell : dof.cell_iterators_on_level(l))
         if (cell->level_subdomain_id() != numbers::artificial_subdomain_id)
           {
             cell->get_mg_dof_indices(dof_indices);
index 81d24620577c1be3064c4cea4fac1d3f7bceb925..a273bcd8ec1ea99918e3779d152f6f01b28cae9e 100644 (file)
@@ -117,7 +117,7 @@ test()
     FullMatrix<double>        cell_matrix(fe.dofs_per_cell, fe.dofs_per_cell);
     AffineConstraints<double> constraints;
 
-    for (auto cell : dh.active_cell_iterators())
+    for (auto &cell : dh.active_cell_iterators())
       if (cell->is_locally_owned())
         {
           cell_matrix = 0;
index c5c70fdc4f942235539cf316e4e58e1d4bc6de51..3b8f08f7d70684c38fa25cf5bcf911b0f243711c 100644 (file)
@@ -120,7 +120,7 @@ test()
     FullMatrix<double>        cell_matrix(fe.dofs_per_cell, fe.dofs_per_cell);
     AffineConstraints<double> constraints;
 
-    for (auto cell : dh.active_cell_iterators())
+    for (auto &cell : dh.active_cell_iterators())
       if (cell->is_locally_owned())
         {
           cell_matrix = 0;
index 82eba703ad10d4d1bed4b1d1fc5662bd21905830..a0ac5cb9583206355e7928023e355d6bac5e7a7f 100644 (file)
@@ -64,7 +64,7 @@ test()
   // set the active_fe_index on all locally active cells equal to the
   // subdomain_id. we can later verify this equality also on ghost
   // cells
-  for (auto cell : dof_handler.active_cell_iterators())
+  for (auto &cell : dof_handler.active_cell_iterators())
     if (cell->is_locally_owned())
       cell->set_active_fe_index(cell->subdomain_id());
 
@@ -75,7 +75,7 @@ test()
           << std::endl;
 
   // verify that the information has been communicated between processors
-  for (auto cell : dof_handler.active_cell_iterators())
+  for (auto &cell : dof_handler.active_cell_iterators())
     {
       if (cell->is_locally_owned())
         Assert(cell->active_fe_index() == cell->subdomain_id(),
index e53b02c4ab0a94d415a41de947ef23130c2da708..795eeee470742342b306cb548a30aaa81595835e 100644 (file)
@@ -66,7 +66,7 @@ test()
   // set the active_fe_index on all locally active cells equal to the
   // subdomain_id. we can later verify this equality also on ghost
   // cells
-  for (auto cell : dof_handler.active_cell_iterators())
+  for (auto &cell : dof_handler.active_cell_iterators())
     if (cell->is_locally_owned())
       cell->set_active_fe_index(cell->subdomain_id());
 
@@ -77,7 +77,7 @@ test()
           << std::endl;
 
   // verify that the information has been communicated between processors
-  for (auto cell : dof_handler.active_cell_iterators())
+  for (auto &cell : dof_handler.active_cell_iterators())
     {
       if (cell->is_locally_owned())
         Assert(cell->active_fe_index() == cell->subdomain_id(),
index 68a358c13962a968fdf91eac6826f4eec46a62d7..c13225b15af6623f44b4eacfd1d3360870d4e9b4 100644 (file)
@@ -66,7 +66,7 @@ test()
   // set the active_fe_index on all locally active cells equal to the
   // subdomain_id. we can later verify this equality also on ghost
   // cells
-  for (auto cell : dof_handler.active_cell_iterators())
+  for (auto &cell : dof_handler.active_cell_iterators())
     if (cell->is_locally_owned())
       cell->set_active_fe_index(cell->subdomain_id());
 
@@ -77,7 +77,7 @@ test()
           << std::endl;
 
   // verify that the information has been communicated between processors
-  for (auto cell : dof_handler.active_cell_iterators())
+  for (auto &cell : dof_handler.active_cell_iterators())
     {
       if (cell->is_locally_owned())
         Assert(cell->active_fe_index() == cell->subdomain_id(),
index 1a1c3e99ef09b8ec7a05580e3ecec44daa01f9c3..104f98720e0725226e813304104b97b4f0c299c8 100644 (file)
@@ -62,7 +62,7 @@ test()
   // set the active_fe_index on all locally active cells equal to the
   // subdomain_id. we can later verify this equality also on ghost
   // cells
-  for (auto cell : dof_handler.active_cell_iterators())
+  for (auto &cell : dof_handler.active_cell_iterators())
     if (cell->is_locally_owned())
       cell->set_active_fe_index(cell->subdomain_id());
 
@@ -73,7 +73,7 @@ test()
           << std::endl;
 
   // verify that the information has been communicated between processors
-  for (auto cell : dof_handler.active_cell_iterators())
+  for (auto &cell : dof_handler.active_cell_iterators())
     {
       if (cell->is_locally_owned())
         Assert(cell->active_fe_index() == cell->subdomain_id(),
index 199de460121bdac2e9c0d3a7974fbcb6f04b614a..0836a469f5476aa5c22224d9222d6f481b0373d9 100644 (file)
@@ -59,7 +59,7 @@ test()
     parallel::shared::Triangulation<dim>::partition_custom_signal);
   triangulation.signals.post_refinement.connect([&triangulation]() {
     // partition the triangulation by hand
-    for (auto cell : triangulation.active_cell_iterators())
+    for (auto &cell : triangulation.active_cell_iterators())
       cell->set_subdomain_id(cell->active_cell_index() %
                              Utilities::MPI::n_mpi_processes(MPI_COMM_WORLD));
   });
index df654638923b42e9128bebfecce4d3b27277e350..f91c2dc9ca47c6c21096b0a4c2ab593f838cf6dc 100644 (file)
@@ -55,7 +55,7 @@ test()
     parallel::shared::Triangulation<dim>::partition_custom_signal);
   triangulation.signals.post_refinement.connect([&triangulation]() {
     // partition the triangulation by hand
-    for (auto cell : triangulation.active_cell_iterators())
+    for (auto &cell : triangulation.active_cell_iterators())
       cell->set_subdomain_id(cell->active_cell_index() %
                              Utilities::MPI::n_mpi_processes(MPI_COMM_WORLD));
   });
index 09ae45f96015b6daa715b689f39bff0d76d25446..566ec3a7d6b05d763230b1e5d3d60fe79ab1a91f 100644 (file)
@@ -247,7 +247,7 @@ Test_Solver_Output::assemble_system()
 
   std::vector<types::global_dof_index> local_dof_indices(dofs_per_cell);
 
-  for (auto cell : dof_handler.active_cell_iterators())
+  for (auto &cell : dof_handler.active_cell_iterators())
     {
       if (cell->is_locally_owned())
         {
index 1602b5ca777ed085685816d2752256327213a557..7da0be3f97b98a5630909119556c6724ca0e24db 100644 (file)
@@ -96,7 +96,7 @@ test(VectorTools::NormType norm, double value, double exp = 2.0)
   hp::DoFHandler<dim> dofh(tria);
 
   // assign FEs mostly randomly to each cell
-  for (auto cell : dofh.active_cell_iterators())
+  for (auto &cell : dofh.active_cell_iterators())
     if (cell->is_locally_owned())
       cell->set_active_fe_index(cell->active_cell_index() % fe.size());
   dofh.distribute_dofs(fe);

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.