]> https://gitweb.dealii.org/ - dealii-svn.git/commitdiff
Switch to types::boundary/material_id_t from 'unsigned char'.
authorbangerth <bangerth@0785d39b-7218-0410-832d-ea1e28bc413d>
Fri, 9 Mar 2012 17:20:18 +0000 (17:20 +0000)
committerbangerth <bangerth@0785d39b-7218-0410-832d-ea1e28bc413d>
Fri, 9 Mar 2012 17:20:18 +0000 (17:20 +0000)
git-svn-id: https://svn.dealii.org/trunk@25225 0785d39b-7218-0410-832d-ea1e28bc413d

52 files changed:
tests/bits/anna_4.cc
tests/bits/anna_6.cc
tests/bits/dof_tools_05.cc
tests/bits/dof_tools_09.cc
tests/bits/dof_tools_14.cc
tests/bits/dof_tools_16a.cc
tests/bits/dof_tools_16b.cc
tests/bits/dof_tools_16b_x.cc
tests/bits/dof_tools_16c.cc
tests/bits/dof_tools_16d.cc
tests/bits/dof_tools_16d_x.cc
tests/bits/dof_tools_20.cc
tests/bits/error_estimator_01.cc
tests/bits/error_estimator_02.cc
tests/bits/get_boundary_indicators_1d.cc
tests/bits/grid_generator_03.cc
tests/codim_one/boundary_indicator_01.cc
tests/codim_one/data_out_03.cc
tests/codim_one/error_estimator_01.cc
tests/codim_one/extract_boundary_mesh_00.cc
tests/codim_one/extract_boundary_mesh_04.cc
tests/codim_one/hanging_nodes_01.cc
tests/codim_one/hanging_nodes_02.cc
tests/codim_one/hanging_nodes_03.cc
tests/codim_one/interpolate_boundary_values_03.cc
tests/codim_one/transform_01.cc
tests/deal.II/error_estimator.cc
tests/deal.II/error_estimator_01.cc
tests/deal.II/interpolate_boundary_values_01.cc
tests/deal.II/no_flux_01.cc
tests/deal.II/no_flux_02.cc
tests/deal.II/no_flux_03.cc
tests/deal.II/no_flux_04.cc
tests/deal.II/no_flux_05.cc
tests/deal.II/no_flux_06.cc
tests/deal.II/no_flux_07.cc
tests/deal.II/no_flux_08.cc
tests/deal.II/no_flux_09.cc
tests/deal.II/no_flux_hp_01.cc
tests/deal.II/no_flux_hp_02.cc
tests/deal.II/no_flux_hp_03.cc
tests/deal.II/no_flux_hp_04.cc
tests/deal.II/no_flux_hp_05.cc
tests/deal.II/project_boundary_rt_01.cc
tests/deal.II/vertex_as_face_08.cc
tests/deal.II/vertex_as_face_10.cc
tests/fe/abf_01.cc
tests/hp/create_rhs_01.cc
tests/mpi/no_flux_constraints.cc
tests/mpi/no_flux_constraints_02.cc
tests/mpi/no_flux_constraints_03.cc
tests/mpi/p4est_2d_constraintmatrix_03.cc

index 197221e4cc8215364ccefdccf35f40b14b3d63e5..139870cf42e4e3d6a63dc65aeeaa48e51f19f05a 100644 (file)
@@ -187,7 +187,7 @@ void FindBug<dim>::dirichlet_conditions ()
 
 
   std::vector<bool> fixed_dofs (dof_handler.n_dofs());
-  std::set<unsigned char> boundary_indicators;
+  std::set<types::boundary_id_t> boundary_indicators;
   boundary_indicators.insert (0);
 
                                    // get a list of those boundary DoFs which
index 6fe9e8cdcdcc49680d88a06b44fdabde38592943..9c8dd245f9102dad129983993ffa6370ae73adb4 100644 (file)
@@ -183,7 +183,7 @@ void ImposeBC<dim>::test_extract_boundary_DoFs ()
   bc_component_select[2] = false;
                        
   std::vector<bool> ned_boundary_dofs (dof_handler.n_dofs());
