]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Be consistent about using types::subdomain_id.
authorWolfgang Bangerth <bangerth@colostate.edu>
Thu, 27 Oct 2016 17:37:59 +0000 (12:37 -0500)
committerWolfgang Bangerth <bangerth@colostate.edu>
Thu, 27 Oct 2016 17:37:59 +0000 (12:37 -0500)
include/deal.II/dofs/dof_tools.h
source/dofs/dof_handler_policy.cc
source/dofs/dof_tools.cc
source/dofs/dof_tools_sparsity.inst.in
source/multigrid/mg_level_global_transfer.cc
source/numerics/error_estimator.inst.in
source/numerics/error_estimator_1d.inst.in

index 1816cca7a2b562c169ed0d69acfd754d8f24bf48..09b6849308f2162bfa34d0191e1da244ba23de42 100644 (file)
@@ -623,7 +623,7 @@ namespace DoFTools
                               SparsityPatternType       &sparsity_pattern,
                               const ConstraintMatrix    &constraints,
                               const bool                 keep_constrained_dofs = true,
-                              const types::subdomain_id  subdomain_id          = numbers::invalid_unsigned_int);
+                              const types::subdomain_id  subdomain_id          = numbers::invalid_subdomain_id);
 
   /**
    * This function does essentially the same as the other
index 9b19530df937de4ca083f2b9c754a67a832915ff..a2004fd2f03e95606dc9f639dc96984d34bb3e81 100644 (file)
@@ -1599,10 +1599,10 @@ namespace internal
                                    const std::vector<dealii::types::global_dof_index> &p4est_tree_to_coarse_cell_permutation)
         {
           // build list of cells to request for each neighbor
-          std::set<unsigned int> level_ghost_owners = tria.level_ghost_owners();
+          std::set<dealii::types::subdomain_id> level_ghost_owners = tria.level_ghost_owners();
           typedef std::map<dealii::types::subdomain_id, typename types<dim>::cellinfo> cellmap_t;
           cellmap_t neighbor_cell_list;
-          for (std::set<unsigned int>::iterator it = level_ghost_owners.begin();
+          for (std::set<dealii::types::subdomain_id>::iterator it = level_ghost_owners.begin();
                it != level_ghost_owners.end();
                ++it)
             neighbor_cell_list.insert(std::make_pair(*it, typename types<dim>::cellinfo()));
index 090ca73cf870395fcfa019704782483244d45107..90e1a0b00ac051b0004f4431deb7be61c454cbe7 100644 (file)
@@ -1376,7 +1376,7 @@ namespace DoFTools
         // one, where we take "random" to be "once this way once that way"
         for (unsigned int i=0; i<dofs_per_cell; ++i)
           if (subdomain_association[local_dof_indices[i]] ==
-              numbers::invalid_unsigned_int)
+              numbers::invalid_subdomain_id)
             subdomain_association[local_dof_indices[i]] = subdomain_id;
           else
             {
index 26ec4109a9c40ead097bdccfa51c25164956fbd5..6bf8e93a032f4f3957320fa9e20b09df30b9ffda 100644 (file)
@@ -121,7 +121,7 @@ for (SP : SPARSITY_PATTERNS; deal_II_dimension : DIMENSIONS)
      SP    &sparsity,
      const ConstraintMatrix &,
      const bool,
-     const unsigned int);
+     const types::subdomain_id);
 
     template void
     DoFTools::make_sparsity_pattern<hp::DoFHandler<deal_II_dimension,deal_II_dimension>, SP>
@@ -129,7 +129,7 @@ for (SP : SPARSITY_PATTERNS; deal_II_dimension : DIMENSIONS)
      SP    &sparsity,
      const ConstraintMatrix &,
      const bool,
-     const unsigned int);
+     const types::subdomain_id);
 
     template void
     DoFTools::make_sparsity_pattern<DoFHandler<deal_II_dimension,deal_II_dimension>, SP>
@@ -138,7 +138,7 @@ for (SP : SPARSITY_PATTERNS; deal_II_dimension : DIMENSIONS)
      SP &,
      const ConstraintMatrix &,
      const bool,
-     const unsigned int);
+     const types::subdomain_id);
 
     template void
     DoFTools::make_sparsity_pattern<hp::DoFHandler<deal_II_dimension,deal_II_dimension>, SP>
@@ -147,7 +147,7 @@ for (SP : SPARSITY_PATTERNS; deal_II_dimension : DIMENSIONS)
      SP &,
      const ConstraintMatrix &,
      const bool,
-     const unsigned int);
+     const types::subdomain_id);
 
     template void
     DoFTools::make_sparsity_pattern<DoFHandler<deal_II_dimension,deal_II_dimension>, SP>
@@ -189,7 +189,7 @@ for (SP : SPARSITY_PATTERNS; deal_II_dimension : DIMENSIONS)
      SP    &sparsity,
      const Table<2,Coupling>&,
      const Table<2,Coupling>&,
-     const unsigned int);
+     const types::subdomain_id);
 
     template void
     DoFTools::make_flux_sparsity_pattern<DoFHandler<deal_II_dimension>,SP>
@@ -199,21 +199,23 @@ for (SP : SPARSITY_PATTERNS; deal_II_dimension : DIMENSIONS)
      const bool,
      const Table<2,Coupling>&,
      const Table<2,Coupling>&,
-     const unsigned int);
+     const types::subdomain_id);
 
     template void
     DoFTools::make_flux_sparsity_pattern<DoFHandler<deal_II_dimension>,SP>
     (const DoFHandler<deal_II_dimension> &dof,
      SP    &sparsity,
      const ConstraintMatrix &constraints,
-     const bool, const unsigned int);
+     const bool,
+     const types::subdomain_id);
 
     template void
     DoFTools::make_flux_sparsity_pattern<hp::DoFHandler<deal_II_dimension>,SP>
     (const hp::DoFHandler<deal_II_dimension> &dof,
      SP    &sparsity,
      const ConstraintMatrix &constraints,
-     const bool, const unsigned int);
+     const bool,
+     const types::subdomain_id);
 
 #if deal_II_dimension > 1
 
@@ -223,7 +225,7 @@ for (SP : SPARSITY_PATTERNS; deal_II_dimension : DIMENSIONS)
      SP    &sparsity,
      const Table<2,Coupling>&,
      const Table<2,Coupling>&,
-     const unsigned int);
+     const types::subdomain_id);
 
     template void
     DoFTools::make_flux_sparsity_pattern<hp::DoFHandler<deal_II_dimension>,SP>
@@ -233,7 +235,7 @@ for (SP : SPARSITY_PATTERNS; deal_II_dimension : DIMENSIONS)
      const bool,
      const Table<2,Coupling>&,
      const Table<2,Coupling>&,
-     const unsigned int);
+     const types::subdomain_id);
 
 #endif
 
@@ -245,7 +247,7 @@ for (SP : SPARSITY_PATTERNS; deal_II_dimension : DIMENSIONS)
      SP    &sparsity,
      const ConstraintMatrix &,
      const bool,
-     const unsigned int);
+     const types::subdomain_id);
 
     template void
     DoFTools::make_sparsity_pattern<hp::DoFHandler<deal_II_dimension,deal_II_dimension+1>, SP>
@@ -253,7 +255,7 @@ for (SP : SPARSITY_PATTERNS; deal_II_dimension : DIMENSIONS)
      SP    &sparsity,
      const ConstraintMatrix &,
      const bool,
-     const unsigned int);
+     const types::subdomain_id);
 
     template void
     DoFTools::make_sparsity_pattern<DoFHandler<deal_II_dimension,deal_II_dimension+1>, SP>
@@ -262,7 +264,7 @@ for (SP : SPARSITY_PATTERNS; deal_II_dimension : DIMENSIONS)
      SP &,
      const ConstraintMatrix &,
      const bool,
-     const unsigned int);
+     const types::subdomain_id);
 
     template void
     DoFTools::make_sparsity_pattern<hp::DoFHandler<deal_II_dimension,deal_II_dimension+1>, SP>
@@ -271,7 +273,7 @@ for (SP : SPARSITY_PATTERNS; deal_II_dimension : DIMENSIONS)
      SP &,
      const ConstraintMatrix &,
      const bool,
-     const unsigned int);
+     const types::subdomain_id);
 
     template void
     DoFTools::make_sparsity_pattern<DoFHandler<deal_II_dimension,deal_II_dimension+1>, SP>
@@ -308,7 +310,7 @@ for (SP : SPARSITY_PATTERNS; deal_II_dimension : DIMENSIONS)
      SP    &sparsity,
      const ConstraintMatrix &,
      const bool,
-     const unsigned int);
+     const types::subdomain_id);
 
     template void
     DoFTools::make_sparsity_pattern<hp::DoFHandler<1,3>, SP>
@@ -316,7 +318,7 @@ for (SP : SPARSITY_PATTERNS; deal_II_dimension : DIMENSIONS)
      SP    &sparsity,
      const ConstraintMatrix &,
      const bool,
-     const unsigned int);
+     const types::subdomain_id);
 
     template void
     DoFTools::make_sparsity_pattern<DoFHandler<1,3>, SP>
@@ -325,7 +327,7 @@ for (SP : SPARSITY_PATTERNS; deal_II_dimension : DIMENSIONS)
      SP &,
      const ConstraintMatrix &,
      const bool,
-     const unsigned int);
+     const types::subdomain_id);
 
     template void
     DoFTools::make_sparsity_pattern<hp::DoFHandler<1,3>, SP>
@@ -334,7 +336,7 @@ for (SP : SPARSITY_PATTERNS; deal_II_dimension : DIMENSIONS)
      SP &,
      const ConstraintMatrix &,
      const bool,
-     const unsigned int);
+     const types::subdomain_id);
 
     template void
     DoFTools::make_sparsity_pattern<DoFHandler<1,3>, SP>
index a74eb04a7afb058fee403ff2c1c706a37148b647..d23ef3fba69f36ae9c9cef23e145829efd190ead 100644 (file)
@@ -172,13 +172,13 @@ namespace
         // inefficient. Please fix this, Timo.
         // The list of neighbors is symmetric (our neighbors have us as a neighbor),
         // so we can use it to send and to know how many messages we will get.
-        std::set<unsigned int> neighbors = tria->level_ghost_owners();
+        std::set<types::subdomain_id> neighbors = tria->level_ghost_owners();
         std::map<int, std::vector<DoFPair> > send_data;
 
         // * find owners of the level dofs and insert into send_data accordingly
         for (typename std::vector<DoFPair>::iterator dofpair=send_data_temp.begin(); dofpair != send_data_temp.end(); ++dofpair)
           {
-            std::set<unsigned int>::iterator it;
+            std::set<types::subdomain_id>::iterator it;
             for (it = neighbors.begin(); it != neighbors.end(); ++it)
               {
                 if (mg_dof.locally_owned_mg_dofs_per_processor(dofpair->level)[*it].is_element(dofpair->level_dof_index))
@@ -195,7 +195,7 @@ namespace
         // * send
         std::vector<MPI_Request> requests;
         {
-          for (std::set<unsigned int>::iterator it = neighbors.begin(); it != neighbors.end(); ++it)
+          for (std::set<types::subdomain_id>::iterator it = neighbors.begin(); it != neighbors.end(); ++it)
             {
               requests.push_back(MPI_Request());
               unsigned int dest = *it;
index 8524aeeaefdcc7e927fe6017425857c07197e985..a6975a1d9fdae24697f1895eac0a8fc278912805 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2015 by the deal.II authors
+// Copyright (C) 2010 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
@@ -37,7 +37,7 @@ for (VEC : SERIAL_VECTORS ; deal_II_dimension : DIMENSIONS; deal_II_space_dimens
             const ComponentMask &,
             const Function<deal_II_space_dimension>     *,
             const unsigned int       ,
-            const unsigned int       ,
+            const types::subdomain_id,
             const types::material_id,
             const KellyErrorEstimator<deal_II_dimension, deal_II_space_dimension>::Strategy);
 
@@ -53,7 +53,7 @@ for (VEC : SERIAL_VECTORS ; deal_II_dimension : DIMENSIONS; deal_II_space_dimens
         const ComponentMask &,
         const Function<deal_II_space_dimension>     *,
         const unsigned int       ,
-        const unsigned int       ,
+        const types::subdomain_id,
         const types::material_id,
         const KellyErrorEstimator<deal_II_dimension, deal_II_space_dimension>::Strategy);
 
@@ -69,7 +69,7 @@ for (VEC : SERIAL_VECTORS ; deal_II_dimension : DIMENSIONS; deal_II_space_dimens
             const ComponentMask &,
             const Function<deal_II_space_dimension>     *,
             const unsigned int       ,
-            const unsigned int       ,
+            const types::subdomain_id,
             const types::material_id,
             const KellyErrorEstimator<deal_II_dimension, deal_II_space_dimension>::Strategy);
 
@@ -85,7 +85,7 @@ for (VEC : SERIAL_VECTORS ; deal_II_dimension : DIMENSIONS; deal_II_space_dimens
         const ComponentMask &,
         const Function<deal_II_space_dimension>     *,
         const unsigned int       ,
-        const unsigned int       ,
+        const types::subdomain_id,
         const types::material_id,
         const KellyErrorEstimator<deal_II_dimension, deal_II_space_dimension>::Strategy);
 
@@ -101,7 +101,7 @@ for (VEC : SERIAL_VECTORS ; deal_II_dimension : DIMENSIONS; deal_II_space_dimens
             const ComponentMask &,
             const Function<deal_II_space_dimension>     *,
             const unsigned int       ,
-            const unsigned int       ,
+            const types::subdomain_id,
             const types::material_id,
             const KellyErrorEstimator<deal_II_dimension, deal_II_space_dimension>::Strategy);
 
@@ -117,7 +117,7 @@ for (VEC : SERIAL_VECTORS ; deal_II_dimension : DIMENSIONS; deal_II_space_dimens
         const ComponentMask &,
         const Function<deal_II_space_dimension>     *,
         const unsigned int       ,
-        const unsigned int       ,
+        const types::subdomain_id,
         const types::material_id,
         const KellyErrorEstimator<deal_II_dimension, deal_II_space_dimension>::Strategy);
 
@@ -133,7 +133,7 @@ for (VEC : SERIAL_VECTORS ; deal_II_dimension : DIMENSIONS; deal_II_space_dimens
             const ComponentMask &,
             const Function<deal_II_space_dimension>     *,
             const unsigned int       ,
-            const unsigned int       ,
+            const types::subdomain_id,
             const types::material_id,
             const KellyErrorEstimator<deal_II_dimension, deal_II_space_dimension>::Strategy);
 
@@ -149,7 +149,7 @@ for (VEC : SERIAL_VECTORS ; deal_II_dimension : DIMENSIONS; deal_II_space_dimens
         const ComponentMask &,
         const Function<deal_II_space_dimension>     *,
         const unsigned int       ,
-        const unsigned int       ,
+        const types::subdomain_id,
         const types::material_id,
         const KellyErrorEstimator<deal_II_dimension, deal_II_space_dimension>::Strategy);
 
index 66fc0420c352efe8d8234e123531709f57ca1017..40a2a6ee3ce613c5e9ad41971c70e891c5bc15ba 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2014 by the deal.II authors
+// Copyright (C) 2010 - 2014, 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
@@ -30,7 +30,7 @@ for (VEC : SERIAL_VECTORS ; deal_II_dimension : DIMENSIONS; deal_II_space_dimens
             const ComponentMask &,
             const Function<deal_II_space_dimension>     *,
             const unsigned int       ,
-            const unsigned int       ,
+            const types::subdomain_id,
             const types::material_id);
 
     template
@@ -45,7 +45,7 @@ for (VEC : SERIAL_VECTORS ; deal_II_dimension : DIMENSIONS; deal_II_space_dimens
         const ComponentMask &,
         const Function<deal_II_space_dimension>     *,
         const unsigned int       ,
-        const unsigned int       ,
+        const types::subdomain_id,
         const types::material_id);
 
     template
@@ -60,7 +60,7 @@ for (VEC : SERIAL_VECTORS ; deal_II_dimension : DIMENSIONS; deal_II_space_dimens
             const ComponentMask &,
             const Function<deal_II_space_dimension>     *,
             const unsigned int       ,
-            const unsigned int       ,
+            const types::subdomain_id,
             const types::material_id);
 
     template
@@ -75,7 +75,7 @@ for (VEC : SERIAL_VECTORS ; deal_II_dimension : DIMENSIONS; deal_II_space_dimens
         const ComponentMask &,
         const Function<deal_II_space_dimension>     *,
         const unsigned int       ,
-        const unsigned int       ,
+        const types::subdomain_id,
         const types::material_id);
 
     template
@@ -90,7 +90,7 @@ for (VEC : SERIAL_VECTORS ; deal_II_dimension : DIMENSIONS; deal_II_space_dimens
             const ComponentMask &,
             const Function<deal_II_space_dimension>     *,
             const unsigned int       ,
-            const unsigned int       ,
+            const types::subdomain_id,
             const types::material_id);
 
     template
@@ -105,7 +105,7 @@ for (VEC : SERIAL_VECTORS ; deal_II_dimension : DIMENSIONS; deal_II_space_dimens
         const ComponentMask &,
         const Function<deal_II_space_dimension>     *,
         const unsigned int       ,
-        const unsigned int       ,
+        const types::subdomain_id,
         const types::material_id);
 
     template
@@ -120,7 +120,7 @@ for (VEC : SERIAL_VECTORS ; deal_II_dimension : DIMENSIONS; deal_II_space_dimens
             const ComponentMask &,
             const Function<deal_II_space_dimension>     *,
             const unsigned int       ,
-            const unsigned int       ,
+            const types::subdomain_id,
             const types::material_id);
 
     template
@@ -135,7 +135,7 @@ for (VEC : SERIAL_VECTORS ; deal_II_dimension : DIMENSIONS; deal_II_space_dimens
         const ComponentMask &,
         const Function<deal_II_space_dimension>     *,
         const unsigned int       ,
-        const unsigned int       ,
+        const types::subdomain_id,
         const types::material_id);
 
 #endif

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.