From ff44ab340cabf7ca3d5b0df42505f586c3d70c88 Mon Sep 17 00:00:00 2001
From: Luca Heltai <luca.heltai@sissa.it>
Date: Sat, 14 Apr 2018 14:56:21 +0000
Subject: [PATCH] Replace set_manifold by reset_manifold

---
 examples/step-1/step-1.cc                 | 2 +-
 examples/step-49/step-49.cc               | 2 +-
 tests/codim_one/bem.cc                    | 2 +-
 tests/codim_one/data_out_03.cc            | 2 +-
 tests/codim_one/mapping_fe_field_01.cc    | 2 +-
 tests/codim_one/transform_01.cc           | 2 +-
 tests/grid/grid_output_input.cc           | 4 ++--
 tests/grid/grid_test.cc                   | 2 +-
 tests/manifold/manifold_id_07.cc          | 2 +-
 tests/mappings/mapping_real_to_unit_02.cc | 2 +-
 tests/mpi/fe_field_function_02.cc         | 2 +-
 tests/mpi/p4est_2d_constraintmatrix_03.cc | 4 ++--
 tests/mpi/p4est_2d_constraintmatrix_04.cc | 4 ++--
 tests/mpi/p4est_3d_constraintmatrix_03.cc | 4 ++--
 14 files changed, 18 insertions(+), 18 deletions(-)

diff --git a/examples/step-1/step-1.cc b/examples/step-1/step-1.cc
index 249a07e393..6ec5b28097 100644
--- a/examples/step-1/step-1.cc
+++ b/examples/step-1/step-1.cc
@@ -257,7 +257,7 @@ void second_grid ()
   // follows. Note that this sets the manifold object used for part "0" of the
   // domain back to a default object, over which the triangulation has full
   // control.
-  triangulation.set_manifold (0);
+  triangulation.reset_manifold(0);
   // An alternative to doing so, and one that is frequently more convenient,
   // would have been to declare the manifold object before the triangulation
   // object. In that case, the triangulation would have let lose of the
diff --git a/examples/step-49/step-49.cc b/examples/step-49/step-49.cc
index 35f41ab85d..3aecc7bb00 100644
--- a/examples/step-49/step-49.cc
+++ b/examples/step-49/step-49.cc
@@ -204,7 +204,7 @@ void grid_3 ()
   // object is destroyed first in this function since it was declared after
   // the triangulation).
   print_mesh_info (triangulation, "grid-3.eps");
-  triangulation.set_manifold (1);
+  triangulation.reset_manifold(1);
 }
 
 // There is one snag to doing things as shown above: If one moves the nodes on
diff --git a/tests/codim_one/bem.cc b/tests/codim_one/bem.cc
index 6616030fb4..f3d95e137d 100644
--- a/tests/codim_one/bem.cc
+++ b/tests/codim_one/bem.cc
@@ -145,7 +145,7 @@ BEM<spacedim>::run()
           solve();
           output_results();
 
-          tria.set_manifold(1);
+          tria.reset_manifold(1);
 
           for (unsigned int i=0; i<dof_handler_q.n_dofs(); ++i)
             global_error +=
diff --git a/tests/codim_one/data_out_03.cc b/tests/codim_one/data_out_03.cc
index 8147a8fe3f..f773652920 100644
--- a/tests/codim_one/data_out_03.cc
+++ b/tests/codim_one/data_out_03.cc
@@ -122,7 +122,7 @@ int main ()
 
 
   dh_test.clear();
-  tria.set_manifold(0);
+  tria.reset_manifold(0);
 
   return 0;
 }
diff --git a/tests/codim_one/mapping_fe_field_01.cc b/tests/codim_one/mapping_fe_field_01.cc
index 703b1d2221..0cd534c431 100644
--- a/tests/codim_one/mapping_fe_field_01.cc
+++ b/tests/codim_one/mapping_fe_field_01.cc
@@ -115,7 +115,7 @@ void test(const unsigned int refs,
   data_out_euler.write_vtk(deallog.get_file_stream());
 
 
-  triangulation.set_manifold(0);
+  triangulation.reset_manifold(0);
 }
 
 int main ()
diff --git a/tests/codim_one/transform_01.cc b/tests/codim_one/transform_01.cc
index 95c794edf7..2cbdcfe15f 100644
--- a/tests/codim_one/transform_01.cc
+++ b/tests/codim_one/transform_01.cc
@@ -72,7 +72,7 @@ int main ()
 
   GridGenerator::extract_boundary_mesh (volume_mesh, triangulation,
                                         boundary_ids);
-  triangulation.set_manifold (0);
+  triangulation.reset_manifold(0);
   GridTools::transform (&warp<3>, triangulation);
 
   deallog << "Surface mesh has " << triangulation.n_active_cells()
diff --git a/tests/grid/grid_output_input.cc b/tests/grid/grid_output_input.cc
index 45602abe15..d1aad878aa 100644
--- a/tests/grid/grid_output_input.cc
+++ b/tests/grid/grid_output_input.cc
@@ -47,7 +47,7 @@ void test(std::ostream &out)
   deallog << "Writing refined from constructor" << std::endl;
   go.write_ucd(tr, out);
 
