From 1c6d1fb147620e86a2e55d007050ebb41aed8d1a Mon Sep 17 00:00:00 2001 From: bangerth Date: Fri, 9 Mar 2012 17:20:18 +0000 Subject: [PATCH] Switch to types::boundary/material_id_t from 'unsigned char'. git-svn-id: https://svn.dealii.org/trunk@25225 0785d39b-7218-0410-832d-ea1e28bc413d --- tests/bits/anna_4.cc | 2 +- tests/bits/anna_6.cc | 4 +-- tests/bits/dof_tools_05.cc | 2 +- tests/bits/dof_tools_09.cc | 4 +-- tests/bits/dof_tools_14.cc | 2 +- tests/bits/dof_tools_16a.cc | 2 +- tests/bits/dof_tools_16b.cc | 2 +- tests/bits/dof_tools_16b_x.cc | 2 +- tests/bits/dof_tools_16c.cc | 2 +- tests/bits/dof_tools_16d.cc | 2 +- tests/bits/dof_tools_16d_x.cc | 2 +- tests/bits/dof_tools_20.cc | 2 +- tests/bits/error_estimator_01.cc | 2 +- tests/bits/error_estimator_02.cc | 2 +- tests/bits/get_boundary_indicators_1d.cc | 2 +- tests/bits/grid_generator_03.cc | 30 +++++++++---------- tests/codim_one/boundary_indicator_01.cc | 2 +- tests/codim_one/data_out_03.cc | 2 +- tests/codim_one/error_estimator_01.cc | 2 +- tests/codim_one/extract_boundary_mesh_00.cc | 2 +- tests/codim_one/extract_boundary_mesh_04.cc | 2 +- tests/codim_one/hanging_nodes_01.cc | 2 +- tests/codim_one/hanging_nodes_02.cc | 2 +- tests/codim_one/hanging_nodes_03.cc | 2 +- .../interpolate_boundary_values_03.cc | 2 +- tests/codim_one/transform_01.cc | 2 +- tests/deal.II/error_estimator.cc | 2 +- tests/deal.II/error_estimator_01.cc | 2 +- .../deal.II/interpolate_boundary_values_01.cc | 2 +- tests/deal.II/no_flux_01.cc | 2 +- tests/deal.II/no_flux_02.cc | 2 +- tests/deal.II/no_flux_03.cc | 2 +- tests/deal.II/no_flux_04.cc | 2 +- tests/deal.II/no_flux_05.cc | 2 +- tests/deal.II/no_flux_06.cc | 2 +- tests/deal.II/no_flux_07.cc | 2 +- tests/deal.II/no_flux_08.cc | 4 +-- tests/deal.II/no_flux_09.cc | 2 +- tests/deal.II/no_flux_hp_01.cc | 2 +- tests/deal.II/no_flux_hp_02.cc | 2 +- tests/deal.II/no_flux_hp_03.cc | 2 +- tests/deal.II/no_flux_hp_04.cc | 2 +- tests/deal.II/no_flux_hp_05.cc | 2 +- tests/deal.II/project_boundary_rt_01.cc | 2 +- tests/deal.II/vertex_as_face_08.cc | 2 +- tests/deal.II/vertex_as_face_10.cc | 2 +- tests/fe/abf_01.cc | 2 +- tests/hp/create_rhs_01.cc | 4 +-- tests/mpi/no_flux_constraints.cc | 2 +- tests/mpi/no_flux_constraints_02.cc | 2 +- tests/mpi/no_flux_constraints_03.cc | 2 +- tests/mpi/p4est_2d_constraintmatrix_03.cc | 2 +- 52 files changed, 70 insertions(+), 70 deletions(-) diff --git a/tests/bits/anna_4.cc b/tests/bits/anna_4.cc index 197221e4cc..139870cf42 100644 --- a/tests/bits/anna_4.cc +++ b/tests/bits/anna_4.cc @@ -187,7 +187,7 @@ void FindBug::dirichlet_conditions () std::vector fixed_dofs (dof_handler.n_dofs()); - std::set boundary_indicators; + std::set boundary_indicators; boundary_indicators.insert (0); // get a list of those boundary DoFs which diff --git a/tests/bits/anna_6.cc b/tests/bits/anna_6.cc index 6fe9e8cdcd..9c8dd245f9 100644 --- a/tests/bits/anna_6.cc +++ b/tests/bits/anna_6.cc @@ -183,7 +183,7 @@ void ImposeBC::test_extract_boundary_DoFs () bc_component_select[2] = false; std::vector ned_boundary_dofs (dof_handler.n_dofs()); - std::set boundary_indicators; + std::set boundary_indicators; boundary_indicators.insert (0); DoFTools::extract_boundary_dofs (dof_handler, bc_component_select, @@ -222,7 +222,7 @@ void ImposeBC::test_interpolate_BC () // (the pressure is assumed to be set to 1 // on the boundary) std::vector p_boundary_dofs (dof_handler.n_dofs()); - std::set boundary_indicators; + std::set boundary_indicators; boundary_indicators.insert (0); DoFTools::extract_boundary_dofs (dof_handler, bc_component_select, diff --git a/tests/bits/dof_tools_05.cc b/tests/bits/dof_tools_05.cc index 02d92ebb08..b2af03a483 100644 --- a/tests/bits/dof_tools_05.cc +++ b/tests/bits/dof_tools_05.cc @@ -51,7 +51,7 @@ check_this (const DoFHandler &dof_handler) // third further restrict to // boundary indicator 0 { - std::set boundary_ids; + std::set boundary_ids; boundary_ids.insert (0); DoFTools::extract_boundary_dofs (dof_handler, component_select, diff --git a/tests/bits/dof_tools_09.cc b/tests/bits/dof_tools_09.cc index 86d2e01edc..5037e61eab 100644 --- a/tests/bits/dof_tools_09.cc +++ b/tests/bits/dof_tools_09.cc @@ -16,7 +16,7 @@ // check // DoFTools::map_dof_to_boundary_indices(const DoFHandler &, -// const std::set &, +// const std::set &, // std::vector &) @@ -28,7 +28,7 @@ void check_this (const DoFHandler &dof_handler) { std::vector map(dof_handler.n_dofs()); - std::set boundary_ids; + std::set boundary_ids; // check for boundary id 0 alone boundary_ids.insert (0); diff --git a/tests/bits/dof_tools_14.cc b/tests/bits/dof_tools_14.cc index 7fb16a1fa6..135a084f5f 100644 --- a/tests/bits/dof_tools_14.cc +++ b/tests/bits/dof_tools_14.cc @@ -36,7 +36,7 @@ check_this (const DoFHandler &dof_handler) deallog << dof_handler.n_boundary_dofs(fm) << std::endl; // with std::set - std::set s; + std::set s; s.insert (0); deallog << dof_handler.n_boundary_dofs(s) << std::endl; diff --git a/tests/bits/dof_tools_16a.cc b/tests/bits/dof_tools_16a.cc index c22331ce8e..2173bb0c30 100644 --- a/tests/bits/dof_tools_16a.cc +++ b/tests/bits/dof_tools_16a.cc @@ -36,7 +36,7 @@ check_this (const DoFHandler &dof_handler) return; std::vector map (dof_handler.n_dofs()); - std::set set; + std::set set; set.insert (0); DoFTools::map_dof_to_boundary_indices (dof_handler, set, map); diff --git a/tests/bits/dof_tools_16b.cc b/tests/bits/dof_tools_16b.cc index 6c789b5d8a..805d3cd67b 100644 --- a/tests/bits/dof_tools_16b.cc +++ b/tests/bits/dof_tools_16b.cc @@ -35,7 +35,7 @@ check_this (const DoFHandler &dof_handler) return; std::vector map (dof_handler.n_dofs()); - std::set set; + std::set set; set.insert (0); DoFTools::map_dof_to_boundary_indices (dof_handler, set, map); diff --git a/tests/bits/dof_tools_16b_x.cc b/tests/bits/dof_tools_16b_x.cc index bbb253cfc1..97c1eb8860 100644 --- a/tests/bits/dof_tools_16b_x.cc +++ b/tests/bits/dof_tools_16b_x.cc @@ -35,7 +35,7 @@ check_this (const DoFHandler &dof_handler) return; std::vector map (dof_handler.n_dofs()); - std::set set; + std::set set; set.insert (0); DoFTools::map_dof_to_boundary_indices (dof_handler, set, map); diff --git a/tests/bits/dof_tools_16c.cc b/tests/bits/dof_tools_16c.cc index a7f8832455..d8476fe0cc 100644 --- a/tests/bits/dof_tools_16c.cc +++ b/tests/bits/dof_tools_16c.cc @@ -35,7 +35,7 @@ check_this (const DoFHandler &dof_handler) return; std::vector map (dof_handler.n_dofs()); - std::set set; + std::set set; set.insert (0); DoFTools::map_dof_to_boundary_indices (dof_handler, set, map); diff --git a/tests/bits/dof_tools_16d.cc b/tests/bits/dof_tools_16d.cc index 668261c4c4..035c54513d 100644 --- a/tests/bits/dof_tools_16d.cc +++ b/tests/bits/dof_tools_16d.cc @@ -35,7 +35,7 @@ check_this (const DoFHandler &dof_handler) return; std::vector map (dof_handler.n_dofs()); - std::set set; + std::set set; set.insert (0); DoFTools::map_dof_to_boundary_indices (dof_handler, set, map); diff --git a/tests/bits/dof_tools_16d_x.cc b/tests/bits/dof_tools_16d_x.cc index e9bb39a3d1..347f3db0d4 100644 --- a/tests/bits/dof_tools_16d_x.cc +++ b/tests/bits/dof_tools_16d_x.cc @@ -35,7 +35,7 @@ check_this (const DoFHandler &dof_handler) return; std::vector map (dof_handler.n_dofs()); - std::set set; + std::set set; set.insert (0); DoFTools::map_dof_to_boundary_indices (dof_handler, set, map); diff --git a/tests/bits/dof_tools_20.cc b/tests/bits/dof_tools_20.cc index ed57b46f9a..3e4e9501df 100644 --- a/tests/bits/dof_tools_20.cc +++ b/tests/bits/dof_tools_20.cc @@ -51,7 +51,7 @@ check_this (const DoFHandler &dof_handler) // third further restrict to // boundary indicator 0 { - std::set boundary_ids; + std::set boundary_ids; boundary_ids.insert (0); DoFTools::extract_dofs_with_support_on_boundary (dof_handler, component_select, diff --git a/tests/bits/error_estimator_01.cc b/tests/bits/error_estimator_01.cc index 6c388b49de..f337f47576 100644 --- a/tests/bits/error_estimator_01.cc +++ b/tests/bits/error_estimator_01.cc @@ -130,7 +130,7 @@ check () MappingQ mapping(3); Quadrature &q_face = get_q_face(function); - std::map*> neumann_bc; + std::map*> neumann_bc; neumann_bc[0] = &function; Vector v (dof.n_dofs()); diff --git a/tests/bits/error_estimator_02.cc b/tests/bits/error_estimator_02.cc index 087dc2ed3d..78557e6fdc 100644 --- a/tests/bits/error_estimator_02.cc +++ b/tests/bits/error_estimator_02.cc @@ -130,7 +130,7 @@ check () MappingQ mapping(3); Quadrature &q_face = get_q_face(function); - std::map*> neumann_bc; + std::map*> neumann_bc; neumann_bc[0] = &function; Vector v (dof.n_dofs()); diff --git a/tests/bits/get_boundary_indicators_1d.cc b/tests/bits/get_boundary_indicators_1d.cc index bb1bce715b..fd9359d72f 100644 --- a/tests/bits/get_boundary_indicators_1d.cc +++ b/tests/bits/get_boundary_indicators_1d.cc @@ -26,7 +26,7 @@ int main () Triangulation<1> triangulation; GridGenerator::hyper_cube (triangulation, -1, 1); - const std::vector indicators = triangulation.get_boundary_indicators(); + const std::vector indicators = triangulation.get_boundary_indicators(); for (unsigned int i=0; i -template Table material_ids(); +template Table material_ids(); -template <> Table<1,unsigned char> material_ids<1>() +template <> Table<1,types::material_id_t> material_ids<1>() { - Table<1,unsigned char> t(2); + Table<1,types::material_id_t> t(2); for (unsigned int i=0; i<2; ++i) t[i] = 1; return t; } -template <> Table<2,unsigned char> material_ids<2>() +template <> Table<2,types::material_id_t> material_ids<2>() { - Table<2,unsigned char> t(2,3); + Table<2,types::material_id_t> t(2,3); for (unsigned int i=0; i<2; ++i) for (unsigned int j=0; j<3; ++j) t[i][j] = 1; // produce a hole in the middle - t[1][1] = (unsigned char)(-1); + t[1][1] = (types::material_id_t)(-1); return t; } -template <> Table<3,unsigned char> material_ids<3>() +template <> Table<3,types::material_id_t> material_ids<3>() { - Table<3,unsigned char> t(2,3,4); + Table<3,types::material_id_t> t(2,3,4); for (unsigned int i=0; i<2; ++i) for (unsigned int j=0; j<3; ++j) for (unsigned int k=0; k<4; ++k) t[i][j][k] = 1; // produce a hole in the middle - t[1][1][1] = (unsigned char)(-1); - t[1][1][2] = (unsigned char)(-1); + t[1][1][1] = (types::material_id_t)(-1); + t[1][1][2] = (types::material_id_t)(-1); return t; } @@ -72,7 +72,7 @@ void test(std::ostream& out) p1[0] = 2.; if (dim>1) p1[1] = -1.; if (dim>2) p1[2] = 0.; - + Point p2; p2[0] = 3.; if (dim>1) p2[1] = 2.; @@ -82,7 +82,7 @@ void test(std::ostream& out) p3[0] = 2.; if (dim>1) p3[1] = 1.; if (dim>2) p3[2] = 4.; - + GridOut go; // uniformly subdivided mesh @@ -128,7 +128,7 @@ int main() deallog.attach(logfile); deallog.depth_console(0); deallog.threshold_double(1.e-10); - + deallog.push("1d"); test<1>(logfile); deallog.pop(); diff --git a/tests/codim_one/boundary_indicator_01.cc b/tests/codim_one/boundary_indicator_01.cc index 31b63da1a3..4eef579dcc 100644 --- a/tests/codim_one/boundary_indicator_01.cc +++ b/tests/codim_one/boundary_indicator_01.cc @@ -85,7 +85,7 @@ int main () // now extract a mesh of the 5 // surface faces - std::set boundary_indicators; + std::set boundary_indicators; boundary_indicators.insert (0); GridTools::extract_boundary_mesh (volume_mesh, boundary_mesh, boundary_indicators); diff --git a/tests/codim_one/data_out_03.cc b/tests/codim_one/data_out_03.cc index 7eae246161..dd412fc329 100644 --- a/tests/codim_one/data_out_03.cc +++ b/tests/codim_one/data_out_03.cc @@ -88,7 +88,7 @@ int main () tria.set_boundary (1, surface_description); tria.set_boundary (0, surface_description); - std::set boundary_ids; + std::set boundary_ids; boundary_ids.insert(0); GridTools::extract_boundary_mesh (volume_mesh, tria, diff --git a/tests/codim_one/error_estimator_01.cc b/tests/codim_one/error_estimator_01.cc index bf467ced0a..46088863d3 100644 --- a/tests/codim_one/error_estimator_01.cc +++ b/tests/codim_one/error_estimator_01.cc @@ -128,7 +128,7 @@ check () MappingQ mapping(3); Quadrature &q_face = get_q_face(); - std::map*> neumann_bc; + std::map*> neumann_bc; neumann_bc[0] = &function; Vector v (dof.n_dofs()); diff --git a/tests/codim_one/extract_boundary_mesh_00.cc b/tests/codim_one/extract_boundary_mesh_00.cc index 14a6fc1191..6ab6d7af3a 100644 --- a/tests/codim_one/extract_boundary_mesh_00.cc +++ b/tests/codim_one/extract_boundary_mesh_00.cc @@ -165,7 +165,7 @@ int main () save_mesh(volume_mesh); Triangulation boundary_mesh; - set boundary_ids; + set boundary_ids; boundary_ids.insert(0); surface_to_volume_mapping diff --git a/tests/codim_one/extract_boundary_mesh_04.cc b/tests/codim_one/extract_boundary_mesh_04.cc index 120b066438..bebed43111 100644 --- a/tests/codim_one/extract_boundary_mesh_04.cc +++ b/tests/codim_one/extract_boundary_mesh_04.cc @@ -117,7 +117,7 @@ int main () boundary_mesh.set_boundary (1, surface_description); boundary_mesh.set_boundary (0, surface_description); - set boundary_ids; + set boundary_ids; boundary_ids.insert(1); surface_to_volume_mapping diff --git a/tests/codim_one/hanging_nodes_01.cc b/tests/codim_one/hanging_nodes_01.cc index 22b1da80cc..4bc550b783 100644 --- a/tests/codim_one/hanging_nodes_01.cc +++ b/tests/codim_one/hanging_nodes_01.cc @@ -50,7 +50,7 @@ int main () cell = volume_mesh.begin_active(); cell->face(0)->set_all_boundary_indicators (1); - std::set boundary_ids; + std::set boundary_ids; boundary_ids.insert(0); GridTools::extract_boundary_mesh (volume_mesh, boundary_mesh, boundary_ids); } diff --git a/tests/codim_one/hanging_nodes_02.cc b/tests/codim_one/hanging_nodes_02.cc index bdfa748d5e..0c9dae13ec 100644 --- a/tests/codim_one/hanging_nodes_02.cc +++ b/tests/codim_one/hanging_nodes_02.cc @@ -50,7 +50,7 @@ int main () cell = volume_mesh.begin_active(); cell->face(0)->set_all_boundary_indicators (1); - std::set boundary_ids; + std::set boundary_ids; boundary_ids.insert(0); GridTools::extract_boundary_mesh (volume_mesh, boundary_mesh, boundary_ids); } diff --git a/tests/codim_one/hanging_nodes_03.cc b/tests/codim_one/hanging_nodes_03.cc index d403023768..12b76b3f30 100644 --- a/tests/codim_one/hanging_nodes_03.cc +++ b/tests/codim_one/hanging_nodes_03.cc @@ -44,7 +44,7 @@ int main () cell = volume_mesh.begin_active(); cell->face(0)->set_all_boundary_indicators (1); - std::set boundary_ids; + std::set boundary_ids; boundary_ids.insert(0); GridTools::extract_boundary_mesh (volume_mesh, boundary_mesh, boundary_ids); } diff --git a/tests/codim_one/interpolate_boundary_values_03.cc b/tests/codim_one/interpolate_boundary_values_03.cc index ba1da7a4a4..ee19bd19e6 100644 --- a/tests/codim_one/interpolate_boundary_values_03.cc +++ b/tests/codim_one/interpolate_boundary_values_03.cc @@ -38,7 +38,7 @@ void test() { Triangulation tria; Triangulation volume_mesh; GridGenerator::half_hyper_ball(volume_mesh); - std::set boundary_ids; + std::set boundary_ids; boundary_ids.insert(0); GridTools::extract_boundary_mesh (volume_mesh, tria,boundary_ids); diff --git a/tests/codim_one/transform_01.cc b/tests/codim_one/transform_01.cc index 55c92bcfe2..e7700d4f0e 100644 --- a/tests/codim_one/transform_01.cc +++ b/tests/codim_one/transform_01.cc @@ -68,7 +68,7 @@ int main () triangulation.set_boundary (1, surface_description); triangulation.set_boundary (0, surface_description); - std::set boundary_ids; + std::set boundary_ids; boundary_ids.insert(0); GridTools::extract_boundary_mesh (volume_mesh, triangulation, diff --git a/tests/deal.II/error_estimator.cc b/tests/deal.II/error_estimator.cc index 2fb900e357..d7f02026e2 100644 --- a/tests/deal.II/error_estimator.cc +++ b/tests/deal.II/error_estimator.cc @@ -95,7 +95,7 @@ check () MappingQ mapping(3); Quadrature &q_face = get_q_face(function); - std::map*> neumann_bc; + std::map*> neumann_bc; neumann_bc[0] = &function; Vector v (dof.n_dofs()); diff --git a/tests/deal.II/error_estimator_01.cc b/tests/deal.II/error_estimator_01.cc index d40790b8c2..7093694836 100644 --- a/tests/deal.II/error_estimator_01.cc +++ b/tests/deal.II/error_estimator_01.cc @@ -55,7 +55,7 @@ check () MappingQ mapping(3); QGauss q_face(4); - std::map*> neumann_bc; + std::map*> neumann_bc; neumann_bc[0] = &function; Vector v (dof.n_dofs()); diff --git a/tests/deal.II/interpolate_boundary_values_01.cc b/tests/deal.II/interpolate_boundary_values_01.cc index 1eeb1c4f0c..867707e98c 100644 --- a/tests/deal.II/interpolate_boundary_values_01.cc +++ b/tests/deal.II/interpolate_boundary_values_01.cc @@ -148,7 +148,7 @@ void FindBug::dirichlet_conditions () std::vector fixed_dofs (dof_handler.n_dofs()); - std::set boundary_indicators; + std::set boundary_indicators; boundary_indicators.insert (0); // get a list of those boundary DoFs which diff --git a/tests/deal.II/no_flux_01.cc b/tests/deal.II/no_flux_01.cc index dcefd0c953..983403a363 100644 --- a/tests/deal.II/no_flux_01.cc +++ b/tests/deal.II/no_flux_01.cc @@ -45,7 +45,7 @@ void test (const Triangulation& tr, << ", case=" << i << std::endl; - std::set boundary_ids; + std::set boundary_ids; for (unsigned int j=0; j<=i; ++j) boundary_ids.insert (j); diff --git a/tests/deal.II/no_flux_02.cc b/tests/deal.II/no_flux_02.cc index bbbeebe922..522a3ec686 100644 --- a/tests/deal.II/no_flux_02.cc +++ b/tests/deal.II/no_flux_02.cc @@ -47,7 +47,7 @@ void test (const Triangulation& tr, << ", case=" << i << std::endl; - std::set boundary_ids; + std::set boundary_ids; for (unsigned int j=0; j<=i; ++j) boundary_ids.insert (j); diff --git a/tests/deal.II/no_flux_03.cc b/tests/deal.II/no_flux_03.cc index 339c63c71a..c4eae8e806 100644 --- a/tests/deal.II/no_flux_03.cc +++ b/tests/deal.II/no_flux_03.cc @@ -45,7 +45,7 @@ void test (const Triangulation& tr, deallog << "FE=" << fe.get_name() << std::endl; - std::set boundary_ids; + std::set boundary_ids; boundary_ids.insert (0); ConstraintMatrix cm; diff --git a/tests/deal.II/no_flux_04.cc b/tests/deal.II/no_flux_04.cc index 8c96ad92e2..a5614e7a9e 100644 --- a/tests/deal.II/no_flux_04.cc +++ b/tests/deal.II/no_flux_04.cc @@ -78,7 +78,7 @@ void test (const Triangulation& tr, deallog << "FE=" << fe.get_name() << std::endl; - std::set boundary_ids; + std::set boundary_ids; boundary_ids.insert (0); ConstraintMatrix cm; diff --git a/tests/deal.II/no_flux_05.cc b/tests/deal.II/no_flux_05.cc index 9219b592c6..64a3e76843 100644 --- a/tests/deal.II/no_flux_05.cc +++ b/tests/deal.II/no_flux_05.cc @@ -57,7 +57,7 @@ void test (const Triangulation& tr, << ", case=" << i << std::endl; - std::set boundary_ids; + std::set boundary_ids; for (unsigned int j=0; j<=i; ++j) boundary_ids.insert (j); diff --git a/tests/deal.II/no_flux_06.cc b/tests/deal.II/no_flux_06.cc index 4938085803..7db9d72ea9 100644 --- a/tests/deal.II/no_flux_06.cc +++ b/tests/deal.II/no_flux_06.cc @@ -48,7 +48,7 @@ void test_hyper_cube() deallog << "FE=" << fe.get_name() << std::endl; - std::set boundary_ids; + std::set boundary_ids; boundary_ids.insert (1); boundary_ids.insert (3); diff --git a/tests/deal.II/no_flux_07.cc b/tests/deal.II/no_flux_07.cc index 9c9263ffb6..0ab0b20273 100644 --- a/tests/deal.II/no_flux_07.cc +++ b/tests/deal.II/no_flux_07.cc @@ -47,7 +47,7 @@ void test (const Triangulation& tr, DoFHandler dof(tr); dof.distribute_dofs(fe); - std::set boundary_ids; + std::set boundary_ids; boundary_ids.insert (0); ConstraintMatrix cm; diff --git a/tests/deal.II/no_flux_08.cc b/tests/deal.II/no_flux_08.cc index 21cdd93ac6..1ef5f7d56d 100644 --- a/tests/deal.II/no_flux_08.cc +++ b/tests/deal.II/no_flux_08.cc @@ -15,7 +15,7 @@ // we used to get this crash: // // An error occurred in line <4646> of file in function -// static void dealii::VectorTools::compute_no_normal_flux_constraints(const DH&, unsigned int, const std::set&, dealii::ConstraintMatrix&, const dealii::Mapping&) [with int dim = 3, DH = dealii::DoFHandler, int spacedim = 3] +// static void dealii::VectorTools::compute_no_normal_flux_constraints(const DH&, unsigned int, const std::set&, dealii::ConstraintMatrix&, const dealii::Mapping&) [with int dim = 3, DH = dealii::DoFHandler, int spacedim = 3] // The violated condition was: // std::fabs (tangent.norm()-1) < 1e-12 // The name and call sequence of the exception was: @@ -55,7 +55,7 @@ check () dofh.distribute_dofs (fe); - std::set no_normal_flux_boundaries; + std::set no_normal_flux_boundaries; no_normal_flux_boundaries.insert (0); VectorTools::compute_no_normal_flux_constraints (dofh, 0, no_normal_flux_boundaries, cm, mapping); diff --git a/tests/deal.II/no_flux_09.cc b/tests/deal.II/no_flux_09.cc index e803d1879e..9457cf3f43 100644 --- a/tests/deal.II/no_flux_09.cc +++ b/tests/deal.II/no_flux_09.cc @@ -53,7 +53,7 @@ check () dofh.distribute_dofs (fe); - std::set no_normal_flux_boundaries; + std::set no_normal_flux_boundaries; no_normal_flux_boundaries.insert (1); // no_normal_flux_boundaries.insert (2); // not required for the crash for now, please test with it later! no_normal_flux_boundaries.insert (3); diff --git a/tests/deal.II/no_flux_hp_01.cc b/tests/deal.II/no_flux_hp_01.cc index e820967ca0..b0da9dccdb 100644 --- a/tests/deal.II/no_flux_hp_01.cc +++ b/tests/deal.II/no_flux_hp_01.cc @@ -32,7 +32,7 @@ void test (const Triangulation& tr, << ", case=" << i << std::endl; - std::set boundary_ids; + std::set boundary_ids; for (unsigned int j=0; j<=i; ++j) boundary_ids.insert (j); diff --git a/tests/deal.II/no_flux_hp_02.cc b/tests/deal.II/no_flux_hp_02.cc index 9ce7fb16a9..7fa21f12f5 100644 --- a/tests/deal.II/no_flux_hp_02.cc +++ b/tests/deal.II/no_flux_hp_02.cc @@ -35,7 +35,7 @@ void test (const Triangulation& tr, << ", case=" << i << std::endl; - std::set boundary_ids; + std::set boundary_ids; for (unsigned int j=0; j<=i; ++j) boundary_ids.insert (j); diff --git a/tests/deal.II/no_flux_hp_03.cc b/tests/deal.II/no_flux_hp_03.cc index c55f89bb9c..21ab7b7200 100644 --- a/tests/deal.II/no_flux_hp_03.cc +++ b/tests/deal.II/no_flux_hp_03.cc @@ -32,7 +32,7 @@ void test (const Triangulation& tr, deallog << "FE=" << fe[0].get_name() << std::endl; - std::set boundary_ids; + std::set boundary_ids; boundary_ids.insert (0); ConstraintMatrix cm; diff --git a/tests/deal.II/no_flux_hp_04.cc b/tests/deal.II/no_flux_hp_04.cc index 3867bbd02f..e5d14eedef 100644 --- a/tests/deal.II/no_flux_hp_04.cc +++ b/tests/deal.II/no_flux_hp_04.cc @@ -65,7 +65,7 @@ void test (const Triangulation& tr, deallog << "FE=" << fe[0].get_name() << std::endl; - std::set boundary_ids; + std::set boundary_ids; boundary_ids.insert (0); ConstraintMatrix cm; diff --git a/tests/deal.II/no_flux_hp_05.cc b/tests/deal.II/no_flux_hp_05.cc index 30dd31960e..256bb11b31 100644 --- a/tests/deal.II/no_flux_hp_05.cc +++ b/tests/deal.II/no_flux_hp_05.cc @@ -45,7 +45,7 @@ void test (const Triangulation& tr, << ", case=" << i << std::endl; - std::set boundary_ids; + std::set boundary_ids; for (unsigned int j=0; j<=i; ++j) boundary_ids.insert (j); diff --git a/tests/deal.II/project_boundary_rt_01.cc b/tests/deal.II/project_boundary_rt_01.cc index c3f94cf900..aab7171e0b 100644 --- a/tests/deal.II/project_boundary_rt_01.cc +++ b/tests/deal.II/project_boundary_rt_01.cc @@ -134,7 +134,7 @@ void test_projection (const Triangulation& tr, TestFunction f(degree-1); std::map boundary_constraints; typename FunctionMap::type boundary_map; - for (unsigned char i=0;i<255;++i) + for (types::boundary_id_t i=0;i<255;++i) boundary_map[i] = &f; VectorTools::project_boundary_values(mapping, dof, boundary_map, quadrature, boundary_constraints); diff --git a/tests/deal.II/vertex_as_face_08.cc b/tests/deal.II/vertex_as_face_08.cc index 5396375b5e..eba87370b8 100644 --- a/tests/deal.II/vertex_as_face_08.cc +++ b/tests/deal.II/vertex_as_face_08.cc @@ -31,7 +31,7 @@ void test () GridGenerator::hyper_cube (tria); tria.refine_global (2); - std::vector + std::vector boundary_ids = tria.get_boundary_indicators (); for (unsigned int i=0; iface(0)->set_boundary_indicator(2); tria.begin_active()->face(1)->set_boundary_indicator(4); - std::vector + std::vector boundary_ids = tria.get_boundary_indicators (); for (unsigned int i=0; i &mapping, // @p{function} to hold on all parts of the // boundary typename FunctionMap::type boundary_functions; - for (unsigned char c=0; c<255; ++c) + for (types::boundary_id_t c=0; c<255; ++c) boundary_functions[c] = &function; project_boundary_values (dof, boundary_functions, q_boundary, boundary_values); diff --git a/tests/hp/create_rhs_01.cc b/tests/hp/create_rhs_01.cc index aed9a30cdc..6c989b2bb5 100644 --- a/tests/hp/create_rhs_01.cc +++ b/tests/hp/create_rhs_01.cc @@ -72,8 +72,8 @@ void test () Vector rhs_vector(hp_dof_handler.n_dofs()); Vector rhs_vector2(hp_dof_handler2.n_dofs()); - unsigned char myints[1]; - std::set boundary_indicators (myints,myints+1); + types::boundary_id_t myints[1]; + std::set boundary_indicators (myints,myints+1); myints[0]=0; hp::QCollection<1> quadrature; quadrature.push_back (QGauss<1>(1)); diff --git a/tests/mpi/no_flux_constraints.cc b/tests/mpi/no_flux_constraints.cc index 06038b07e7..b6fc2f6772 100644 --- a/tests/mpi/no_flux_constraints.cc +++ b/tests/mpi/no_flux_constraints.cc @@ -106,7 +106,7 @@ void test() ConstraintMatrix constraints; constraints.reinit(relevant_set); DoFTools::make_hanging_node_constraints (dofh, constraints); - std::set no_normal_flux_boundaries; + std::set no_normal_flux_boundaries; no_normal_flux_boundaries.insert (1); const unsigned int degree = 1; VectorTools::compute_no_normal_flux_constraints (dofh, 0, diff --git a/tests/mpi/no_flux_constraints_02.cc b/tests/mpi/no_flux_constraints_02.cc index 1feed297c7..95b2130eb2 100644 --- a/tests/mpi/no_flux_constraints_02.cc +++ b/tests/mpi/no_flux_constraints_02.cc @@ -111,7 +111,7 @@ void test() ConstraintMatrix constraints; constraints.reinit(relevant_set); DoFTools::make_hanging_node_constraints (dofh, constraints); - std::set no_normal_flux_boundaries; + std::set no_normal_flux_boundaries; no_normal_flux_boundaries.insert (1); const unsigned int degree = 1; /* VectorTools::compute_no_normal_flux_constraints (dofh, 0, diff --git a/tests/mpi/no_flux_constraints_03.cc b/tests/mpi/no_flux_constraints_03.cc index 36fd5acc39..e00d4bcfce 100644 --- a/tests/mpi/no_flux_constraints_03.cc +++ b/tests/mpi/no_flux_constraints_03.cc @@ -82,7 +82,7 @@ void test() ConstraintMatrix constraints; constraints.reinit(relevant_set); DoFTools::make_hanging_node_constraints (dofh, constraints); - std::set no_normal_flux_boundaries; + std::set no_normal_flux_boundaries; no_normal_flux_boundaries.insert (0); const unsigned int degree = 1; VectorTools::compute_no_normal_flux_constraints (dofh, 0, diff --git a/tests/mpi/p4est_2d_constraintmatrix_03.cc b/tests/mpi/p4est_2d_constraintmatrix_03.cc index c4cbc6e2a5..450fd20dd3 100644 --- a/tests/mpi/p4est_2d_constraintmatrix_03.cc +++ b/tests/mpi/p4est_2d_constraintmatrix_03.cc @@ -162,7 +162,7 @@ void test() cm, velocity_mask); - std::set no_normal_flux_boundaries; + std::set no_normal_flux_boundaries; no_normal_flux_boundaries.insert (1); -- 2.39.5