-  std::set<unsigned char> boundary_indicators;
+  std::set<types::boundary_id_t> boundary_indicators;
   boundary_indicators.insert (0);
   DoFTools::extract_boundary_dofs (dof_handler, 
                                    bc_component_select,
@@ -222,7 +222,7 @@ void ImposeBC<dim>::test_interpolate_BC ()
                                    // (the pressure is assumed to be set to 1
                                    // on the boundary)                                  
   std::vector<bool> p_boundary_dofs (dof_handler.n_dofs());
-  std::set<unsigned char> boundary_indicators;
+  std::set<types::boundary_id_t> boundary_indicators;
   boundary_indicators.insert (0);
   DoFTools::extract_boundary_dofs (dof_handler, 
                                    bc_component_select,
index 02d92ebb0864fffead96e0da0560193302ca0449..b2af03a4836c199efd4e7e5ce1f4579a63cbb083 100644 (file)
@@ -51,7 +51,7 @@ check_this (const DoFHandler<dim> &dof_handler)
                                    // third further restrict to
                                    // boundary indicator 0
   {
-    std::set<unsigned char> boundary_ids;
+    std::set<types::boundary_id_t> boundary_ids;
     boundary_ids.insert (0);
     DoFTools::extract_boundary_dofs (dof_handler,
                                      component_select,
index 86d2e01edc8348c43b09ee4c85ecb39c7aec5217..5037e61eab3f45891f37b2fb59bb05daa1d11381 100644 (file)
@@ -16,7 +16,7 @@
 
 // check
 //   DoFTools::map_dof_to_boundary_indices(const DoFHandler<int>     &,
-//                                         const std::set<unsigned char> &,
+//                                         const std::set<types::boundary_id_t> &,
 //                                         std::vector<unsigned int> &)
 
 
@@ -28,7 +28,7 @@ void
 check_this (const DoFHandler<dim> &dof_handler)
 {
   std::vector<unsigned int> map(dof_handler.n_dofs());
-  std::set<unsigned char> boundary_ids;
+  std::set<types::boundary_id_t> boundary_ids;
 
                                    // check for boundary id 0 alone
   boundary_ids.insert (0);
index 7fb16a1fa60a4b52104ce9fbc78e03d610913755..135a084f5f357a40e516a527b49a742cde6e897b 100644 (file)
@@ -36,7 +36,7 @@ check_this (const DoFHandler<dim> &dof_handler)
   deallog << dof_handler.n_boundary_dofs(fm) << std::endl;
   
                                    // with std::set
-  std::set<unsigned char> s;
+  std::set<types::boundary_id_t> s;
   s.insert (0);
   deallog << dof_handler.n_boundary_dofs(s) << std::endl;
   
index c22331ce8e0eabf63f55a9d899b066b9c51196c9..2173bb0c30c592da597aa12515eecdce7d616a42 100644 (file)
@@ -36,7 +36,7 @@ check_this (const DoFHandler<dim> &dof_handler)
     return;
   
   std::vector<unsigned int> map (dof_handler.n_dofs());
-  std::set<unsigned char> set;
+  std::set<types::boundary_id_t> set;
   set.insert (0);
   DoFTools::map_dof_to_boundary_indices (dof_handler, set, map);
   
index 6c789b5d8a6a9c356f2a3b510938dbb85fb954d6..805d3cd67b8364a672dd413608bfc3bf1a11fc22 100644 (file)
@@ -35,7 +35,7 @@ check_this (const DoFHandler<dim> &dof_handler)
     return;
   
   std::vector<unsigned int> map (dof_handler.n_dofs());
-  std::set<unsigned char> set;
+  std::set<types::boundary_id_t> set;
   set.insert (0);
   DoFTools::map_dof_to_boundary_indices (dof_handler, set, map);
   
index bbb253cfc1587596ac8db745b3f00c2cb0ee2f10..97c1eb886056588ac38a1d334a15328c05823df5 100644 (file)
@@ -35,7 +35,7 @@ check_this (const DoFHandler<dim> &dof_handler)
     return;
   
   std::vector<unsigned int> map (dof_handler.n_dofs());
-  std::set<unsigned char> set;
+  std::set<types::boundary_id_t> set;
   set.insert (0);
   DoFTools::map_dof_to_boundary_indices (dof_handler, set, map);
   
index a7f88324555b0c755839295ae860120f017ee390..d8476fe0cc046bedf656cbcc933e58c2183d7853 100644 (file)
@@ -35,7 +35,7 @@ check_this (const DoFHandler<dim> &dof_handler)
     return;
   
   std::vector<unsigned int> map (dof_handler.n_dofs());
-  std::set<unsigned char> set;
+  std::set<types::boundary_id_t> set;
   set.insert (0);
   DoFTools::map_dof_to_boundary_indices (dof_handler, set, map);
   
index 668261c4c4315fb8b8e7ea9a5857842d7531d5ac..035c54513d0b6070276c5ba2c62845e84945d17d 100644 (file)
@@ -35,7 +35,7 @@ check_this (const DoFHandler<dim> &dof_handler)
     return;
   
   std::vector<unsigned int> map (dof_handler.n_dofs());
-  std::set<unsigned char> set;
+  std::set<types::boundary_id_t> set;
   set.insert (0);
   DoFTools::map_dof_to_boundary_indices (dof_handler, set, map);
 
index e9bb39a3d146c34ff6fb2456152a7db9b2375ded..347f3db0d4c1d5741de6a8553ffdb5def5b750eb 100644 (file)
@@ -35,7 +35,7 @@ check_this (const DoFHandler<dim> &dof_handler)
     return;
   
   std::vector<unsigned int> map (dof_handler.n_dofs());
-  std::set<unsigned char> set;
+  std::set<types::boundary_id_t> set;
   set.insert (0);
   DoFTools::map_dof_to_boundary_indices (dof_handler, set, map);
 
index ed57b46f9a6616336922046c990f13109e03e3b9..3e4e9501df38e500acf70850f2908bd9e1ee179f 100644 (file)
@@ -51,7 +51,7 @@ check_this (const DoFHandler<dim> &dof_handler)
                                    // third further restrict to
                                    // boundary indicator 0
   {
-    std::set<unsigned char> boundary_ids;
+    std::set<types::boundary_id_t> boundary_ids;
     boundary_ids.insert (0);
     DoFTools::extract_dofs_with_support_on_boundary (dof_handler,
                                      component_select,
index 6c388b49dec2167b940cb446f89a53dd263f6233..f337f475767da3403746c8967bceb23ccd7429c0 100644 (file)
@@ -130,7 +130,7 @@ check ()
   MappingQ<dim> mapping(3);
   Quadrature<dim-1> &q_face = get_q_face(function);
 
-  std::map<unsigned char,const Function<dim>*> neumann_bc;
+  std::map<types::boundary_id_t,const Function<dim>*> neumann_bc;
   neumann_bc[0] = &function;
   
   Vector<double> v (dof.n_dofs());
index 087dc2ed3d10fa5db8704e5c7a1efb6b64375310..78557e6fdc3c3b9639479ea65290a56f12fc10a4 100644 (file)
@@ -130,7 +130,7 @@ check ()
   MappingQ<dim> mapping(3);
   Quadrature<dim-1> &q_face = get_q_face(function);
 
-  std::map<unsigned char,const Function<dim>*> neumann_bc;
+  std::map<types::boundary_id_t,const Function<dim>*> neumann_bc;
   neumann_bc[0] = &function;
   
   Vector<double> v (dof.n_dofs());
index bb1bce715be1e287b1231902857afcf65d0e667b..fd9359d72ff68025b1c44c0e53ab3f2106fc77ba 100644 (file)
@@ -26,7 +26,7 @@ int main ()
 
   Triangulation<1>   triangulation;
   GridGenerator::hyper_cube (triangulation, -1, 1);
-  const std::vector<unsigned char> indicators = triangulation.get_boundary_indicators();
+  const std::vector<types::boundary_id_t> indicators = triangulation.get_boundary_indicators();
   for (unsigned int i=0; i<indicators.size(); ++i)
     deallog << int (indicators[i]) << std::endl;
 
index a4de45a36607048114aa75f89c085f56feed14f3..324937dc814dbf1809b981c74ad28aef6054281e 100644 (file)
@@ -1,8 +1,8 @@
 //---------------------------------------------------------------------------
 //    $Id$
-//    Version: $Name$ 
+//    Version: $Name$
 //
-//    Copyright (C) 2005, 2006 by the deal.II authors
+//    Copyright (C) 2005, 2006, 2012 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
 #include <iomanip>
 
 
-template <int dim> Table<dim,unsigned char> material_ids();
+template <int dim> Table<dim,types::material_id_t> 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<dim> 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();
index 31b63da1a33c44dc986387de94a488962e9cc1a9..4eef579dcc19e94007f53ec0c70f6499d9793490 100644 (file)
@@ -85,7 +85,7 @@ int main ()
 
                                     // now extract a mesh of the 5
                                     // surface faces
-    std::set<unsigned char> boundary_indicators;
+    std::set<types::boundary_id_t> boundary_indicators;
     boundary_indicators.insert (0);
     GridTools::extract_boundary_mesh (volume_mesh, boundary_mesh,
                                      boundary_indicators);
index 7eae2461617b1bcc3248e34937ce146d4a163f5d..dd412fc3294f4a1f1043eb0cb49ed9d01b9a08d2 100644 (file)
@@ -88,7 +88,7 @@ int main ()
   tria.set_boundary (1, surface_description);
   tria.set_boundary (0, surface_description);
 
-  std::set<unsigned char> boundary_ids;
+  std::set<types::boundary_id_t> boundary_ids;
   boundary_ids.insert(0);
 
   GridTools::extract_boundary_mesh (volume_mesh, tria,
index bf467ced0a63b053fac0e47393785b2cd884df2e..46088863d31302cc73c15d6fdf50b363123b8d99 100644 (file)
@@ -128,7 +128,7 @@ check ()
   MappingQ<dim,spacedim> mapping(3);
   Quadrature<dim-1> &q_face = get_q_face<dim>();
 
-  std::map<unsigned char,const Function<spacedim>*> neumann_bc;
+  std::map<types::boundary_id_t,const Function<spacedim>*> neumann_bc;
   neumann_bc[0] = &function;
   
   Vector<double> v (dof.n_dofs());
index 14a6fc1191105af4c48bf06a8ccc745a91db8f63..6ab6d7af3a8c23fb38b977dc176e8246b54c7db1 100644 (file)
@@ -165,7 +165,7 @@ int main ()
     save_mesh(volume_mesh);
 
     Triangulation<dim-1,dim> boundary_mesh;
-    set<unsigned char> boundary_ids;
+    set<types::boundary_id_t> boundary_ids;
     boundary_ids.insert(0);
 
     surface_to_volume_mapping
index 120b0664380179dcfc90b40068715f67983fa7c1..bebed43111687eb160ca8a05637489b1a5b03e9c 100644 (file)
@@ -117,7 +117,7 @@ int main ()
     boundary_mesh.set_boundary (1, surface_description);
     boundary_mesh.set_boundary (0, surface_description);
 
-    set<unsigned char> boundary_ids;
+    set<types::boundary_id_t> boundary_ids;
     boundary_ids.insert(1);
 
     surface_to_volume_mapping
index 22b1da80cc15053679a8fd096445f7844502b0b0..4bc550b78365ced7dbb6306847fbb132b9b20e09 100644 (file)
@@ -50,7 +50,7 @@ int main ()
       cell = volume_mesh.begin_active();
 
     cell->face(0)->set_all_boundary_indicators (1);
-    std::set<unsigned char> boundary_ids;
+    std::set<types::boundary_id_t> boundary_ids;
     boundary_ids.insert(0);
     GridTools::extract_boundary_mesh (volume_mesh, boundary_mesh, boundary_ids);
   }
index bdfa748d5eaad8f757ad4c467dd447575c477f56..0c9dae13ec767c25e7d290994a7867497c5a0825 100644 (file)
@@ -50,7 +50,7 @@ int main ()
       cell = volume_mesh.begin_active();
 
     cell->face(0)->set_all_boundary_indicators (1);
-    std::set<unsigned char> boundary_ids;
+    std::set<types::boundary_id_t> boundary_ids;
     boundary_ids.insert(0);
     GridTools::extract_boundary_mesh (volume_mesh, boundary_mesh, boundary_ids);
   }
index d4030237688bbb47b76538183748f2131ad61aec..12b76b3f30d8462d8be14d0b269c0400bd7f487a 100644 (file)
@@ -44,7 +44,7 @@ int main ()
       cell = volume_mesh.begin_active();
 
     cell->face(0)->set_all_boundary_indicators (1);
-    std::set<unsigned char> boundary_ids;
+    std::set<types::boundary_id_t> boundary_ids;
     boundary_ids.insert(0);
     GridTools::extract_boundary_mesh (volume_mesh, boundary_mesh, boundary_ids);
   }
index ba1da7a4a4586407c0fe08518bf306c5cdd3e566..ee19bd19e676083311cc5f6ddbf012b29482d5e7 100644 (file)
@@ -38,7 +38,7 @@ void test() {
   Triangulation<dim, spacedim> tria;
   Triangulation<spacedim> volume_mesh;
   GridGenerator::half_hyper_ball(volume_mesh);
-  std::set<unsigned char> boundary_ids;
+  std::set<types::boundary_id_t> boundary_ids;
   boundary_ids.insert(0);
   
   GridTools::extract_boundary_mesh (volume_mesh, tria,boundary_ids);
index 55c92bcfe280420e6531b0225a639e7ecceede44..e7700d4f0e3007e32406a9c53bc91ab3639bd936 100644 (file)
@@ -68,7 +68,7 @@ int main ()
   triangulation.set_boundary (1, surface_description);
   triangulation.set_boundary (0, surface_description);
   
-  std::set<unsigned char> boundary_ids;
+  std::set<types::boundary_id_t> boundary_ids;
   boundary_ids.insert(0);
   
   GridTools::extract_boundary_mesh (volume_mesh, triangulation,
index 2fb900e357211ca7e96b8acddd549af5751eb8a8..d7f02026e21c69a7d95afa46b372e67f0a407d0c 100644 (file)
@@ -95,7 +95,7 @@ check ()
   MappingQ<dim> mapping(3);
   Quadrature<dim-1> &q_face = get_q_face(function);
 
-  std::map<unsigned char,const Function<dim>*> neumann_bc;
+  std::map<types::boundary_id_t,const Function<dim>*> neumann_bc;
   neumann_bc[0] = &function;
   
   Vector<double> v (dof.n_dofs());
index d40790b8c20018fd05b3b69e4249a81031367283..70936948363d1cc538a1b4bb7402373784b4f124 100644 (file)
@@ -55,7 +55,7 @@ check ()
   MappingQ<dim,spacedim> mapping(3);
   QGauss<dim-1> q_face(4);
 
-  std::map<unsigned char,const Function<spacedim>*> neumann_bc;
+  std::map<types::boundary_id_t,const Function<spacedim>*> neumann_bc;
   neumann_bc[0] = &function;
   
   Vector<double> v (dof.n_dofs());
index 1eeb1c4f0c12e47c02f49c8e7574425d06cfd92e..867707e98c63b831ae0d4b8f7794ef0b6ce51a58 100644 (file)
@@ -148,7 +148,7 @@ void FindBug<dim>::dirichlet_conditions ()
 
 
   std::vector<bool> fixed_dofs (dof_handler.n_dofs());
-  std::set<unsigned char> boundary_indicators;
+  std::set<types::boundary_id_t> boundary_indicators;
   boundary_indicators.insert (0);
 
                                    // get a list of those boundary DoFs which
index dcefd0c953c2212800405a7656871382c82963be..983403a3638aba2b1968c1bf5a9673bb7c565a67 100644 (file)
@@ -45,7 +45,7 @@ void test (const Triangulation<dim>& tr,
              << ", case=" << i
              << std::endl;
 
-      std::set<unsigned char> boundary_ids;
+      std::set<types::boundary_id_t> boundary_ids;
       for (unsigned int j=0; j<=i; ++j)
        boundary_ids.insert (j);
       
index bbbeebe922f8e53af3bad3977bc4d61fb4a4b26b..522a3ec686c06287ee24b01302bdbc7e4e2979f0 100644 (file)
@@ -47,7 +47,7 @@ void test (const Triangulation<dim>& tr,
              << ", case=" << i
              << std::endl;
 
-      std::set<unsigned char> boundary_ids;
+      std::set<types::boundary_id_t> boundary_ids;
       for (unsigned int j=0; j<=i; ++j)
        boundary_ids.insert (j);
       
index 339c63c71a0e5bead6f5e7815bdf86c278256fb2..c4eae8e8065f22c3edba8937ad8ef6292e913f36 100644 (file)
@@ -45,7 +45,7 @@ void test (const Triangulation<dim>& tr,
   deallog << "FE=" << fe.get_name()
          << std::endl;
 
-  std::set<unsigned char> boundary_ids;
+  std::set<types::boundary_id_t> boundary_ids;
   boundary_ids.insert (0);
       
   ConstraintMatrix cm;
index 8c96ad92e284ea1b3beff8828510b35b90b7ec74..a5614e7a9ec85152810ca28c3bf9a2f10f99f0a5 100644 (file)
@@ -78,7 +78,7 @@ void test (const Triangulation<dim>& tr,
   deallog << "FE=" << fe.get_name()
          << std::endl;
 
-  std::set<unsigned char> boundary_ids;
+  std::set<types::boundary_id_t> boundary_ids;
   boundary_ids.insert (0);
 
   ConstraintMatrix cm;
index 9219b592c6b2566dca3917bb774f9b9b38d8313a..64a3e768432582ea836e4178e0c05b8256fdf833 100644 (file)
@@ -57,7 +57,7 @@ void test (const Triangulation<dim>& tr,
              << ", case=" << i
              << std::endl;
 
-      std::set<unsigned char> boundary_ids;
+      std::set<types::boundary_id_t> boundary_ids;
       for (unsigned int j=0; j<=i; ++j)
        boundary_ids.insert (j);
 
index 49380858032ab2f975bcf6686495f94f76c749cd..7db9d72ea9e600c394ccbafb15212956da7cf921 100644 (file)
@@ -48,7 +48,7 @@ void test_hyper_cube()
   deallog << "FE=" << fe.get_name()
          << std::endl;
 
-  std::set<unsigned char> boundary_ids;
+  std::set<types::boundary_id_t> boundary_ids;
   boundary_ids.insert (1);
   boundary_ids.insert (3);
   
index 9c9263ffb6e0edc5b0d381ef494ed54a1f302d90..0ab0b20273162653daaa18216531d9d49ca7c858 100644 (file)
@@ -47,7 +47,7 @@ void test (const Triangulation<dim>& tr,
   DoFHandler<dim> dof(tr);
   dof.distribute_dofs(fe);
 
-  std::set<unsigned char> boundary_ids;
+  std::set<types::boundary_id_t> boundary_ids;
   boundary_ids.insert (0);
 
   ConstraintMatrix cm;
index 21cdd93ac6fc1649ec7e11e6182531803c5aff80..1ef5f7d56d28e3be5d79c09202f7910b0b021fbe 100644 (file)
@@ -15,7 +15,7 @@
 // we used to get this crash:
 //
 // An error occurred in line <4646> of file </w/heister/deal-trunk/deal.II/include/deal.II/numerics/vectors.templates.h> in function
-//     static void dealii::VectorTools::compute_no_normal_flux_constraints(const DH<dim, spacedim>&, unsigned int, const std::set<unsigned char>&, dealii::ConstraintMatrix&, const dealii::Mapping<dim, spacedim>&) [with int dim = 3, DH = dealii::DoFHandler, int spacedim = 3]
+//     static void dealii::VectorTools::compute_no_normal_flux_constraints(const DH<dim, spacedim>&, unsigned int, const std::set<types::boundary_id_t>&, dealii::ConstraintMatrix&, const dealii::Mapping<dim, spacedim>&) [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<unsigned char> no_normal_flux_boundaries;
+  std::set<types::boundary_id_t> no_normal_flux_boundaries;
   no_normal_flux_boundaries.insert (0);
   VectorTools::compute_no_normal_flux_constraints (dofh, 0, no_normal_flux_boundaries, cm, mapping);
 
index e803d1879e4642f57b43304efdd1186ad2f0f60e..9457cf3f43609bd1361f1a40c65548801ecac097 100644 (file)
@@ -53,7 +53,7 @@ check ()
 
   dofh.distribute_dofs (fe);
 
-  std::set<unsigned char> no_normal_flux_boundaries;
+  std::set<types::boundary_id_t> 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);
index e820967ca083306e2622dcd0c2658639f8a6642b..b0da9dccdb3c724af98ffd127780de02b86325f7 100644 (file)
@@ -32,7 +32,7 @@ void test (const Triangulation<dim>& tr,
              << ", case=" << i
              << std::endl;
 
-      std::set<unsigned char> boundary_ids;
+      std::set<types::boundary_id_t> boundary_ids;
       for (unsigned int j=0; j<=i; ++j)
        boundary_ids.insert (j);
       
index 9ce7fb16a9e1e2ac300b3d1d952af5e2c6921b5e..7fa21f12f5bc2a080221f9cff3644db3546adff8 100644 (file)
@@ -35,7 +35,7 @@ void test (const Triangulation<dim>& tr,
              << ", case=" << i
              << std::endl;
 
-      std::set<unsigned char> boundary_ids;
+      std::set<types::boundary_id_t> boundary_ids;
       for (unsigned int j=0; j<=i; ++j)
        boundary_ids.insert (j);
       
index c55f89bb9c7bafecc1773ebd7f5558b8ad3a85ae..21ab7b7200ae9b2a28f1a98759acb54b7af1059a 100644 (file)
@@ -32,7 +32,7 @@ void test (const Triangulation<dim>& tr,
   deallog << "FE=" << fe[0].get_name()
          << std::endl;
 
-  std::set<unsigned char> boundary_ids;
+  std::set<types::boundary_id_t> boundary_ids;
   boundary_ids.insert (0);
       
   ConstraintMatrix cm;
index 3867bbd02f47d679382936f28f6de00912ecb1e6..e5d14eedef2431de0e80986d0eec48c5742d1b82 100644 (file)
@@ -65,7 +65,7 @@ void test (const Triangulation<dim>& tr,
   deallog << "FE=" << fe[0].get_name()
          << std::endl;
 
-  std::set<unsigned char> boundary_ids;
+  std::set<types::boundary_id_t> boundary_ids;
   boundary_ids.insert (0);
 
   ConstraintMatrix cm;
index 30dd31960e1b2c7d07f29b7cb9c12a5cd74cc4b5..256bb11b31c18d3b6171e80f7fd72c8a0a4c7658 100644 (file)
@@ -45,7 +45,7 @@ void test (const Triangulation<dim>& tr,
              << ", case=" << i
              << std::endl;
 
-      std::set<unsigned char> boundary_ids;
+      std::set<types::boundary_id_t> boundary_ids;
       for (unsigned int j=0; j<=i; ++j)
        boundary_ids.insert (j);
 
index c3f94cf900d4fe5217d4071e8070cf77d26e64af..aab7171e0bc43524590acd9b25254c0980210f31 100644 (file)
@@ -134,7 +134,7 @@ void test_projection (const Triangulation<dim>& tr,
   TestFunction<dim> f(degree-1);
   std::map<unsigned int, double> boundary_constraints;
   typename FunctionMap<dim>::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);
index 5396375b5e9c22dd0f0d1c698c49a92efd24dc5e..eba87370b879c4a8f1693d40d6a81ba5a57ddfd2 100644 (file)
@@ -31,7 +31,7 @@ void test ()
   GridGenerator::hyper_cube (tria);
   tria.refine_global (2);
 
-  std::vector<unsigned char>
+  std::vector<types::boundary_id_t>
     boundary_ids = tria.get_boundary_indicators ();
 
   for (unsigned int i=0; i<boundary_ids.size(); ++i)
index 0f2f572703404e8216f35f8265e33aef2ce250b0..22b8afa14b6b4f9bcfe17aff3aecf030ec3cbf21 100644 (file)
@@ -33,7 +33,7 @@ void test ()
   tria.begin_active()->face(0)->set_boundary_indicator(2);
   tria.begin_active()->face(1)->set_boundary_indicator(4);
 
-  std::vector<unsigned char>
+  std::vector<types::boundary_id_t>
     boundary_ids = tria.get_boundary_indicators ();
 
   for (unsigned int i=0; i<boundary_ids.size(); ++i)
index 8217de4e1dbf548468a2ef8dcd64a9b3b9de6aff..6d5de5c267b844a4c201365a6698ca9af02b502f 100644 (file)
@@ -493,7 +493,7 @@ void project (const Mapping<dim>       &mapping,
                                         // @p{function} to hold on all parts of the
                                         // boundary
        typename FunctionMap<dim>::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);
index aed9a30cdccfe22ce452c674212a462d0af11e43..6c989b2bb596e54c9dbc306e79f3bc0653770448 100644 (file)
@@ -72,8 +72,8 @@ void test ()
   Vector<double> rhs_vector(hp_dof_handler.n_dofs());
   Vector<double> rhs_vector2(hp_dof_handler2.n_dofs());
 
-  unsigned char myints[1];
-  std::set<unsigned char> boundary_indicators  (myints,myints+1);  
+  types::boundary_id_t myints[1];
+  std::set<types::boundary_id_t> boundary_indicators  (myints,myints+1);  
   myints[0]=0;
   hp::QCollection<1>   quadrature;
   quadrature.push_back (QGauss<1>(1));
index 06038b07e7978a1a9f9a3d263558d4aaeaad37e5..b6fc2f67720254e008155a56920e2d332922736c 100644 (file)
@@ -106,7 +106,7 @@ void test()
   ConstraintMatrix constraints;
   constraints.reinit(relevant_set);
   DoFTools::make_hanging_node_constraints (dofh, constraints);
-  std::set<unsigned char> no_normal_flux_boundaries;
+  std::set<types::boundary_id_t> no_normal_flux_boundaries;
   no_normal_flux_boundaries.insert (1);
   const unsigned int degree = 1;
   VectorTools::compute_no_normal_flux_constraints (dofh, 0,
index 1feed297c7abca2e51313ef78d813f3b2f599efb..95b2130eb2cb776a38a98c2c7b6c3ce24037a645 100644 (file)
@@ -111,7 +111,7 @@ void test()
   ConstraintMatrix constraints;
   constraints.reinit(relevant_set);
   DoFTools::make_hanging_node_constraints (dofh, constraints);
-  std::set<unsigned char> no_normal_flux_boundaries;
+  std::set<types::boundary_id_t> no_normal_flux_boundaries;
   no_normal_flux_boundaries.insert (1);
   const unsigned int degree = 1;
 /*  VectorTools::compute_no_normal_flux_constraints (dofh, 0,
index 36fd5acc39b3d2e969f616583bd1a813b1707c94..e00d4bcfce5d2b74e86fd992ab26fb1be7d63b17 100644 (file)
@@ -82,7 +82,7 @@ void test()
   ConstraintMatrix constraints;
   constraints.reinit(relevant_set);
   DoFTools::make_hanging_node_constraints (dofh, constraints);
-  std::set<unsigned char> no_normal_flux_boundaries;
+  std::set<types::boundary_id_t> no_normal_flux_boundaries;
   no_normal_flux_boundaries.insert (0);
   const unsigned int degree = 1;
   VectorTools::compute_no_normal_flux_constraints (dofh, 0,
index c4cbc6e2a5feb79e182dc1dae26844d8f48cec97..450fd20dd3daeea935bd9533c4cd338add38bf4d 100644 (file)
@@ -162,7 +162,7 @@ void test()
                                              cm,
                                              velocity_mask);
 
-    std::set<unsigned char> no_normal_flux_boundaries;
+    std::set<types::boundary_id_t> no_normal_flux_boundaries;
     no_normal_flux_boundaries.insert (1);
 
 

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.