-  tr.set_manifold(1);
+  tr.reset_manifold(1);
   tr.clear();
 
   GridIn<dim> gi;
@@ -70,7 +70,7 @@ void test(std::ostream &out)
     grid_file.close();
   }
 
-  tr.set_manifold(1);
+  tr.reset_manifold(1);
   tr.clear();
 }
 
diff --git a/tests/grid/grid_test.cc b/tests/grid/grid_test.cc
index ee86071797..19f76c9d64 100644
--- a/tests/grid/grid_test.cc
+++ b/tests/grid/grid_test.cc
@@ -239,7 +239,7 @@ void test (const int test_case)
           tria.execute_coarsening_and_refinement();
         };
 
-      tria.set_manifold (1);
+      tria.reset_manifold(1);
       break;
     }
     }
diff --git a/tests/manifold/manifold_id_07.cc b/tests/manifold/manifold_id_07.cc
index fe016ff57a..7d71bf56f8 100644
--- a/tests/manifold/manifold_id_07.cc
+++ b/tests/manifold/manifold_id_07.cc
@@ -57,7 +57,7 @@ void test(unsigned int ref=1)
 
   GridOut gridout;
   gridout.write_msh(tria, deallog.get_file_stream());
-  tria.set_manifold(1);
+  tria.reset_manifold(1);
 }
 
 int main ()
diff --git a/tests/mappings/mapping_real_to_unit_02.cc b/tests/mappings/mapping_real_to_unit_02.cc
index 4faea407d4..cac6947275 100644
--- a/tests/mappings/mapping_real_to_unit_02.cc
+++ b/tests/mappings/mapping_real_to_unit_02.cc
@@ -69,7 +69,7 @@ void test2()
   points[95]=p;
   fe_function.value_list (points, m); // <<<< this fails at point[95] but only if the other points are filled in?!
 
-  triangulation.set_manifold (0);
+  triangulation.reset_manifold(0);
 
   deallog << "OK" << std::endl;
 }
diff --git a/tests/mpi/fe_field_function_02.cc b/tests/mpi/fe_field_function_02.cc
index 350c5f9e55..bd6213917d 100644
--- a/tests/mpi/fe_field_function_02.cc
+++ b/tests/mpi/fe_field_function_02.cc
@@ -155,7 +155,7 @@ void test()
   if (Utilities::MPI::this_mpi_process (MPI_COMM_WORLD) == 0)
     deallog << "OK" << std::endl;
 
-  tr.set_manifold(99);
+  tr.reset_manifold(99);
 }
 
 
diff --git a/tests/mpi/p4est_2d_constraintmatrix_03.cc b/tests/mpi/p4est_2d_constraintmatrix_03.cc
index 063c26f9ad..697e929481 100644
--- a/tests/mpi/p4est_2d_constraintmatrix_03.cc
+++ b/tests/mpi/p4est_2d_constraintmatrix_03.cc
@@ -135,8 +135,8 @@ void test()
   if (myid==0)
     x_dub.print(deallog.get_file_stream(), 8, true, false);
 
-  tr.set_manifold (0);
-  tr.set_manifold (1);
+  tr.reset_manifold(0);
+  tr.reset_manifold(1);
 }
 
 
diff --git a/tests/mpi/p4est_2d_constraintmatrix_04.cc b/tests/mpi/p4est_2d_constraintmatrix_04.cc
index 212b829e12..c5f3838fdb 100644
--- a/tests/mpi/p4est_2d_constraintmatrix_04.cc
+++ b/tests/mpi/p4est_2d_constraintmatrix_04.cc
@@ -307,8 +307,8 @@ void test()
   std::ofstream output (filename.c_str());
   data_out.write_deal_II_intermediate (output);
 
-  tr.set_manifold (0);
-  tr.set_manifold (1);
+  tr.reset_manifold(0);
+  tr.reset_manifold(1);
   if (Utilities::MPI::this_mpi_process (MPI_COMM_WORLD) == 0)
     deallog << "OK" << std::endl;
 }
diff --git a/tests/mpi/p4est_3d_constraintmatrix_03.cc b/tests/mpi/p4est_3d_constraintmatrix_03.cc
index bcda49ea8c..ccb4c8a3f6 100644
--- a/tests/mpi/p4est_3d_constraintmatrix_03.cc
+++ b/tests/mpi/p4est_3d_constraintmatrix_03.cc
@@ -302,8 +302,8 @@ void test()
   std::ofstream output (filename.c_str());
   data_out.write_vtu (output);
 
-  tr.set_manifold (0);
-  tr.set_manifold (1);
+  tr.reset_manifold(0);
+  tr.reset_manifold(1);
 
   if (Utilities::MPI::this_mpi_process (MPI_COMM_WORLD) == 0)
     deallog << "OK" << std::endl;
-- 
2.39.5