]> https://gitweb.dealii.org/ - dealii-svn.git/commitdiff
As discussed at the workshop, rename types::material_id_t to types::material_id and...
authorbangerth <bangerth@0785d39b-7218-0410-832d-ea1e28bc413d>
Wed, 22 Aug 2012 19:48:12 +0000 (19:48 +0000)
committerbangerth <bangerth@0785d39b-7218-0410-832d-ea1e28bc413d>
Wed, 22 Aug 2012 19:48:12 +0000 (19:48 +0000)
git-svn-id: https://svn.dealii.org/trunk@26085 0785d39b-7218-0410-832d-ea1e28bc413d

41 files changed:
deal.II/doc/news/changes.h
deal.II/examples/step-31/step-31.cc
deal.II/examples/step-32/step-32.cc
deal.II/examples/step-35/step-35.cc
deal.II/examples/step-38/step-38.cc
deal.II/include/deal.II/base/types.h
deal.II/include/deal.II/distributed/tria.h
deal.II/include/deal.II/dofs/dof_handler.h
deal.II/include/deal.II/dofs/dof_tools.h
deal.II/include/deal.II/dofs/function_map.h
deal.II/include/deal.II/grid/filtered_iterator.h
deal.II/include/deal.II/grid/grid_generator.h
deal.II/include/deal.II/grid/grid_tools.h
deal.II/include/deal.II/grid/tria.h
deal.II/include/deal.II/grid/tria_accessor.h
deal.II/include/deal.II/grid/tria_accessor.templates.h
deal.II/include/deal.II/grid/tria_levels.h
deal.II/include/deal.II/grid/tria_objects.h
deal.II/include/deal.II/hp/dof_handler.h
deal.II/include/deal.II/numerics/error_estimator.h
deal.II/include/deal.II/numerics/vector_tools.h
deal.II/include/deal.II/numerics/vector_tools.templates.h
deal.II/source/distributed/tria.cc
deal.II/source/dofs/dof_handler.cc
deal.II/source/dofs/dof_handler_policy.cc
deal.II/source/dofs/dof_renumbering.cc
deal.II/source/dofs/dof_tools.cc
deal.II/source/dofs/dof_tools.inst.in
deal.II/source/fe/fe_tools.cc
deal.II/source/grid/grid_generator.cc
deal.II/source/grid/grid_in.cc
deal.II/source/grid/grid_out.cc
deal.II/source/grid/grid_tools.cc
deal.II/source/grid/grid_tools.inst.in
deal.II/source/grid/tria.cc
deal.II/source/grid/tria_accessor.cc
deal.II/source/hp/dof_handler.cc
deal.II/source/multigrid/mg_tools.cc
deal.II/source/numerics/error_estimator.cc
deal.II/source/numerics/error_estimator.inst.in
deal.II/source/numerics/vector_tools.inst.in

index 1e8ca84a17a8ecfa79e11c2dde5612931ed131db..c75381a056b8618c164a62d6e7c67a366c0e1561 100644 (file)
@@ -37,7 +37,7 @@ and then copy it into a vector with ghost elements.
 (Wolfgang Bangerth, 2012/08/06)
 
 <li> Changed: The argument material_id of the estimate-functions of
-the KellyErrorEstimator class is now of type types::material_id_type
+the KellyErrorEstimator class is now of type types::material_id
 with default value types::invalid_material_id, instead of type
 unsigned int with default value numbers::invalid_unsigned_int. This
 should not make a difference to most users unless you specified the
@@ -47,7 +47,7 @@ argument's default value by hand.
 
 <li>
 The member functions Triangulation::set_boundary and
-Triangulation::get_boundary now take a types::boundary_id_t instead of
+Triangulation::get_boundary now take a types::boundary_id instead of
 an unsigned int as argument. This now matches the actual data type
 used to store boundary indicators internally.
 <br>
@@ -63,10 +63,19 @@ used to store boundary indicators internally.
 
 <ol>
 <li>
-Changed: unify the concept of compress() for all linear algebra
+Changed: To make the naming of types defined in namespace types
+consistent, we have renamed types::subdomain_id_t to
+types::subdomain_id. The old name has been retained as a typedef
+but is now deprecated.
+<br>
+(Wolfgang Bangerth, 2012/08/22)
+
+<li>
+Changed: Unify the concept of compress() for all linear algebra
 objects. Introduce type VectorOperation to decide between
 add and insert. Implement also for serial vectors. Note:
-this breaks distributed::vector::compress(bool).
+this breaks distributed::vector::compress(bool). See
+@ref GlossCompress for more information.
 <br>
 (Timo Heister, 2012/08/13)
 
@@ -187,14 +196,14 @@ embedded into spacedim=dim+2 dimensional space.
 
 <li> Changed: Material and Boundary indicators have been both of the
 type unsigned char. Throughout the library, we changed their datatype
-to <code>types::material_id_t</code>
-resp. <code>types::boundary_id_t</code>, both typedefs of unsigned
+to <code>types::material_id</code>
+resp. <code>types::boundary_id</code>, both typedefs of unsigned
 char. Internal faces are now characterized by
-types::internal_face_boundary_id(<code>=static_cast@<boundary_id_t@>(-1)</code>)
+types::internal_face_boundary_id(<code>=static_cast@<types::boundary_id@>(-1)</code>)
 instead of 255, so we get rid of that mysterious number in the source
 code.  Material_ids are also assumed to lie in the range from 0 to
 types::invalid_material_id-1 (where <code>types::invalid_material_id =
-static_cast<material_id_t>(-1)</code>). With this change, it is now
+static_cast<types::material_id>(-1)</code>). With this change, it is now
 much easier to extend the range of boundary or material ids, if
 needed.
 <br>
index 0b38b30310d46d84f69afe60dd75cb367dcc100b..0d78aa904670447b53bc0ddd016f12d85d011032 100644 (file)
@@ -1085,7 +1085,7 @@ namespace Step31
       stokes_constraints.clear ();
       DoFTools::make_hanging_node_constraints (stokes_dof_handler,
                                                stokes_constraints);
-      std::set<types::boundary_id_t> no_normal_flux_boundaries;
+      std::set<types::boundary_id> no_normal_flux_boundaries;
       no_normal_flux_boundaries.insert (0);
       VectorTools::compute_no_normal_flux_constraints (stokes_dof_handler, 0,
                                                        no_normal_flux_boundaries,
index c272df0437e56dc239134aad129dbca22ce60e85..a07419dc95915a52ff721f233f03e14f8833b535 100644 (file)
@@ -2554,7 +2554,7 @@ namespace Step32
                                                stokes_constraints,
                                                velocity_mask);
 
-      std::set<types::boundary_id_t> no_normal_flux_boundaries;
+      std::set<types::boundary_id> no_normal_flux_boundaries;
       no_normal_flux_boundaries.insert (1);
       VectorTools::compute_no_normal_flux_constraints (stokes_dof_handler, 0,
                                                        no_normal_flux_boundaries,
index bebc49be329156e7c2df0d21ce738c749e94c163..cd57ab99b77b8d93ef49a22c63a1597573243593 100644 (file)
@@ -433,7 +433,7 @@ namespace Step35
 
       EquationData::Velocity<dim>       vel_exact;
       std::map<unsigned int, double>    boundary_values;
-      std::vector<types::boundary_id_t> boundary_indicators;
+      std::vector<types::boundary_id> boundary_indicators;
 
       Triangulation<dim> triangulation;
 
@@ -1118,7 +1118,7 @@ namespace Step35
 
         vel_exact.set_component(d);
         boundary_values.clear();
-        for (std::vector<types::boundary_id_t>::const_iterator
+        for (std::vector<types::boundary_id>::const_iterator
                boundaries = boundary_indicators.begin();
              boundaries != boundary_indicators.end();
              ++boundaries)
index d05c3ec25830afae689c618c58d70b6e6a816fe3..b26b6b8db1ec2f97f1721090204c4fafc6df0897 100644 (file)
@@ -381,7 +381,7 @@ namespace Step38
       Triangulation<spacedim> volume_mesh;
       GridGenerator::half_hyper_ball(volume_mesh);
 
-      std::set<types::boundary_id_t> boundary_ids;
+      std::set<types::boundary_id> boundary_ids;
       boundary_ids.insert (0);
 
       GridTools::extract_boundary_mesh (volume_mesh, triangulation,
index a1d59a441811d3f40708afb3e728848e1760ffca..c0237b04f43537dba92eea39573d4f01f7cb9bed 100644 (file)
@@ -30,7 +30,7 @@ namespace types
                                     * See the @ref GlossSubdomainId
                                     * "glossary" for more information.
                                     */
-  typedef unsigned int subdomain_id_t;
+  typedef unsigned int subdomain_id;
 
                                    /**
                                     * A special id for an invalid
@@ -44,7 +44,7 @@ namespace types
                                     * See the @ref GlossSubdomainId
                                     * "glossary" for more information.
                                     */
-  const unsigned int invalid_subdomain_id = static_cast<subdomain_id_t>(-1);
+  const unsigned int invalid_subdomain_id = static_cast<subdomain_id>(-1);
 
                                    /**
                                     * The subdomain id assigned to a
@@ -63,7 +63,7 @@ namespace types
                                     * the @ref distributed module for
                                     * more information.
                                     */
-  const unsigned int artificial_subdomain_id = static_cast<subdomain_id_t>(-2);
+  const unsigned int artificial_subdomain_id = static_cast<subdomain_id>(-2);
 
                                    /**
                                     * The type used to denote global dof
@@ -82,25 +82,25 @@ namespace types
            * piece of the boundary and, in the case of meshes that describe
            * manifolds in higher dimensions, associated with every cell.
            */
-  typedef unsigned char boundary_id_t;
+  typedef unsigned char boundary_id;
 
           /**
            * The number which we reserve for internal faces.
            * We assume that all boundary_ids lie in the range [0, internal_face_boundary_id).
            */
-  const boundary_id_t internal_face_boundary_id = static_cast<boundary_id_t>(-1);
+  const boundary_id internal_face_boundary_id = static_cast<boundary_id>(-1);
 
           /**
            * The type used to denote material indicators associated with every
            * cell.
            */
-  typedef unsigned char material_id_t;
+  typedef unsigned char material_id;
 
           /**
            * Invalid material_id which we need in several places as a default value.
            * We assume that all material_ids lie in the range [0, invalid_material_id).
            */
-  const material_id_t invalid_material_id = static_cast<material_id_t>(-1);
+  const material_id invalid_material_id = static_cast<material_id>(-1);
 
 }
 
index 333216b6d35a23da48e637af144f74fc4fcb2902..e11b680be6cc4f7ad17bc23cba320399de4d6c3b 100644 (file)
@@ -356,7 +356,7 @@ namespace parallel
                                           * children that only exist
                                           * on other processors.
                                           */
-        types::subdomain_id_t locally_owned_subdomain () const;
+        types::subdomain_id locally_owned_subdomain () const;
 
                                          /**
                                           * Return the number of
@@ -575,7 +575,7 @@ namespace parallel
                                           * used for the current
                                           * processor.
                                           */
-        types::subdomain_id_t my_subdomain;
+        types::subdomain_id my_subdomain;
 
                                          /**
                                           * A flag that indicates whether the
@@ -813,7 +813,7 @@ namespace parallel
                                           * children that only exist
                                           * on other processors.
                                           */
-        types::subdomain_id_t locally_owned_subdomain () const;
+        types::subdomain_id locally_owned_subdomain () const;
 
                                          /**
                                           * Dummy arrays. This class
@@ -878,7 +878,7 @@ namespace parallel
                                           * children that only exist
                                           * on other processors.
                                           */
-        types::subdomain_id_t locally_owned_subdomain () const;
+        types::subdomain_id locally_owned_subdomain () const;
 
                                          /**
                                           * Return the MPI
index 86fd9cbbe04bfc78e634bb36ea987f5802a87ff6..b236cdea757acb5654cb529a106d4b77170a4dc8 100644 (file)
@@ -1073,7 +1073,7 @@ class DoFHandler  :  public Subscriptor
                                       * consideration.
                                       */
     unsigned int
-    n_boundary_dofs (const std::set<types::boundary_id_t> &boundary_indicators) const;
+    n_boundary_dofs (const std::set<types::boundary_id> &boundary_indicators) const;
 
                                      /**
                                       * Access to an object informing
@@ -1419,7 +1419,7 @@ class DoFHandler  :  public Subscriptor
 
 template <> unsigned int DoFHandler<1>::n_boundary_dofs () const;
 template <> unsigned int DoFHandler<1>::n_boundary_dofs (const FunctionMap &) const;
-template <> unsigned int DoFHandler<1>::n_boundary_dofs (const std::set<types::boundary_id_t> &) const;
+template <> unsigned int DoFHandler<1>::n_boundary_dofs (const std::set<types::boundary_id> &) const;
 
 
 /* ----------------------- Inline functions ---------------------------------- */
index af91c38a0fc20d9ccccab0e0359e331439f00d8b..22a9d90963ddc6e80939107d7b8dfdf1847dc8d7 100644 (file)
@@ -496,7 +496,7 @@ namespace DoFTools
                          SparsityPattern        &sparsity_pattern,
                          const ConstraintMatrix &constraints = ConstraintMatrix(),
                          const bool              keep_constrained_dofs = true,
-                         const types::subdomain_id_t subdomain_id = types::invalid_subdomain_id);
+                         const types::subdomain_id subdomain_id = types::invalid_subdomain_id);
 
                                    /**
                                     * Locate non-zero entries for
@@ -658,7 +658,7 @@ namespace DoFTools
                          SparsityPattern          &sparsity_pattern,
                          const ConstraintMatrix   &constraints = ConstraintMatrix(),
                          const bool                keep_constrained_dofs = true,
-                         const types::subdomain_id_t subdomain_id = types::invalid_subdomain_id);
+                         const types::subdomain_id subdomain_id = types::invalid_subdomain_id);
 
                                    /**
                                     * @deprecated This is the old
@@ -815,7 +815,7 @@ namespace DoFTools
                               SparsityPattern &sparsity_pattern,
                               const ConstraintMatrix   &constraints,
                               const bool                keep_constrained_dofs = true,
-                              const types::subdomain_id_t  subdomain_id = numbers::invalid_unsigned_int);
+                              const types::subdomain_id  subdomain_id = numbers::invalid_unsigned_int);
 
                                    /**
                                     * This function does the same as
@@ -1084,7 +1084,7 @@ namespace DoFTools
   template<typename DH>
   void
   make_periodicity_constraints (const DH                   &dof_handler,
-                                const types::boundary_id_t boundary_component,
+                                const types::boundary_id boundary_component,
                                 const int                  direction,
                                 dealii::ConstraintMatrix   &constraint_matrix,
                                 const std::vector<bool>    &component_mask = std::vector<bool>());
@@ -1104,7 +1104,7 @@ namespace DoFTools
   template<typename DH>
   void
   make_periodicity_constraints (const DH                       &dof_handler,
-                                const types::boundary_id_t     boundary_component,
+                                const types::boundary_id     boundary_component,
                                 const int                      direction,
                                 dealii::Tensor<1,DH::space_dimension>
                                                                &offset,
@@ -1335,7 +1335,7 @@ namespace DoFTools
   extract_boundary_dofs (const DH                   &dof_handler,
                          const std::vector<bool>    &component_mask,
                          std::vector<bool>          &selected_dofs,
-                         const std::set<types::boundary_id_t> &boundary_indicators = std::set<types::boundary_id_t>());
+                         const std::set<types::boundary_id> &boundary_indicators = std::set<types::boundary_id>());
 
   /**
    * This function does the same as the previous one but it
@@ -1371,7 +1371,7 @@ namespace DoFTools
   extract_boundary_dofs (const DH                   &dof_handler,
                          const std::vector<bool>    &component_mask,
                          IndexSet                    &selected_dofs,
-                         const std::set<types::boundary_id_t> &boundary_indicators = std::set<types::boundary_id_t>());
+                         const std::set<types::boundary_id> &boundary_indicators = std::set<types::boundary_id>());
 
                                    /**
                                     * This function is similar to
@@ -1408,7 +1408,7 @@ namespace DoFTools
   extract_dofs_with_support_on_boundary (const DH                   &dof_handler,
                                          const std::vector<bool>    &component_mask,
                                          std::vector<bool>          &selected_dofs,
-                                         const std::set<types::boundary_id_t> &boundary_indicators = std::set<types::boundary_id_t>());
+                                         const std::set<types::boundary_id> &boundary_indicators = std::set<types::boundary_id>());
 
                                    /**
                                     * @name Hanging Nodes
@@ -1458,7 +1458,7 @@ namespace DoFTools
   template <class DH>
   void
   extract_subdomain_dofs (const DH           &dof_handler,
-                          const types::subdomain_id_t subdomain_id,
+                          const types::subdomain_id subdomain_id,
                           std::vector<bool>  &selected_dofs);
 
 
@@ -1589,7 +1589,7 @@ namespace DoFTools
   template <class DH>
   void
   get_subdomain_association (const DH                  &dof_handler,
-                             std::vector<types::subdomain_id_t> &subdomain);
+                             std::vector<types::subdomain_id> &subdomain);
 
                                    /**
                                     * Count how many degrees of freedom are
@@ -1633,7 +1633,7 @@ namespace DoFTools
   template <class DH>
   unsigned int
   count_dofs_with_subdomain_association (const DH           &dof_handler,
-                                         const types::subdomain_id_t subdomain);
+                                         const types::subdomain_id subdomain);
 
                                    /**
                                     * Count how many degrees of freedom are
@@ -1670,7 +1670,7 @@ namespace DoFTools
   template <class DH>
   void
   count_dofs_with_subdomain_association (const DH           &dof_handler,
-                                         const types::subdomain_id_t subdomain,
+                                         const types::subdomain_id subdomain,
                                          std::vector<unsigned int> &n_dofs_on_subdomain);
 
                                    /**
@@ -1712,7 +1712,7 @@ namespace DoFTools
   template <class DH>
   IndexSet
   dof_indices_with_subdomain_association (const DH           &dof_handler,
-                                          const types::subdomain_id_t subdomain);
+                                          const types::subdomain_id subdomain);
 
                                    // @}
                                    /**
@@ -2419,7 +2419,7 @@ namespace DoFTools
   template <class DH>
   void
   map_dof_to_boundary_indices (const DH                      &dof_handler,
-                               const std::set<types::boundary_id_t> &boundary_indicators,
+                               const std::set<types::boundary_id> &boundary_indicators,
                                std::vector<unsigned int>     &mapping);
 
                                    /**
index da45ed52fc4a499f97a1a7654e2493f86bcc6050..40b3635e4fc3c4f835b1b364ec7879288b74239f 100644 (file)
@@ -48,7 +48,7 @@ struct FunctionMap
                                       * name it in the fashion of the
                                       * STL local typedefs.
                                       */
-    typedef std::map<types::boundary_id_t, const Function<dim>*> type;
+    typedef std::map<types::boundary_id, const Function<dim>*> type;
 };
 
 DEAL_II_NAMESPACE_CLOSE
index b776e92a4435024298a73f05025516f4f475fcc5..895c407bd0b6ab91ce1a08fb59b69d74796292b6 100644 (file)
@@ -169,7 +169,7 @@ namespace IteratorFilters
                                         * shall have to be evaluated
                                         * to true.
                                         */
-      SubdomainEqualTo (const types::subdomain_id_t subdomain_id);
+      SubdomainEqualTo (const types::subdomain_id subdomain_id);
 
                                        /**
                                         * Evaluation operator. Returns
@@ -187,7 +187,7 @@ namespace IteratorFilters
                                         * Stored value to compare the
                                         * subdomain with.
                                         */
-      const types::subdomain_id_t subdomain_id;
+      const types::subdomain_id subdomain_id;
   };
 
 
@@ -296,7 +296,7 @@ namespace IteratorFilters
  *   class SubdomainEqualTo
  *   {
  *     public:
- *       SubdomainEqualTo (const types::subdomain_id_t subdomain_id)
+ *       SubdomainEqualTo (const types::subdomain_id subdomain_id)
  *                   : subdomain_id (subdomain_id) {};
  *
  *       template <class Iterator>
@@ -305,7 +305,7 @@ namespace IteratorFilters
  *       }
  *
  *     private:
- *       const types::subdomain_id_t subdomain_id;
+ *       const types::subdomain_id subdomain_id;
  *   };
  * @endcode
  * Objects like <code>SubdomainEqualTo(3)</code> can then be used as predicates.
@@ -1124,7 +1124,7 @@ namespace IteratorFilters
 
 // ---------------- IteratorFilters::SubdomainEqualTo ---------
   inline
-  SubdomainEqualTo::SubdomainEqualTo (const types::subdomain_id_t subdomain_id)
+  SubdomainEqualTo::SubdomainEqualTo (const types::subdomain_id subdomain_id)
                   :
                   subdomain_id (subdomain_id)
   {}
index 500f5e86242cbc9898c765bd48be316d3233ca05..044daec67472e4c9bf3ed4d6e0ba8de6310428ca 100644 (file)
@@ -280,7 +280,7 @@ class GridGenerator
     subdivided_hyper_rectangle (Triangulation<dim>                       &tria,
                                 const std::vector< std::vector<double> > &spacing,
                                 const Point<dim>                         &p,
-                                const Table<dim,types::material_id_t>           &material_id,
+                                const Table<dim,types::material_id>           &material_id,
                                 const bool                               colorize=false);
 
                                      /**
index 31d9e344c3207bda1f0290a63e41ef1658ed6016..d001af2caa6b4c213db67c743b54dff87c178560 100644 (file)
@@ -575,7 +575,7 @@ namespace GridTools
   template <int dim, int spacedim>
   void
   get_subdomain_association (const Triangulation<dim, spacedim>  &triangulation,
-                             std::vector<types::subdomain_id_t> &subdomain);
+                             std::vector<types::subdomain_id> &subdomain);
 
                                    /**
                                     * Count how many cells are uniquely
@@ -602,7 +602,7 @@ namespace GridTools
   template <int dim, int spacedim>
   unsigned int
   count_cells_with_subdomain_association (const Triangulation<dim, spacedim> &triangulation,
-                                          const types::subdomain_id_t         subdomain);
+                                          const types::subdomain_id         subdomain);
 
                                    /**
                                     * Given two mesh containers
@@ -897,8 +897,8 @@ namespace GridTools
            typename Container<dim,spacedim>::face_iterator>
   extract_boundary_mesh (const Container<dim,spacedim> &volume_mesh,
                          Container<dim-1,spacedim>     &surface_mesh,
-                         const std::set<types::boundary_id_t> &boundary_ids
-                         = std::set<types::boundary_id_t>());
+                         const std::set<types::boundary_id> &boundary_ids
+                         = std::set<types::boundary_id>());
 
 
                                    /**
@@ -945,7 +945,7 @@ namespace GridTools
   std::map<CellIterator, CellIterator>
   collect_periodic_cell_pairs (const CellIterator                          &begin,
                                const typename identity<CellIterator>::type &end,
-                               const types::boundary_id_t                  boundary_component,
+                               const types::boundary_id                  boundary_component,
                                int                                         direction,
                                const dealii::Tensor<1,CellIterator::AccessorType::space_dimension>
                                  &offset = dealii::Tensor<1,CellIterator::AccessorType::space_dimension>());
@@ -962,7 +962,7 @@ namespace GridTools
   template<typename DH>
   std::map<typename DH::cell_iterator, typename DH::cell_iterator>
   collect_periodic_cell_pairs (const DH                   &dof_handler,
-                               const types::boundary_id_t boundary_component,
+                               const types::boundary_id boundary_component,
                                int                        direction,
                                const dealii::Tensor<1,DH::space_dimension>
                                  &offset = Tensor<1,DH::space_dimension>());
index b002eb13cbf26969abb661a6e4cba6fbd23473ce..39a678440c79afc69a20b4f1db53329f9ed6cd12 100644 (file)
@@ -110,8 +110,8 @@ struct CellData
                                       */
     union
     {
-        types::boundary_id_t boundary_id;
-        types::material_id_t material_id;
+        types::boundary_id boundary_id;
+        types::material_id material_id;
     };
 };
 
@@ -1805,7 +1805,7 @@ class Triangulation : public Subscriptor
                                       * boundary, for instance the material id
                                       * in a UCD input file. They are not
                                       * necessarily consecutive but must be in
-                                      * the range 0-(types::boundary_id_t-1).
+                                      * the range 0-(types::boundary_id-1).
                                       * Material IDs on boundaries are also
                                       * called boundary indicators and are
                                       * accessed with accessor functions
@@ -1834,7 +1834,7 @@ class Triangulation : public Subscriptor
                                      *
                                      * @ingroup boundary
                                       */
-    void set_boundary (const types::boundary_id_t   number,
+    void set_boundary (const types::boundary_id   number,
                        const Boundary<dim,spacedim> &boundary_object);
 
                                      /**
@@ -1848,7 +1848,7 @@ class Triangulation : public Subscriptor
                                      *
                                      * @ingroup boundary
                                       */
-    void set_boundary (const types::boundary_id_t number);
+    void set_boundary (const types::boundary_id number);
 
                                      /**
                                       * Return a constant reference to
@@ -1859,7 +1859,7 @@ class Triangulation : public Subscriptor
                                      *
                                      * @ingroup boundary
                                       */
-    const Boundary<dim,spacedim> & get_boundary (const types::boundary_id_t number) const;
+    const Boundary<dim,spacedim> & get_boundary (const types::boundary_id number) const;
 
                                      /**
                                       * Returns a vector containing
@@ -1876,7 +1876,7 @@ class Triangulation : public Subscriptor
                                      *
                                      * @ingroup boundary
                                       */
-    std::vector<types::boundary_id_t> get_boundary_indicators() const;
+    std::vector<types::boundary_id> get_boundary_indicators() const;
 
                                      /**
                                       *  Copy a triangulation. This
@@ -3505,7 +3505,7 @@ class Triangulation : public Subscriptor
                                       * of those cells that are owned
                                       * by the current processor.
                                       */
-    virtual types::subdomain_id_t locally_owned_subdomain () const;
+    virtual types::subdomain_id locally_owned_subdomain () const;
                                      /*@}*/
 
                                      /**
@@ -3765,7 +3765,7 @@ class Triangulation : public Subscriptor
                                       *  objects, which are not
                                       *  of type StraightBoundary.
                                       */
-    std::map<types::boundary_id_t, SmartPointer<const Boundary<dim, spacedim> , Triangulation<dim, spacedim> > >  boundary;
+    std::map<types::boundary_id, SmartPointer<const Boundary<dim, spacedim> , Triangulation<dim, spacedim> > >  boundary;
 
                                      /**
                                       * Flag indicating whether
@@ -3824,7 +3824,7 @@ class Triangulation : public Subscriptor
                                       * TriaAccessor::set_boundary_indicator)
                                       * were not a pointer.
                                       */
-    std::map<unsigned int, types::boundary_id_t> *vertex_to_boundary_id_map_1d;
+    std::map<unsigned int, types::boundary_id> *vertex_to_boundary_id_map_1d;
 
     /**
      * A map that correlates each refinement listener that has been added
index 25f0a3e24db4c9bd95b424be61c00a217f551820..d9a1a5a4a585821d32a503915abf38f2aad221e7 100644 (file)
@@ -1023,7 +1023,7 @@ class TriaAccessor : public TriaAccessorBase<structdim, dim, spacedim>
                                       * then this object is in the
                                       * interior of the domain.
                                       */
-    types::boundary_id_t boundary_indicator () const;
+    types::boundary_id boundary_indicator () const;
 
                                      /**
                                       * Set the boundary indicator.
@@ -1069,7 +1069,7 @@ class TriaAccessor : public TriaAccessorBase<structdim, dim, spacedim>
                                       *
                                       * @ingroup boundary
                                       */
-    void set_boundary_indicator (const types::boundary_id_t) const;
+    void set_boundary_indicator (const types::boundary_id) const;
 
                                      /**
                                       * Do as set_boundary_indicator()
@@ -1089,7 +1089,7 @@ class TriaAccessor : public TriaAccessorBase<structdim, dim, spacedim>
                                       *
                                       * @ingroup boundary
                                       */
-    void set_all_boundary_indicators (const types::boundary_id_t) const;
+    void set_all_boundary_indicators (const types::boundary_id) const;
 
                                      /**
                                       * Return whether this object is at the
@@ -1934,7 +1934,7 @@ class TriaAccessor<0, 1, spacedim>
                                       * then this object is in the
                                       * interior of the domain.
                                       */
-    types::boundary_id_t boundary_indicator () const;
+    types::boundary_id boundary_indicator () const;
 
                                      /**
                                       *  @name Orientation of sub-objects
@@ -2072,7 +2072,7 @@ class TriaAccessor<0, 1, spacedim>
                                       * @ingroup boundary
                                       */
     void
-    set_boundary_indicator (const types::boundary_id_t);
+    set_boundary_indicator (const types::boundary_id);
 
                                      /**
                                       * Since this object only represents a
@@ -2083,7 +2083,7 @@ class TriaAccessor<0, 1, spacedim>
                                       * @ingroup boundary
                                       */
     void
-    set_all_boundary_indicators (const types::boundary_id_t);
+    set_all_boundary_indicators (const types::boundary_id);
                                      /**
                                       * @}
                                       */
@@ -2621,7 +2621,7 @@ class CellAccessor :  public TriaAccessor<dim,dim,spacedim>
                                       * "glossary" for more
                                       * information.
                                       */
-    types::material_id_t material_id () const;
+    types::material_id material_id () const;
 
                                      /**
                                       * Set the material id of this
@@ -2635,7 +2635,7 @@ class CellAccessor :  public TriaAccessor<dim,dim,spacedim>
                                       * "glossary" for more
                                       * information.
                                       */
-    void set_material_id (const types::material_id_t new_material_id) const;
+    void set_material_id (const types::material_id new_material_id) const;
 
                                      /**
                                       * Set the material id of this
@@ -2647,7 +2647,7 @@ class CellAccessor :  public TriaAccessor<dim,dim,spacedim>
                                       * "glossary" for more
                                       * information.
                                       */
-    void recursively_set_material_id (const types::material_id_t new_material_id) const;
+    void recursively_set_material_id (const types::material_id new_material_id) const;
                                      /**
                                       * @}
                                       */
@@ -2671,7 +2671,7 @@ class CellAccessor :  public TriaAccessor<dim,dim,spacedim>
                                       * parallel::distributed::Triangulation
                                       * object.
                                       */
-    types::subdomain_id_t subdomain_id () const;
+    types::subdomain_id subdomain_id () const;
 
                                      /**
                                       * Set the subdomain id of this
@@ -2685,7 +2685,7 @@ class CellAccessor :  public TriaAccessor<dim,dim,spacedim>
                                       * parallel::distributed::Triangulation
                                       * object.
                                       */
-    void set_subdomain_id (const types::subdomain_id_t new_subdomain_id) const;
+    void set_subdomain_id (const types::subdomain_id new_subdomain_id) const;
 
                                      /**
                                       * Set the subdomain id of this
@@ -2701,7 +2701,7 @@ class CellAccessor :  public TriaAccessor<dim,dim,spacedim>
                                       * parallel::distributed::Triangulation
                                       * object.
                                       */
-    void recursively_set_subdomain_id (const types::subdomain_id_t new_subdomain_id) const;
+    void recursively_set_subdomain_id (const types::subdomain_id new_subdomain_id) const;
                                      /**
                                       * @}
                                       */
index e15a341ac36acf4fe389983de09be9c7dab01a93..47c48cb45b93e7424ea344f2a1b9471071d9c1c8 100644 (file)
@@ -1820,7 +1820,7 @@ TriaAccessor<structdim, dim, spacedim>::number_of_children () const
 
 
 template <int structdim, int dim, int spacedim>
-types::boundary_id_t
+types::boundary_id
 TriaAccessor<structdim, dim, spacedim>::boundary_indicator () const
 {
   Assert (structdim<dim, ExcImpossibleInDim(dim));
@@ -1834,7 +1834,7 @@ TriaAccessor<structdim, dim, spacedim>::boundary_indicator () const
 template <int structdim, int dim, int spacedim>
 void
 TriaAccessor<structdim, dim, spacedim>::
-set_boundary_indicator (const types::boundary_id_t boundary_ind) const
+set_boundary_indicator (const types::boundary_id boundary_ind) const
 {
   Assert (structdim<dim, ExcImpossibleInDim(dim));
   Assert (this->used(), TriaAccessorExceptions::ExcCellNotUsed());
@@ -1847,7 +1847,7 @@ set_boundary_indicator (const types::boundary_id_t boundary_ind) const
 template <int structdim, int dim, int spacedim>
 void
 TriaAccessor<structdim, dim, spacedim>::
-set_all_boundary_indicators (const types::boundary_id_t boundary_ind) const
+set_all_boundary_indicators (const types::boundary_id boundary_ind) const
 {
   set_boundary_indicator (boundary_ind);
 
@@ -2236,7 +2236,7 @@ TriaAccessor<0, 1, spacedim>::at_boundary () const
 
 template <int spacedim>
 inline
-types::boundary_id_t
+types::boundary_id
 TriaAccessor<0, 1, spacedim>::boundary_indicator () const
 {
   switch (vertex_kind)
@@ -2373,7 +2373,7 @@ int TriaAccessor<0, 1, spacedim>::isotropic_child_index (const unsigned int)
 template <int spacedim>
 inline
 void
-TriaAccessor<0, 1, spacedim>::set_boundary_indicator (const types::boundary_id_t b)
+TriaAccessor<0, 1, spacedim>::set_boundary_indicator (const types::boundary_id b)
 {
   Assert (tria->vertex_to_boundary_id_map_1d->find (this->vertex_index())
           != tria->vertex_to_boundary_id_map_1d->end(),
@@ -2386,7 +2386,7 @@ TriaAccessor<0, 1, spacedim>::set_boundary_indicator (const types::boundary_id_t
 
 template <int spacedim>
 inline
-void TriaAccessor<0, 1, spacedim>::set_all_boundary_indicators (const types::boundary_id_t b)
+void TriaAccessor<0, 1, spacedim>::set_all_boundary_indicators (const types::boundary_id b)
 {
   set_boundary_indicator (b);
 }
@@ -2856,7 +2856,7 @@ CellAccessor<dim,spacedim>::is_locally_owned () const
 #ifndef DEAL_II_USE_P4EST
   return true;
 #else
-  const types::subdomain_id_t subdomain = this->subdomain_id();
+  const types::subdomain_id subdomain = this->subdomain_id();
   if (subdomain == types::artificial_subdomain_id)
     return false;
 
@@ -2879,7 +2879,7 @@ CellAccessor<dim,spacedim>::is_ghost () const
 #ifndef DEAL_II_USE_P4EST
   return false;
 #else
-  const types::subdomain_id_t subdomain = this->subdomain_id();
+  const types::subdomain_id subdomain = this->subdomain_id();
   if (subdomain == types::artificial_subdomain_id)
     return false;
 
index 37b0bac873192cb7b3333deeb22f4fa1a8e29509..24bf5a87a72431ace226f2ef2e48083d2f4d62a7 100644 (file)
@@ -138,7 +138,7 @@ namespace internal
                                           * cells with a given subdomain
                                           * number.
                                           */
-        std::vector<types::subdomain_id_t> subdomain_ids;
+        std::vector<types::subdomain_id> subdomain_ids;
 
                                          /**
                                           * One integer for every consecutive
@@ -242,7 +242,7 @@ namespace internal
         std::vector<unsigned char> refine_flags;
         std::vector<bool> coarsen_flags;
         std::vector<std::pair<int,int> > neighbors;
-        std::vector<types::subdomain_id_t> subdomain_ids;
+        std::vector<types::subdomain_id> subdomain_ids;
         std::vector<int> parents;
 
                                          // The following is not used
index 23d6bda87f4e67a4f68d3e775fa384d73d5e662f..73d369e317f39e06c958e8ea96d0547355266550 100644 (file)
@@ -141,8 +141,8 @@ namespace internal
         {
             union
             {
-                types::boundary_id_t boundary_id;
-                types::material_id_t material_id;
+                types::boundary_id boundary_id;
+                types::material_id material_id;
             };
 
 
index c157bc3a1c92522658888fbc771a92e188b05257..c15ffc2a426757e213463c92ec5f89262453b97b 100644 (file)
@@ -863,7 +863,7 @@ namespace hp
                                         * consideration.
                                         */
       unsigned int
-      n_boundary_dofs (const std::set<types::boundary_id_t> &boundary_indicators) const;
+      n_boundary_dofs (const std::set<types::boundary_id> &boundary_indicators) const;
 
                                        /**
                                         * Return the number of
index ba847adb88644faa77d7094aded247a4e6e310b1..adfec866bbdc588a6a8d96ccfb29e4b6d0143a2b 100644 (file)
@@ -348,8 +348,8 @@ class KellyErrorEstimator
                           const std::vector<bool> &component_mask = std::vector<bool>(),
                           const Function<spacedim>     *coefficients   = 0,
                           const unsigned int       n_threads = numbers::invalid_unsigned_int,
-                          const types::subdomain_id_t subdomain_id = types::invalid_subdomain_id,
-                          const types::material_id_t       material_id = types::invalid_material_id);
+                          const types::subdomain_id subdomain_id = types::invalid_subdomain_id,
+                          const types::material_id       material_id = types::invalid_material_id);
 
                                      /**
                                       * Calls the @p estimate
@@ -365,8 +365,8 @@ class KellyErrorEstimator
                           const std::vector<bool> &component_mask = std::vector<bool>(),
                           const Function<spacedim>     *coefficients   = 0,
                           const unsigned int       n_threads = multithread_info.n_default_threads,
-                          const types::subdomain_id_t subdomain_id = types::invalid_subdomain_id,
-                          const types::material_id_t       material_id = types::invalid_material_id);
+                          const types::subdomain_id subdomain_id = types::invalid_subdomain_id,
+                          const types::material_id       material_id = types::invalid_material_id);
 
                                      /**
                                       * Same function as above, but
@@ -405,8 +405,8 @@ class KellyErrorEstimator
                           const std::vector<bool>     &component_mask = std::vector<bool>(),
                           const Function<spacedim>         *coefficients   = 0,
                           const unsigned int           n_threads = multithread_info.n_default_threads,
-                          const types::subdomain_id_t subdomain_id = types::invalid_subdomain_id,
-                          const types::material_id_t           material_id = types::invalid_material_id);
+                          const types::subdomain_id subdomain_id = types::invalid_subdomain_id,
+                          const types::material_id           material_id = types::invalid_material_id);
 
                                      /**
                                       * Calls the @p estimate
@@ -422,8 +422,8 @@ class KellyErrorEstimator
                           const std::vector<bool>     &component_mask = std::vector<bool>(),
                           const Function<spacedim>         *coefficients   = 0,
                           const unsigned int           n_threads = multithread_info.n_default_threads,
-                          const types::subdomain_id_t subdomain_id = types::invalid_subdomain_id,
-                          const types::material_id_t          material_id = types::invalid_material_id);
+                          const types::subdomain_id subdomain_id = types::invalid_subdomain_id,
+                          const types::material_id          material_id = types::invalid_material_id);
 
 
                                      /**
@@ -442,8 +442,8 @@ class KellyErrorEstimator
                           const std::vector<bool> &component_mask = std::vector<bool>(),
                           const Function<spacedim>     *coefficients   = 0,
                           const unsigned int       n_threads = multithread_info.n_default_threads,
-                          const types::subdomain_id_t subdomain_id = types::invalid_subdomain_id,
-                          const types::material_id_t       material_id = types::invalid_material_id);
+                          const types::subdomain_id subdomain_id = types::invalid_subdomain_id,
+                          const types::material_id       material_id = types::invalid_material_id);
 
 
                                      /**
@@ -461,8 +461,8 @@ class KellyErrorEstimator
                           const std::vector<bool> &component_mask = std::vector<bool>(),
                           const Function<spacedim>     *coefficients   = 0,
                           const unsigned int       n_threads = multithread_info.n_default_threads,
-                          const types::subdomain_id_t subdomain_id = types::invalid_subdomain_id,
-                          const types::material_id_t       material_id = types::invalid_material_id);
+                          const types::subdomain_id subdomain_id = types::invalid_subdomain_id,
+                          const types::material_id       material_id = types::invalid_material_id);
 
 
                                      /**
@@ -481,8 +481,8 @@ class KellyErrorEstimator
                           const std::vector<bool>     &component_mask = std::vector<bool>(),
                           const Function<spacedim>         *coefficients   = 0,
                           const unsigned int           n_threads = multithread_info.n_default_threads,
-                          const types::subdomain_id_t subdomain_id = types::invalid_subdomain_id,
-                          const types::material_id_t           material_id = types::invalid_material_id);
+                          const types::subdomain_id subdomain_id = types::invalid_subdomain_id,
+                          const types::material_id           material_id = types::invalid_material_id);
 
 
                                      /**
@@ -500,8 +500,8 @@ class KellyErrorEstimator
                           const std::vector<bool>     &component_mask = std::vector<bool>(),
                           const Function<spacedim>*    coefficients   = 0,
                           const unsigned int           n_threads = multithread_info.n_default_threads,
-                          const types::subdomain_id_t subdomain_id = types::invalid_subdomain_id,
-                          const types::material_id_t           material_id = types::invalid_material_id);
+                          const types::subdomain_id subdomain_id = types::invalid_subdomain_id,
+                          const types::material_id           material_id = types::invalid_material_id);
 
 
                                      /**
@@ -611,8 +611,8 @@ class KellyErrorEstimator<1,spacedim>
                           const std::vector<bool> &component_mask = std::vector<bool>(),
                           const Function<spacedim>     *coefficients   = 0,
                           const unsigned int       n_threads = multithread_info.n_default_threads,
-                          const types::subdomain_id_t subdomain_id = types::invalid_subdomain_id,
-                          const types::material_id_t       material_id = types::invalid_material_id);
+                          const types::subdomain_id subdomain_id = types::invalid_subdomain_id,
+                          const types::material_id       material_id = types::invalid_material_id);
 
                                      /**
                                       * Calls the @p estimate
@@ -628,8 +628,8 @@ class KellyErrorEstimator<1,spacedim>
                           const std::vector<bool> &component_mask = std::vector<bool>(),
                           const Function<spacedim>     *coefficients   = 0,
                           const unsigned int       n_threads = multithread_info.n_default_threads,
-                          const types::subdomain_id_t subdomain_id = types::invalid_subdomain_id,
-                          const types::material_id_t       material_id = types::invalid_material_id);
+                          const types::subdomain_id subdomain_id = types::invalid_subdomain_id,
+                          const types::material_id       material_id = types::invalid_material_id);
 
                                      /**
                                       * Same function as above, but
@@ -668,8 +668,8 @@ class KellyErrorEstimator<1,spacedim>
                           const std::vector<bool>     &component_mask = std::vector<bool>(),
                           const Function<spacedim>         *coefficients   = 0,
                           const unsigned int           n_threads = multithread_info.n_default_threads,
-                          const types::subdomain_id_t subdomain_id = types::invalid_subdomain_id,
-                          const types::material_id_t           material_id = types::invalid_material_id);
+                          const types::subdomain_id subdomain_id = types::invalid_subdomain_id,
+                          const types::material_id           material_id = types::invalid_material_id);
 
                                      /**
                                       * Calls the @p estimate
@@ -685,8 +685,8 @@ class KellyErrorEstimator<1,spacedim>
                           const std::vector<bool>     &component_mask = std::vector<bool>(),
                           const Function<spacedim>         *coefficients   = 0,
                           const unsigned int           n_threads = multithread_info.n_default_threads,
-                          const types::subdomain_id_t subdomain_id = types::invalid_subdomain_id,
-                          const types::material_id_t           material_id = types::invalid_material_id);
+                          const types::subdomain_id subdomain_id = types::invalid_subdomain_id,
+                          const types::material_id           material_id = types::invalid_material_id);
 
 
                                      /**
@@ -705,8 +705,8 @@ class KellyErrorEstimator<1,spacedim>
                           const std::vector<bool> &component_mask = std::vector<bool>(),
                           const Function<spacedim>     *coefficients   = 0,
                           const unsigned int       n_threads = multithread_info.n_default_threads,
-                          const types::subdomain_id_t subdomain_id = types::invalid_subdomain_id,
-                          const types::material_id_t       material_id = types::invalid_material_id);
+                          const types::subdomain_id subdomain_id = types::invalid_subdomain_id,
+                          const types::material_id       material_id = types::invalid_material_id);
 
 
                                      /**
@@ -724,8 +724,8 @@ class KellyErrorEstimator<1,spacedim>
                           const std::vector<bool> &component_mask = std::vector<bool>(),
                           const Function<spacedim>     *coefficients   = 0,
                           const unsigned int       n_threads = multithread_info.n_default_threads,
-                          const types::subdomain_id_t subdomain_id = types::invalid_subdomain_id,
-                          const types::material_id_t       material_id = types::invalid_material_id);
+                          const types::subdomain_id subdomain_id = types::invalid_subdomain_id,
+                          const types::material_id       material_id = types::invalid_material_id);
 
 
                                      /**
@@ -744,8 +744,8 @@ class KellyErrorEstimator<1,spacedim>
                           const std::vector<bool>     &component_mask = std::vector<bool>(),
                           const Function<spacedim>         *coefficients   = 0,
                           const unsigned int           n_threads = multithread_info.n_default_threads,
-                          const types::subdomain_id_t subdomain_id = types::invalid_subdomain_id,
-                          const types::material_id_t           material_id = types::invalid_material_id);
+                          const types::subdomain_id subdomain_id = types::invalid_subdomain_id,
+                          const types::material_id           material_id = types::invalid_material_id);
 
 
                                      /**
@@ -763,8 +763,8 @@ class KellyErrorEstimator<1,spacedim>
                           const std::vector<bool>     &component_mask = std::vector<bool>(),
                           const Function<spacedim>         *coefficients   = 0,
                           const unsigned int           n_threads = multithread_info.n_default_threads,
-                          const types::subdomain_id_t subdomain_id = types::invalid_subdomain_id,
-                          const types::material_id_t           material_id = types::invalid_material_id);
+                          const types::subdomain_id subdomain_id = types::invalid_subdomain_id,
+                          const types::material_id           material_id = types::invalid_material_id);
 
                                      /**
                                       * Exception
index f950e14db951e9fc61d77befc4211d17909345e8..f6a1387560ce0487deb6e9a6a955923f61beed3e 100644 (file)
@@ -194,7 +194,7 @@ class ConstraintMatrix;
  *   of boundary nodes and their values. You can get such a list by interpolation
  *   of a boundary function using the interpolate_boundary_values() function.
  *   To use it, you have to
- *   specify a list of pairs of boundary indicators (of type <tt>types::boundary_id_t</tt>;
+ *   specify a list of pairs of boundary indicators (of type <tt>types::boundary_id</tt>;
  *   see the section in the documentation of the Triangulation class for more
  *   details) and the according functions denoting the dirichlet boundary values
  *   of the nodes on boundary faces with this boundary indicator.
@@ -767,7 +767,7 @@ namespace VectorTools
   void
   interpolate_boundary_values (const Mapping<DH::dimension,DH::space_dimension>            &mapping,
                                const DH                 &dof,
-                               const types::boundary_id_t            boundary_component,
+                               const types::boundary_id            boundary_component,
                                const Function<DH::space_dimension>           &boundary_function,
                                std::map<unsigned int,double> &boundary_values,
                                const std::vector<bool>       &component_mask = std::vector<bool>());
@@ -781,7 +781,7 @@ namespace VectorTools
   template <class DH>
   void
   interpolate_boundary_values (const DH        &dof,
-                               const types::boundary_id_t            boundary_component,
+                               const types::boundary_id            boundary_component,
                                const Function<DH::space_dimension>           &boundary_function,
                                std::map<unsigned int,double> &boundary_values,
                                const std::vector<bool>       &component_mask = std::vector<bool>());
@@ -908,7 +908,7 @@ namespace VectorTools
   void
   interpolate_boundary_values (const Mapping<DH::dimension,DH::space_dimension> &mapping,
                                const DH                            &dof,
-                               const types::boundary_id_t                  boundary_component,
+                               const types::boundary_id                  boundary_component,
                                const Function<DH::space_dimension> &boundary_function,
                                ConstraintMatrix                    &constraints,
                                const std::vector<bool>             &component_mask = std::vector<bool>());
@@ -924,7 +924,7 @@ namespace VectorTools
   template <class DH>
   void
   interpolate_boundary_values (const DH                            &dof,
-                               const types::boundary_id_t                  boundary_component,
+                               const types::boundary_id                  boundary_component,
                                const Function<DH::space_dimension> &boundary_function,
                                ConstraintMatrix                    &constraints,
                                const std::vector<bool>             &component_mask = std::vector<bool>());
@@ -1179,7 +1179,7 @@ namespace VectorTools
   void project_boundary_values_curl_conforming (const DoFHandler<dim>& dof_handler,
                                                 const unsigned int first_vector_component,
                                                 const Function<dim>& boundary_function,
-                                                const types::boundary_id_t boundary_component,
+                                                const types::boundary_id boundary_component,
                                                 ConstraintMatrix& constraints,
                                                 const Mapping<dim>& mapping = StaticMappingQ1<dim>::mapping);
 
@@ -1192,7 +1192,7 @@ namespace VectorTools
   void project_boundary_values_curl_conforming (const hp::DoFHandler<dim>& dof_handler,
                                                 const unsigned int first_vector_component,
                                                 const Function<dim>& boundary_function,
-                                                const types::boundary_id_t boundary_component,
+                                                const types::boundary_id boundary_component,
                                                 ConstraintMatrix& constraints,
                                                 const hp::MappingCollection<dim, dim>& mapping_collection = hp::StaticMappingQ1<dim>::mapping_collection);
 
@@ -1265,7 +1265,7 @@ namespace VectorTools
   void project_boundary_values_div_conforming (const DoFHandler<dim>& dof_handler,
                                                const unsigned int first_vector_component,
                                                const Function<dim>& boundary_function,
-                                               const types::boundary_id_t boundary_component,
+                                               const types::boundary_id boundary_component,
                                                ConstraintMatrix& constraints,
                                                const Mapping<dim>& mapping = StaticMappingQ1<dim>::mapping);
 
@@ -1278,7 +1278,7 @@ namespace VectorTools
   void project_boundary_values_div_conforming (const hp::DoFHandler<dim>& dof_handler,
                                                const unsigned int first_vector_component,
                                                const Function<dim>& boundary_function,
-                                               const types::boundary_id_t boundary_component,
+                                               const types::boundary_id boundary_component,
                                                ConstraintMatrix& constraints,
                                                const hp::MappingCollection<dim, dim>& mapping_collection = hp::StaticMappingQ1<dim>::mapping_collection);
 
@@ -1603,7 +1603,7 @@ namespace VectorTools
   void
   compute_no_normal_flux_constraints (const DH<dim,spacedim>         &dof_handler,
                                       const unsigned int     first_vector_component,
-                                      const std::set<types::boundary_id_t> &boundary_ids,
+                                      const std::set<types::boundary_id> &boundary_ids,
                                       ConstraintMatrix      &constraints,
                                       const Mapping<dim, spacedim>    &mapping = StaticMappingQ1<dim>::mapping);
 
@@ -1786,7 +1786,7 @@ namespace VectorTools
                                         const Quadrature<dim-1> &q,
                                         const Function<spacedim>     &rhs,
                                         Vector<double>          &rhs_vector,
-                                        const std::set<types::boundary_id_t> &boundary_indicators = std::set<types::boundary_id_t>());
+                                        const std::set<types::boundary_id> &boundary_indicators = std::set<types::boundary_id>());
 
                                    /**
                                     * Calls the
@@ -1799,7 +1799,7 @@ namespace VectorTools
                                         const Quadrature<dim-1> &q,
                                         const Function<spacedim>     &rhs,
                                         Vector<double>          &rhs_vector,
-                                        const std::set<types::boundary_id_t> &boundary_indicators = std::set<types::boundary_id_t>());
+                                        const std::set<types::boundary_id> &boundary_indicators = std::set<types::boundary_id>());
 
                                    /**
                                     * Same as the set of functions above,
@@ -1811,7 +1811,7 @@ namespace VectorTools
                                         const hp::QCollection<dim-1> &q,
                                         const Function<spacedim>     &rhs,
                                         Vector<double>          &rhs_vector,
-                                        const std::set<types::boundary_id_t> &boundary_indicators = std::set<types::boundary_id_t>());
+                                        const std::set<types::boundary_id> &boundary_indicators = std::set<types::boundary_id>());
 
                                    /**
                                     * Calls the
@@ -1828,7 +1828,7 @@ namespace VectorTools
                                         const hp::QCollection<dim-1> &q,
                                         const Function<spacedim>     &rhs,
                                         Vector<double>          &rhs_vector,
-                                        const std::set<types::boundary_id_t> &boundary_indicators = std::set<types::boundary_id_t>());
+                                        const std::set<types::boundary_id> &boundary_indicators = std::set<types::boundary_id>());
 
                                    //@}
                                    /**
index 673e069acc716b07d73ae9632cd0f9fa56acb4fc..2df4c30f05ff8302998d7219d82f3be636275f1f 100644 (file)
@@ -571,7 +571,7 @@ namespace VectorTools
                                            // function to hold on
                                            // all parts of the boundary
           typename FunctionMap<spacedim>::type boundary_functions;
-          for (types::boundary_id_t c=0; c<types::internal_face_boundary_id; ++c)
+          for (types::boundary_id c=0; c<types::internal_face_boundary_id; ++c)
             boundary_functions[c] = &function;
           project_boundary_values (dof, boundary_functions, q_boundary,
                                    boundary_values);
@@ -1117,7 +1117,7 @@ namespace VectorTools
                                    const Quadrature<0>   &,
                                    const Function<1>     &,
                                    Vector<double>        &,
-                                   const std::set<types::boundary_id_t> &)
+                                   const std::set<types::boundary_id> &)
   {
     Assert (false, ExcImpossibleInDim(1));
   }
@@ -1131,7 +1131,7 @@ namespace VectorTools
                                    const Quadrature<0>   &,
                                    const Function<2>     &,
                                    Vector<double>        &,
-                                   const std::set<types::boundary_id_t> &)
+                                   const std::set<types::boundary_id> &)
   {
     Assert (false, ExcImpossibleInDim(1));
   }
@@ -1145,7 +1145,7 @@ namespace VectorTools
                                    const Quadrature<dim-1> &quadrature,
                                    const Function<spacedim>     &rhs_function,
                                    Vector<double>          &rhs_vector,
-                                   const std::set<types::boundary_id_t> &boundary_indicators)
+                                   const std::set<types::boundary_id> &boundary_indicators)
   {
     const FiniteElement<dim> &fe  = dof_handler.get_fe();
     Assert (fe.n_components() == rhs_function.n_components,
@@ -1267,7 +1267,7 @@ namespace VectorTools
                                    const Quadrature<dim-1> &quadrature,
                                    const Function<spacedim>     &rhs_function,
                                    Vector<double>          &rhs_vector,
-                                   const std::set<types::boundary_id_t> &boundary_indicators)
+                                   const std::set<types::boundary_id> &boundary_indicators)
   {
     Assert (DEAL_II_COMPAT_MAPPING, ExcCompatibility("mapping"));
 
@@ -1288,7 +1288,7 @@ namespace VectorTools
                                    const hp::QCollection<0> &,
                                    const Function<1>     &,
                                    Vector<double>          &,
-                                   const std::set<types::boundary_id_t> &)
+                                   const std::set<types::boundary_id> &)
   {
     Assert (false, ExcImpossibleInDim(1));
   }
@@ -1302,7 +1302,7 @@ namespace VectorTools
                                    const hp::QCollection<0> &,
                                    const Function<2>     &,
                                    Vector<double>          &,
-                                   const std::set<types::boundary_id_t> &)
+                                   const std::set<types::boundary_id> &)
   {
     Assert (false, ExcImpossibleInDim(1));
   }
@@ -1316,7 +1316,7 @@ namespace VectorTools
                                    const hp::QCollection<dim-1>  &quadrature,
                                    const Function<spacedim>      &rhs_function,
                                    Vector<double>                &rhs_vector,
-                                   const std::set<types::boundary_id_t> &boundary_indicators)
+                                   const std::set<types::boundary_id> &boundary_indicators)
   {
     const hp::FECollection<dim> &fe  = dof_handler.get_fe();
     Assert (fe.n_components() == rhs_function.n_components,
@@ -1450,7 +1450,7 @@ namespace VectorTools
                                    const hp::QCollection<dim-1>  &quadrature,
                                    const Function<spacedim>      &rhs_function,
                                    Vector<double>                &rhs_vector,
-                                   const std::set<types::boundary_id_t> &boundary_indicators)
+                                   const std::set<types::boundary_id> &boundary_indicators)
   {
     Assert (DEAL_II_COMPAT_MAPPING, ExcCompatibility("mapping"));
     create_boundary_right_hand_side(hp::StaticMappingQ1<dim>::mapping_collection,
@@ -1742,7 +1742,7 @@ namespace VectorTools
                 }
 
               const typename DH::face_iterator face = cell->face(face_no);
-              const types::boundary_id_t boundary_component = face->boundary_indicator();
+              const types::boundary_id boundary_component = face->boundary_indicator();
 
                                               // see if this face is
                                               // part of the
@@ -1942,7 +1942,7 @@ namespace VectorTools
   void
   interpolate_boundary_values (const Mapping<DH::dimension, DH::space_dimension>            &mapping,
                                const DH                 &dof,
-                               const types::boundary_id_t            boundary_component,
+                               const types::boundary_id            boundary_component,
                                const Function<DH::space_dimension>           &boundary_function,
                                std::map<unsigned int,double> &boundary_values,
                                const std::vector<bool>       &component_mask)
@@ -1958,7 +1958,7 @@ namespace VectorTools
   template <class DH>
   void
   interpolate_boundary_values (const DH                 &dof,
-                               const types::boundary_id_t            boundary_component,
+                               const types::boundary_id            boundary_component,
                                const Function<DH::space_dimension>           &boundary_function,
                                std::map<unsigned int,double> &boundary_values,
                                const std::vector<bool>       &component_mask)
@@ -2025,7 +2025,7 @@ namespace VectorTools
   interpolate_boundary_values
   (const Mapping<DH::dimension, DH::space_dimension> &mapping,
    const DH                                          &dof,
-   const types::boundary_id_t                                boundary_component,
+   const types::boundary_id                                boundary_component,
    const Function<DH::space_dimension>               &boundary_function,
    ConstraintMatrix                                  &constraints,
    const std::vector<bool>                           &component_mask)
@@ -2042,7 +2042,7 @@ namespace VectorTools
   void
   interpolate_boundary_values
   (const DH                            &dof,
-   const types::boundary_id_t                  boundary_component,
+   const types::boundary_id                  boundary_component,
    const Function<DH::space_dimension> &boundary_function,
    ConstraintMatrix                    &constraints,
    const std::vector<bool>             &component_mask)
@@ -2142,7 +2142,7 @@ namespace VectorTools
       AssertDimension (dof.get_fe().n_components(), component_mapping.size());
 
     std::vector<unsigned int> dof_to_boundary_mapping;
-    std::set<types::boundary_id_t> selected_boundary_components;
+    std::set<types::boundary_id> selected_boundary_components;
     for (typename FunctionMap<spacedim>::type::const_iterator i=boundary_functions.begin();
          i!=boundary_functions.end(); ++i)
       selected_boundary_components.insert (i->first);
@@ -3232,7 +3232,7 @@ namespace VectorTools
   project_boundary_values_curl_conforming (const DoFHandler<dim>& dof_handler,
                                            const unsigned int first_vector_component,
                                            const Function<dim>& boundary_function,
-                                           const types::boundary_id_t boundary_component,
+                                           const types::boundary_id boundary_component,
                                            ConstraintMatrix& constraints,
                                            const Mapping<dim>& mapping)
   {
@@ -3524,7 +3524,7 @@ namespace VectorTools
   project_boundary_values_curl_conforming (const hp::DoFHandler<dim>& dof_handler,
                                            const unsigned int first_vector_component,
                                            const Function<dim>& boundary_function,
-                                           const types::boundary_id_t boundary_component,
+                                           const types::boundary_id boundary_component,
                                            ConstraintMatrix& constraints,
                                            const hp::MappingCollection<dim>& mapping_collection)
   {
@@ -3943,7 +3943,7 @@ namespace VectorTools
   project_boundary_values_div_conforming (const DoFHandler<dim>& dof_handler,
                                           const unsigned int first_vector_component,
                                           const Function<dim>& boundary_function,
-                                          const types::boundary_id_t boundary_component,
+                                          const types::boundary_id boundary_component,
                                           ConstraintMatrix& constraints,
                                           const Mapping<dim>& mapping)
   {
@@ -4109,7 +4109,7 @@ namespace VectorTools
   project_boundary_values_div_conforming (const hp::DoFHandler<dim>& dof_handler,
                                           const unsigned int first_vector_component,
                                           const Function<dim>& boundary_function,
-                                          const types::boundary_id_t boundary_component,
+                                          const types::boundary_id boundary_component,
                                           ConstraintMatrix& constraints,
                                           const hp::MappingCollection<dim, dim>& mapping_collection)
   {
@@ -4246,7 +4246,7 @@ namespace VectorTools
   void
   compute_no_normal_flux_constraints (const DH<dim,spacedim>         &dof_handler,
                                       const unsigned int     first_vector_component,
-                                      const std::set<types::boundary_id_t> &boundary_ids,
+                                      const std::set<types::boundary_id> &boundary_ids,
                                       ConstraintMatrix      &constraints,
                                       const Mapping<dim, spacedim>    &mapping)
   {
index 9499c5548fefbd65b1f7e6df8aab93e4e668aeb7..e025665818c3256f8a525cce5e267ceabc1a07ef 100644 (file)
@@ -962,7 +962,7 @@ namespace
                           const typename Triangulation<dim,spacedim>::cell_iterator     &dealii_cell,
                           const typename internal::p4est::types<dim>::quadrant &p4est_cell,
                           const typename internal::p4est::types<dim>::forest   &forest,
-                          const types::subdomain_id_t                           my_subdomain)
+                          const types::subdomain_id                           my_subdomain)
   {
                                      // check if this cell exists in
                                      // the local p4est cell
@@ -1394,7 +1394,7 @@ namespace
     public:
       RefineAndCoarsenList (const Triangulation<dim,spacedim> &triangulation,
                             const std::vector<unsigned int> &p4est_tree_to_coarse_cell_permutation,
-                            const types::subdomain_id_t                   my_subdomain,
+                            const types::subdomain_id                   my_subdomain,
                             typename internal::p4est::types<dim>::forest &forest);
 
                                        /**
@@ -1468,7 +1468,7 @@ namespace
   RefineAndCoarsenList<dim,spacedim>::
   RefineAndCoarsenList (const Triangulation<dim,spacedim>            &triangulation,
                         const std::vector<unsigned int> &p4est_tree_to_coarse_cell_permutation,
-                        const types::subdomain_id_t                   my_subdomain,
+                        const types::subdomain_id                   my_subdomain,
                         typename internal::p4est::types<dim>::forest &forest)
                   :
                   forest(forest)
@@ -1554,7 +1554,7 @@ namespace
   RefineAndCoarsenList<dim,spacedim>::
   build_lists (const typename Triangulation<dim,spacedim>::cell_iterator     &cell,
                const typename internal::p4est::types<dim>::quadrant &p4est_cell,
-               const types::subdomain_id_t my_subdomain)
+               const types::subdomain_id my_subdomain)
   {
     if (!cell->has_children())
       {
@@ -2821,7 +2821,7 @@ namespace parallel
 
 
     template <int dim, int spacedim>
-    types::subdomain_id_t
+    types::subdomain_id
     Triangulation<dim,spacedim>::locally_owned_subdomain () const
     {
       Assert (dim > 1, ExcNotImplemented());
@@ -3082,7 +3082,7 @@ namespace parallel
 
 
     template <>
-    types::subdomain_id_t
+    types::subdomain_id
     Triangulation<1,1>::locally_owned_subdomain () const
     {
       Assert (false, ExcNotImplemented());
@@ -3131,7 +3131,7 @@ namespace parallel
 
 
     template <>
-    types::subdomain_id_t
+    types::subdomain_id
     Triangulation<1,2>::locally_owned_subdomain () const
     {
       Assert (false, ExcNotImplemented());
@@ -3172,7 +3172,7 @@ namespace parallel
 
 
     template <>
-    types::subdomain_id_t
+    types::subdomain_id
     Triangulation<1,3>::locally_owned_subdomain () const
     {
       Assert (false, ExcNotImplemented());
@@ -3221,7 +3221,7 @@ namespace parallel
 
 
     template <int dim, int spacedim>
-    types::subdomain_id_t
+    types::subdomain_id
     Triangulation<dim,spacedim>::locally_owned_subdomain () const
     {
       Assert (false, ExcNotImplemented());
index fb4a98ac97cf5e95c0520ca44cf00cd56088b941..9e466cd2d0bb311e284a669b5f3f255daf9a91d7 100644 (file)
@@ -1489,12 +1489,12 @@ unsigned int DoFHandler<1>::n_boundary_dofs (const FunctionMap &boundary_indicat
 
 
 template <>
-unsigned int DoFHandler<1>::n_boundary_dofs (const std::set<types::boundary_id_t> &boundary_indicators) const
+unsigned int DoFHandler<1>::n_boundary_dofs (const std::set<types::boundary_id> &boundary_indicators) const
 {
                                    // check that only boundary
                                    // indicators 0 and 1 are allowed
                                    // in 1d
-  for (std::set<types::boundary_id_t>::const_iterator i=boundary_indicators.begin();
+  for (std::set<types::boundary_id>::const_iterator i=boundary_indicators.begin();
        i!=boundary_indicators.end(); ++i)
     Assert ((*i == 0) || (*i == 1),
             ExcInvalidBoundaryIndicator());
@@ -1528,12 +1528,12 @@ unsigned int DoFHandler<1,2>::n_boundary_dofs (const FunctionMap &boundary_indic
 
 
 template <>
-unsigned int DoFHandler<1,2>::n_boundary_dofs (const std::set<types::boundary_id_t> &boundary_indicators) const
+unsigned int DoFHandler<1,2>::n_boundary_dofs (const std::set<types::boundary_id> &boundary_indicators) const
 {
                                    // check that only boundary
                                    // indicators 0 and 1 are allowed
                                    // in 1d
-  for (std::set<types::boundary_id_t>::const_iterator i=boundary_indicators.begin();
+  for (std::set<types::boundary_id>::const_iterator i=boundary_indicators.begin();
        i!=boundary_indicators.end(); ++i)
     Assert ((*i == 0) || (*i == 1),
             ExcInvalidBoundaryIndicator());
@@ -1603,7 +1603,7 @@ DoFHandler<dim,spacedim>::n_boundary_dofs (const FunctionMap &boundary_indicator
 
 template<int dim, int spacedim>
 unsigned int
-DoFHandler<dim,spacedim>::n_boundary_dofs (const std::set<types::boundary_id_t> &boundary_indicators) const
+DoFHandler<dim,spacedim>::n_boundary_dofs (const std::set<types::boundary_id> &boundary_indicators) const
 {
   Assert (boundary_indicators.find (types::internal_face_boundary_id) == boundary_indicators.end(),
           ExcInvalidBoundaryIndicator());
index 241199d8918c8039b9c7fa2feaca6ba28e5860d8..5c8185b46ff8fc9f87f6a5c5a200e85e1573fb76 100644 (file)
@@ -226,7 +226,7 @@ namespace internal
           static
           unsigned int
           distribute_dofs (const unsigned int        offset,
-                           const types::subdomain_id_t subdomain_id,
+                           const types::subdomain_id subdomain_id,
                            DoFHandler<dim,spacedim> &dof_handler)
             {
               const dealii::Triangulation<dim,spacedim> & tria
@@ -637,8 +637,8 @@ namespace internal
                                      const unsigned int tree_index,
                                      const typename DoFHandler<dim,spacedim>::cell_iterator &dealii_cell,
                                      const typename dealii::internal::p4est::types<dim>::quadrant &p4est_cell,
-                                     const std::map<unsigned int, std::set<dealii::types::subdomain_id_t> > &vertices_with_ghost_neighbors,
-                                     std::map<dealii::types::subdomain_id_t, typename types<dim>::cellinfo> &needs_to_get_cell)
+                                     const std::map<unsigned int, std::set<dealii::types::subdomain_id> > &vertices_with_ghost_neighbors,
+                                     std::map<dealii::types::subdomain_id, typename types<dim>::cellinfo> &needs_to_get_cell)
         {
                                            // see if we have to
                                            // recurse...
@@ -671,10 +671,10 @@ namespace internal
                                                // check each vertex if
                                                // it is interesting and
                                                // push dofindices if yes
-              std::set<dealii::types::subdomain_id_t> send_to;
+              std::set<dealii::types::subdomain_id> send_to;
               for (unsigned int v=0; v<GeometryInfo<dim>::vertices_per_cell; ++v)
                 {
-                  const std::map<unsigned int, std::set<dealii::types::subdomain_id_t> >::const_iterator
+                  const std::map<unsigned int, std::set<dealii::types::subdomain_id> >::const_iterator
                     neighbor_subdomains_of_vertex
                     = vertices_with_ghost_neighbors.find (dealii_cell->vertex_index(v));
 
@@ -698,10 +698,10 @@ namespace internal
                     local_dof_indices (dealii_cell->get_fe().dofs_per_cell);
                   dealii_cell->get_dof_indices (local_dof_indices);
 
-                  for (std::set<dealii::types::subdomain_id_t>::iterator it=send_to.begin();
+                  for (std::set<dealii::types::subdomain_id>::iterator it=send_to.begin();
                        it!=send_to.end();++it)
                     {
-                      const dealii::types::subdomain_id_t subdomain = *it;
+                      const dealii::types::subdomain_id subdomain = *it;
 
                                                        // get an iterator
                                                        // to what needs to
@@ -710,7 +710,7 @@ namespace internal
                                                        // already exists),
                                                        // or create such
                                                        // an object
-                      typename std::map<dealii::types::subdomain_id_t, typename types<dim>::cellinfo>::iterator
+                      typename std::map<dealii::types::subdomain_id, typename types<dim>::cellinfo>::iterator
                         p
                         = needs_to_get_cell.insert (std::make_pair(subdomain,
                                                                    typename types<dim>::cellinfo()))
@@ -825,7 +825,7 @@ namespace internal
         void
         communicate_dof_indices_on_marked_cells
         (const DoFHandler<1,spacedim> &,
-         const std::map<unsigned int, std::set<dealii::types::subdomain_id_t> > &,
+         const std::map<unsigned int, std::set<dealii::types::subdomain_id> > &,
          const std::vector<unsigned int> &,
          const std::vector<unsigned int> &)
         {
@@ -838,7 +838,7 @@ namespace internal
         void
         communicate_dof_indices_on_marked_cells
         (const DoFHandler<dim,spacedim> &dof_handler,
-         const std::map<unsigned int, std::set<dealii::types::subdomain_id_t> > &vertices_with_ghost_neighbors,
+         const std::map<unsigned int, std::set<dealii::types::subdomain_id> > &vertices_with_ghost_neighbors,
          const std::vector<unsigned int> &coarse_cell_to_p4est_tree_permutation,
          const std::vector<unsigned int> &p4est_tree_to_coarse_cell_permutation)
         {
@@ -856,7 +856,7 @@ namespace internal
                                            // dof_indices for the
                                            // interested neighbors
           typedef
-            std::map<dealii::types::subdomain_id_t, typename types<dim>::cellinfo>
+            std::map<dealii::types::subdomain_id, typename types<dim>::cellinfo>
             cellmap_t;
           cellmap_t needs_to_get_cells;
 
@@ -912,7 +912,7 @@ namespace internal
                                            // mark all own cells, that miss some
                                            // dof_data and collect the neighbors
                                            // that are going to send stuff to us
-          std::set<dealii::types::subdomain_id_t> senders;
+          std::set<dealii::types::subdomain_id> senders;
           {
             std::vector<unsigned int> local_dof_indices;
             typename DoFHandler<dim,spacedim>::active_cell_iterator
@@ -1219,7 +1219,7 @@ namespace internal
                                          // subdomain to the vertex and
                                          // keep track of interesting
                                          // neighbors
-        std::map<unsigned int, std::set<dealii::types::subdomain_id_t> >
+        std::map<unsigned int, std::set<dealii::types::subdomain_id> >
           vertices_with_ghost_neighbors;
         for (typename DoFHandler<dim,spacedim>::active_cell_iterator
                cell = dof_handler.begin_active();
@@ -1464,7 +1464,7 @@ namespace internal
                                            // subdomain to the vertex and
                                            // keep track of interesting
                                            // neighbors
-          std::map<unsigned int, std::set<dealii::types::subdomain_id_t> >
+          std::map<unsigned int, std::set<dealii::types::subdomain_id> >
             vertices_with_ghost_neighbors;
           for (typename DoFHandler<dim,spacedim>::active_cell_iterator
                  cell = dof_handler.begin_active();
index 2791e024ce15d557ff4041f0ff063c2bd33b7d2e..99bec3b82325ce10f5ca1b0845ff9161c0cc9b0e 100644 (file)
@@ -849,7 +849,7 @@ namespace DoFRenumbering
         for (unsigned int c=0; c<n_buckets; ++c)
           {
             shifts[c]=cumulated;
-            for (types::subdomain_id_t i=0; i<tria->locally_owned_subdomain(); ++i)
+            for (types::subdomain_id i=0; i<tria->locally_owned_subdomain(); ++i)
               shifts[c] += all_dof_counts[c+n_buckets*i];
             for (unsigned int i=0; i<Utilities::MPI::n_mpi_processes (tria->get_communicator()); ++i)
               cumulated += all_dof_counts[c+n_buckets*i];
@@ -1868,7 +1868,7 @@ namespace DoFRenumbering
                                      // first get the association of each dof
                                      // with a subdomain and determine the total
                                      // number of subdomain ids used
-    std::vector<types::subdomain_id_t> subdomain_association (n_dofs);
+    std::vector<types::subdomain_id> subdomain_association (n_dofs);
     DoFTools::get_subdomain_association (dof_handler,
                                          subdomain_association);
     const unsigned int n_subdomains
index b385dd908b37998a6d98a2e628594c234c25b5a5..e23dd691a8399107fb8ca80851567498f4c01fec 100644 (file)
@@ -60,7 +60,7 @@ namespace DoFTools
                          SparsityPattern        &sparsity,
                          const ConstraintMatrix &constraints,
                          const bool              keep_constrained_dofs,
-                         const types::subdomain_id_t subdomain_id)
+                         const types::subdomain_id subdomain_id)
   {
     const unsigned int n_dofs = dof.n_dofs();
 
@@ -123,7 +123,7 @@ namespace DoFTools
                          SparsityPattern         &sparsity,
                          const ConstraintMatrix  &constraints,
                          const bool               keep_constrained_dofs,
-                         const types::subdomain_id_t subdomain_id)
+                         const types::subdomain_id subdomain_id)
   {
     const unsigned int n_dofs = dof.n_dofs();
 
@@ -521,7 +521,7 @@ namespace DoFTools
                               SparsityPattern &sparsity,
                               const ConstraintMatrix &constraints,
                               const bool              keep_constrained_dofs,
-                              const types::subdomain_id_t subdomain_id)
+                              const types::subdomain_id subdomain_id)
   {
     const unsigned int n_dofs = dof.n_dofs();
 
@@ -3378,7 +3378,7 @@ namespace DoFTools
   template<typename DH>
   void
   make_periodicity_constraints (const DH                       &dof_handler,
-                                const types::boundary_id_t     boundary_component,
+                                const types::boundary_id     boundary_component,
                                 const int                      direction,
                                 dealii::ConstraintMatrix       &constraint_matrix,
                                 const std::vector<bool>        &component_mask)
@@ -3396,7 +3396,7 @@ namespace DoFTools
   template<typename DH>
   void
   make_periodicity_constraints (const DH                       &dof_handler,
-                                const types::boundary_id_t     boundary_component,
+                                const types::boundary_id     boundary_component,
                                 const int                      direction,
                                 dealii::Tensor<1,DH::space_dimension>
                                                                &offset,
@@ -3918,7 +3918,7 @@ namespace DoFTools
   extract_boundary_dofs (const DH                      &dof_handler,
                          const std::vector<bool>       &component_select,
                          std::vector<bool>             &selected_dofs,
-                         const std::set<types::boundary_id_t> &boundary_indicators)
+                         const std::set<types::boundary_id> &boundary_indicators)
   {
     Assert ((dynamic_cast<const parallel::distributed::Triangulation<DH::dimension,DH::space_dimension>*>
              (&dof_handler.get_tria())
@@ -3945,7 +3945,7 @@ namespace DoFTools
   extract_boundary_dofs (const DH                      &dof_handler,
                          const std::vector<bool>       &component_select,
                          IndexSet             &selected_dofs,
-                         const std::set<types::boundary_id_t> &boundary_indicators)
+                         const std::set<types::boundary_id> &boundary_indicators)
   {
     AssertDimension (component_select.size(), n_components(dof_handler));
     Assert (boundary_indicators.find (types::internal_face_boundary_id) == boundary_indicators.end(),
@@ -4073,7 +4073,7 @@ namespace DoFTools
   extract_dofs_with_support_on_boundary (const DH                      &dof_handler,
                                          const std::vector<bool>       &component_select,
                                          std::vector<bool>             &selected_dofs,
-                                         const std::set<types::boundary_id_t> &boundary_indicators)
+                                         const std::set<types::boundary_id> &boundary_indicators)
   {
     AssertDimension (component_select.size(), n_components(dof_handler));
     Assert (boundary_indicators.find (types::internal_face_boundary_id) == boundary_indicators.end(),
@@ -4306,7 +4306,7 @@ namespace DoFTools
   template <class DH>
   void
   extract_subdomain_dofs (const DH                   &dof_handler,
-                          const types::subdomain_id_t subdomain_id,
+                          const types::subdomain_id subdomain_id,
                           std::vector<bool>          &selected_dofs)
   {
     Assert(selected_dofs.size() == dof_handler.n_dofs(),
@@ -4491,7 +4491,7 @@ namespace DoFTools
   template <class DH>
   void
   get_subdomain_association (const DH                  &dof_handler,
-                             std::vector<types::subdomain_id_t> &subdomain_association)
+                             std::vector<types::subdomain_id> &subdomain_association)
   {
                                      // if the Triangulation is distributed, the
                                      // only thing we can usefully ask is for
@@ -4533,7 +4533,7 @@ namespace DoFTools
                 ExcMessage ("You can't call this function for meshes that "
                             "have artificial cells."));
 
-        const types::subdomain_id_t subdomain_id = cell->subdomain_id();
+        const types::subdomain_id subdomain_id = cell->subdomain_id();
         const unsigned int dofs_per_cell = cell->get_fe().dofs_per_cell;
         local_dof_indices.resize (dofs_per_cell);
         cell->get_dof_indices (local_dof_indices);
@@ -4572,9 +4572,9 @@ namespace DoFTools
   template <class DH>
   unsigned int
   count_dofs_with_subdomain_association (const DH           &dof_handler,
-                                         const types::subdomain_id_t subdomain)
+                                         const types::subdomain_id subdomain)
   {
-    std::vector<types::subdomain_id_t> subdomain_association (dof_handler.n_dofs());
+    std::vector<types::subdomain_id> subdomain_association (dof_handler.n_dofs());
     get_subdomain_association (dof_handler, subdomain_association);
 
     return std::count (subdomain_association.begin(),
@@ -4587,7 +4587,7 @@ namespace DoFTools
   template <class DH>
   IndexSet
   dof_indices_with_subdomain_association (const DH           &dof_handler,
-                                          const types::subdomain_id_t subdomain)
+                                          const types::subdomain_id subdomain)
   {
 
                                      // If we have a distributed::Triangulation only
@@ -4648,7 +4648,7 @@ namespace DoFTools
   template <class DH>
   void
   count_dofs_with_subdomain_association (const DH           &dof_handler,
-                                         const types::subdomain_id_t subdomain,
+                                         const types::subdomain_id subdomain,
                                          std::vector<unsigned int> &n_dofs_on_subdomain)
   {
     Assert (n_dofs_on_subdomain.size() == dof_handler.get_fe().n_components(),
@@ -4675,7 +4675,7 @@ namespace DoFTools
     }
 #endif
 
-    std::vector<types::subdomain_id_t> subdomain_association (dof_handler.n_dofs());
+    std::vector<types::subdomain_id> subdomain_association (dof_handler.n_dofs());
     get_subdomain_association (dof_handler, subdomain_association);
 
     std::vector<unsigned char> component_association (dof_handler.n_dofs());
@@ -5871,7 +5871,7 @@ namespace DoFTools
   template <class DH>
   void map_dof_to_boundary_indices (
     const DH                      &dof_handler,
-    const std::set<types::boundary_id_t> &boundary_indicators,
+    const std::set<types::boundary_id> &boundary_indicators,
     std::vector<unsigned int>     &mapping)
   {
     Assert (&dof_handler.get_fe() != 0, ExcNoFESelected());
index 8564f052f09ac07210d609eeb3778146dc5ab9d2..f1ecde11e7a751498893f0eb046a3f16e15f3b0f 100644 (file)
@@ -331,7 +331,7 @@ for (DH : DOFHANDLERS; deal_II_dimension : DIMENSIONS)
   template
   void
   DoFTools::make_periodicity_constraints(const DH &,
-                                         const types::boundary_id_t,
+                                         const types::boundary_id,
                                          const int,
                                          dealii::ConstraintMatrix &,
                                          const std::vector<bool> &);
@@ -339,7 +339,7 @@ for (DH : DOFHANDLERS; deal_II_dimension : DIMENSIONS)
   template
   void
   DoFTools::make_periodicity_constraints(const DH &,
-                                         const types::boundary_id_t,
+                                         const types::boundary_id,
                                          const int,
                                          dealii::Tensor<1,DH::space_dimension> &,
                                          dealii::ConstraintMatrix &,
@@ -437,14 +437,14 @@ DoFTools::extract_boundary_dofs<DoFHandler<deal_II_dimension> >
 (const DoFHandler<deal_II_dimension> &,
  const std::vector<bool>                  &,
  std::vector<bool>                        &,
- const std::set<types::boundary_id_t> &);
+ const std::set<types::boundary_id> &);
 template
 void
 DoFTools::extract_boundary_dofs<hp::DoFHandler<deal_II_dimension> >
 (const hp::DoFHandler<deal_II_dimension> &,
  const std::vector<bool>                  &,
  std::vector<bool>                        &,
- const std::set<types::boundary_id_t> &);
+ const std::set<types::boundary_id> &);
 
 template
 void
@@ -452,14 +452,14 @@ DoFTools::extract_dofs_with_support_on_boundary<DoFHandler<deal_II_dimension> >
 (const DoFHandler<deal_II_dimension> &,
  const std::vector<bool>                  &,
  std::vector<bool>                        &,
- const std::set<types::boundary_id_t> &);
+ const std::set<types::boundary_id> &);
 template
 void
 DoFTools::extract_dofs_with_support_on_boundary<hp::DoFHandler<deal_II_dimension> >
 (const hp::DoFHandler<deal_II_dimension> &,
  const std::vector<bool>                  &,
  std::vector<bool>                        &,
- const std::set<types::boundary_id_t> &);
+ const std::set<types::boundary_id> &);
 
 template
 void
@@ -471,13 +471,13 @@ template
 void
 DoFTools::extract_subdomain_dofs<DoFHandler<deal_II_dimension> >
 (const DoFHandler<deal_II_dimension> &dof_handler,
- const types::subdomain_id_t  subdomain_id,
+ const types::subdomain_id  subdomain_id,
  std::vector<bool>     &selected_dofs);
 template
 void
 DoFTools::extract_subdomain_dofs<hp::DoFHandler<deal_II_dimension> >
 (const hp::DoFHandler<deal_II_dimension> &dof_handler,
- const types::subdomain_id_t subdomain_id,
+ const types::subdomain_id subdomain_id,
  std::vector<bool>     &selected_dofs);
 
 template
@@ -529,46 +529,46 @@ template
 void
 DoFTools::get_subdomain_association<DoFHandler<deal_II_dimension> >
 (const DoFHandler<deal_II_dimension> &dof_handler,
- std::vector<types::subdomain_id_t>           &subdomain_association);
+ std::vector<types::subdomain_id>           &subdomain_association);
 template
 void
 DoFTools::get_subdomain_association<hp::DoFHandler<deal_II_dimension> >
 (const hp::DoFHandler<deal_II_dimension> &dof_handler,
- std::vector<types::subdomain_id_t>           &subdomain_association);
+ std::vector<types::subdomain_id>           &subdomain_association);
 
 
 template
 unsigned int
 DoFTools::count_dofs_with_subdomain_association<DoFHandler<deal_II_dimension> >
 (const DoFHandler<deal_II_dimension> &,
- const types::subdomain_id_t);
+ const types::subdomain_id);
 template
 IndexSet
 DoFTools::dof_indices_with_subdomain_association<DoFHandler<deal_II_dimension> >
 (const DoFHandler<deal_II_dimension> &,
- const types::subdomain_id_t);
+ const types::subdomain_id);
 template
 void
 DoFTools::count_dofs_with_subdomain_association<DoFHandler<deal_II_dimension> >
 (const DoFHandler<deal_II_dimension> &,
- const types::subdomain_id_t,
+ const types::subdomain_id,
  std::vector<unsigned int> &);
 
 template
 unsigned int
 DoFTools::count_dofs_with_subdomain_association<hp::DoFHandler<deal_II_dimension> >
 (const hp::DoFHandler<deal_II_dimension> &,
- const types::subdomain_id_t);
+ const types::subdomain_id);
 template
 IndexSet
 DoFTools::dof_indices_with_subdomain_association<hp::DoFHandler<deal_II_dimension> >
 (const hp::DoFHandler<deal_II_dimension> &,
- const types::subdomain_id_t);
+ const types::subdomain_id);
 template
 void
 DoFTools::count_dofs_with_subdomain_association<hp::DoFHandler<deal_II_dimension> >
 (const hp::DoFHandler<deal_II_dimension> &,
- const types::subdomain_id_t,
+ const types::subdomain_id,
  std::vector<unsigned int> &);
 
 #if deal_II_dimension < 3
@@ -578,52 +578,52 @@ DoFTools::extract_boundary_dofs<DoFHandler<deal_II_dimension,deal_II_dimension+1
   (const DoFHandler<deal_II_dimension,deal_II_dimension+1> &,
    const std::vector<bool>                  &,
    std::vector<bool>                        &,
-   const std::set<types::boundary_id_t> &);
+   const std::set<types::boundary_id> &);
 template
 unsigned int
 DoFTools::count_dofs_with_subdomain_association<DoFHandler<deal_II_dimension,deal_II_dimension+1> >
 (const DoFHandler<deal_II_dimension,deal_II_dimension+1> &,
- const types::subdomain_id_t);
+ const types::subdomain_id);
 template
 IndexSet
 DoFTools::dof_indices_with_subdomain_association<DoFHandler<deal_II_dimension,deal_II_dimension+1> >
 (const DoFHandler<deal_II_dimension,deal_II_dimension+1> &,
- const types::subdomain_id_t);
+ const types::subdomain_id);
 template
 void
 DoFTools::count_dofs_with_subdomain_association<DoFHandler<deal_II_dimension,deal_II_dimension+1> >
 (const DoFHandler<deal_II_dimension,deal_II_dimension+1> &,
- const types::subdomain_id_t,
+ const types::subdomain_id,
  std::vector<unsigned int> &);
 
 template
 unsigned int
 DoFTools::count_dofs_with_subdomain_association<hp::DoFHandler<deal_II_dimension,deal_II_dimension+1> >
 (const hp::DoFHandler<deal_II_dimension,deal_II_dimension+1> &,
- const types::subdomain_id_t);
+ const types::subdomain_id);
 
 template
 IndexSet
 DoFTools::dof_indices_with_subdomain_association<hp::DoFHandler<deal_II_dimension,deal_II_dimension+1> >
 (const hp::DoFHandler<deal_II_dimension,deal_II_dimension+1> &,
- const types::subdomain_id_t);
+ const types::subdomain_id);
 
 template
 void
 DoFTools::get_subdomain_association<DoFHandler<deal_II_dimension,deal_II_dimension+1> >
 (const DoFHandler<deal_II_dimension,deal_II_dimension+1> &dof_handler,
- std::vector<types::subdomain_id_t>           &subdomain_association);
+ std::vector<types::subdomain_id>           &subdomain_association);
 template
 void
 DoFTools::get_subdomain_association<hp::DoFHandler<deal_II_dimension,deal_II_dimension+1> >
 (const hp::DoFHandler<deal_II_dimension,deal_II_dimension+1> &dof_handler,
- std::vector<types::subdomain_id_t>           &subdomain_association);
+ std::vector<types::subdomain_id>           &subdomain_association);
 
 template
 void
 DoFTools::count_dofs_with_subdomain_association<hp::DoFHandler<deal_II_dimension,deal_II_dimension+1> >
 (const hp::DoFHandler<deal_II_dimension,deal_II_dimension+1> &,
- const types::subdomain_id_t,
+ const types::subdomain_id,
  std::vector<unsigned int> &);
 #endif
 
@@ -634,51 +634,51 @@ DoFTools::extract_boundary_dofs<DoFHandler<1,3> >
   (const DoFHandler<1,3> &,
    const std::vector<bool>                  &,
    std::vector<bool>                        &,
-   const std::set<types::boundary_id_t> &);
+   const std::set<types::boundary_id> &);
 
 template
 void
 DoFTools::get_subdomain_association<DoFHandler<1,3> >
 (const DoFHandler<1,3> &dof_handler,
- std::vector<types::subdomain_id_t>           &subdomain_association);
+ std::vector<types::subdomain_id>           &subdomain_association);
 template
 void
 DoFTools::get_subdomain_association<hp::DoFHandler<1,3> >
 (const hp::DoFHandler<1,3> &dof_handler,
- std::vector<types::subdomain_id_t>           &subdomain_association);
+ std::vector<types::subdomain_id>           &subdomain_association);
 
 template
 unsigned int
 DoFTools::count_dofs_with_subdomain_association<DoFHandler<1,3> >
 (const DoFHandler<1,3> &,
- const types::subdomain_id_t);
+ const types::subdomain_id);
 template
 IndexSet
 DoFTools::dof_indices_with_subdomain_association<DoFHandler<1,3> >
 (const DoFHandler<1,3> &,
- const types::subdomain_id_t);
+ const types::subdomain_id);
 template
 void
 DoFTools::count_dofs_with_subdomain_association<DoFHandler<1,3> >
 (const DoFHandler<1,3> &,
- const types::subdomain_id_t,
+ const types::subdomain_id,
  std::vector<unsigned int> &);
 
 template
 unsigned int
 DoFTools::count_dofs_with_subdomain_association<hp::DoFHandler<1,3> >
 (const hp::DoFHandler<1,3> &,
- const types::subdomain_id_t);
+ const types::subdomain_id);
 template
 IndexSet
 DoFTools::dof_indices_with_subdomain_association<hp::DoFHandler<1,3> >
 (const hp::DoFHandler<1,3> &,
- const types::subdomain_id_t);
+ const types::subdomain_id);
 template
 void
 DoFTools::count_dofs_with_subdomain_association<hp::DoFHandler<1,3> >
 (const hp::DoFHandler<1,3> &,
- const types::subdomain_id_t,
+ const types::subdomain_id,
  std::vector<unsigned int> &);
 #endif
 
@@ -688,17 +688,17 @@ template
 unsigned int
 DoFTools::count_dofs_with_subdomain_association<MGDoFHandler<deal_II_dimension> >
 (const MGDoFHandler<deal_II_dimension> &,
- const types::subdomain_id_t);
+ const types::subdomain_id);
 template
 IndexSet
 DoFTools::dof_indices_with_subdomain_association<MGDoFHandler<deal_II_dimension> >
 (const MGDoFHandler<deal_II_dimension> &,
- const types::subdomain_id_t);
+ const types::subdomain_id);
 template
 void
 DoFTools::count_dofs_with_subdomain_association<MGDoFHandler<deal_II_dimension> >
 (const MGDoFHandler<deal_II_dimension> &,
- const types::subdomain_id_t,
+ const types::subdomain_id,
  std::vector<unsigned int> &);
 
 
@@ -807,7 +807,7 @@ template
 void
 DoFTools::map_dof_to_boundary_indices<DoFHandler<deal_II_dimension> >
 (const DoFHandler<deal_II_dimension> &,
- const std::set<types::boundary_id_t> &,
+ const std::set<types::boundary_id> &,
  std::vector<unsigned int> &);
 
 template
@@ -822,7 +822,7 @@ template
 void
 DoFTools::map_dof_to_boundary_indices<hp::DoFHandler<deal_II_dimension> >
 (const hp::DoFHandler<deal_II_dimension> &,
- const std::set<types::boundary_id_t> &,
+ const std::set<types::boundary_id> &,
  std::vector<unsigned int> &);
 
 template
@@ -983,7 +983,7 @@ template
 void
 DoFTools::map_dof_to_boundary_indices<DoFHandler<deal_II_dimension,deal_II_dimension+1> >
 (const DoFHandler<deal_II_dimension,deal_II_dimension+1> &,
- const std::set<types::boundary_id_t> &,
+ const std::set<types::boundary_id> &,
  std::vector<unsigned int> &);
 
 template
@@ -1003,7 +1003,7 @@ DoFTools::extract_hanging_node_dofs
  void
  DoFTools::map_dof_to_boundary_indices<hp::DoFHandler<deal_II_dimension,deal_II_dimension+1> >
  (const hp::DoFHandler<deal_II_dimension,deal_II_dimension+1> &,
-  const std::set<types::boundary_id_t> &,
+  const std::set<types::boundary_id> &,
   std::vector<unsigned int> &);
 
  template
@@ -1020,7 +1020,7 @@ template
 void
 DoFTools::map_dof_to_boundary_indices<DoFHandler<1,3> >
 (const DoFHandler<1,3> &,
- const std::set<types::boundary_id_t> &,
+ const std::set<types::boundary_id> &,
  std::vector<unsigned int> &);
 
 template
index 679aa7edf1aadeab05126a3860a2b19dbd53b71c..cd7d7a28f9841601f0ad6c937ed25a83d98b30c5 100644 (file)
@@ -1350,7 +1350,7 @@ namespace FETools
                                    // we can only interpolate u1 on
                                    // a cell, which this processor owns,
                                    // so we have to know the subdomain_id
-    const types::subdomain_id_t subdomain_id =
+    const types::subdomain_id subdomain_id =
       dof1.get_tria().locally_owned_subdomain();
 
     for (; cell1!=endc1; ++cell1, ++cell2)
@@ -1498,7 +1498,7 @@ namespace FETools
     Vector<typename OutVector::value_type> u1_local(dofs_per_cell1);
     Vector<typename OutVector::value_type> u1_int_local(dofs_per_cell1);
 
-    const types::subdomain_id_t subdomain_id =
+    const types::subdomain_id subdomain_id =
       dof1.get_tria().locally_owned_subdomain();
 
     typename DoFHandler<dim,spacedim>::active_cell_iterator cell = dof1.begin_active(),
@@ -1568,7 +1568,7 @@ namespace FETools
     Vector<typename OutVector::value_type> u1_local(DoFTools::max_dofs_per_cell(dof1));
     Vector<typename OutVector::value_type> u1_int_local(DoFTools::max_dofs_per_cell(dof1));
 
-    const types::subdomain_id_t subdomain_id =
+    const types::subdomain_id subdomain_id =
       dof1.get_tria().locally_owned_subdomain();
 
     typename DH<dim>::active_cell_iterator cell = dof1.begin_active(),
@@ -1744,7 +1744,7 @@ namespace FETools
     Vector<typename OutVector::value_type> u1_local(dofs_per_cell);
     Vector<typename OutVector::value_type> u1_diff_local(dofs_per_cell);
 
-    const types::subdomain_id_t subdomain_id =
+    const types::subdomain_id subdomain_id =
       dof1.get_tria().locally_owned_subdomain();
 
     FullMatrix<double> difference_matrix(dofs_per_cell, dofs_per_cell);
index cb2f5ccec360af50346babc546c026ee3a781b18..24a3432374292785327db8df36a486145ae64958 100644 (file)
@@ -891,7 +891,7 @@ GridGenerator::subdivided_hyper_rectangle (
   Triangulation<1>&                             tria,
   const std::vector< std::vector<double> >&     spacing,
   const Point<1>&                               p,
-  const Table<1,types::material_id_t>&                 material_id,
+  const Table<1,types::material_id>&                 material_id,
   const bool                                    colorize)
 {
                                    // contributed by Yaqi Wang 2006
@@ -950,7 +950,7 @@ GridGenerator::subdivided_hyper_rectangle (
   Triangulation<2>&                         tria,
   const std::vector< std::vector<double> >&     spacing,
   const Point<2>&                               p,
-  const Table<2,types::material_id_t>&          material_id,
+  const Table<2,types::material_id>&          material_id,
   const bool                                    colorize)
 {
                                    // contributed by Yaqi Wang 2006
@@ -1048,7 +1048,7 @@ GridGenerator::subdivided_hyper_rectangle (
   Triangulation<3>&                           tria,
   const std::vector< std::vector<double> >&     spacing,
   const Point<3>&                             p,
-  const Table<3,types::material_id_t>&               material_id,
+  const Table<3,types::material_id>&               material_id,
   const bool                                    colorize)
 {
                                    // contributed by Yaqi Wang 2006
@@ -1382,7 +1382,7 @@ void GridGenerator::enclosed_hyper_cube (Triangulation<2> &tria,
     for (unsigned int i1=0;i1<4;++i1)
       vertices[k++] = Point<2>(coords[i1], coords[i0]);
 
-  const types::material_id_t materials[9] = { 5, 4, 6,
+  const types::material_id materials[9] = { 5, 4, 6,
                                        1, 0, 2,
                                        9, 8,10
   };
@@ -2012,7 +2012,7 @@ void GridGenerator::enclosed_hyper_cube (Triangulation<3> &tria,
       for (unsigned int x=0;x<4;++x)
         vertices[k++] = Point<3>(coords[x], coords[y], coords[z]);
 
-  const types::material_id_t materials[27] = {
+  const types::material_id materials[27] = {
         21,20,22,
         17,16,18,
         25,24,26,
index c5a10923f5acb868aefe1003232126b7dac99de1..a48f534ef33a39eb6047bf6e48cb811c6f55053f 100644 (file)
@@ -355,13 +355,13 @@ void GridIn<dim, spacedim>::read_ucd (std::istream &in)
             in >> cells.back().vertices[i];
 
           // to make sure that the cast wont fail
-    Assert(material_id<= std::numeric_limits<types::material_id_t>::max(),
-        ExcIndexRange(material_id,0,std::numeric_limits<types::material_id_t>::max()));
+    Assert(material_id<= std::numeric_limits<types::material_id>::max(),
+        ExcIndexRange(material_id,0,std::numeric_limits<types::material_id>::max()));
     // we use only material_ids in the range from 0 to types::invalid_material_id-1
     Assert(material_id < types::invalid_material_id,
         ExcIndexRange(material_id,0,types::invalid_material_id));
 
-          cells.back().material_id = static_cast<types::material_id_t>(material_id);
+          cells.back().material_id = static_cast<types::material_id>(material_id);
 
                                            // transform from ucd to
                                            // consecutive numbering
@@ -385,14 +385,14 @@ void GridIn<dim, spacedim>::read_ucd (std::istream &in)
                >> subcelldata.boundary_lines.back().vertices[1];
 
             // to make sure that the cast wont fail
-            Assert(material_id<= std::numeric_limits<types::boundary_id_t>::max(),
-                ExcIndexRange(material_id,0,std::numeric_limits<types::boundary_id_t>::max()));
+            Assert(material_id<= std::numeric_limits<types::boundary_id>::max(),
+                ExcIndexRange(material_id,0,std::numeric_limits<types::boundary_id>::max()));
             // we use only boundary_ids in the range from 0 to types::internal_face_boundary_id-1
             Assert(material_id < types::internal_face_boundary_id,
                 ExcIndexRange(material_id,0,types::internal_face_boundary_id));
 
             subcelldata.boundary_lines.back().boundary_id
-                = static_cast<types::boundary_id_t>(material_id);
+                = static_cast<types::boundary_id>(material_id);
 
                                              // transform from ucd to
                                              // consecutive numbering
@@ -423,14 +423,14 @@ void GridIn<dim, spacedim>::read_ucd (std::istream &in)
                  >> subcelldata.boundary_quads.back().vertices[3];
 
               // to make sure that the cast wont fail
-              Assert(material_id<= std::numeric_limits<types::boundary_id_t>::max(),
-                  ExcIndexRange(material_id,0,std::numeric_limits<types::boundary_id_t>::max()));
+              Assert(material_id<= std::numeric_limits<types::boundary_id>::max(),
+                  ExcIndexRange(material_id,0,std::numeric_limits<types::boundary_id>::max()));
               // we use only boundary_ids in the range from 0 to types::internal_face_boundary_id-1
               Assert(material_id < types::internal_face_boundary_id,
                   ExcIndexRange(material_id,0,types::internal_face_boundary_id));
 
               subcelldata.boundary_quads.back().boundary_id
-                  = static_cast<types::boundary_id_t>(material_id);
+                  = static_cast<types::boundary_id>(material_id);
 
                                                // transform from ucd to
                                                // consecutive numbering
@@ -998,13 +998,13 @@ void GridIn<dim, spacedim>::read_msh (std::istream &in)
             in >> cells.back().vertices[i];
 
     // to make sure that the cast wont fail
-    Assert(material_id<= std::numeric_limits<types::material_id_t>::max(),
-        ExcIndexRange(material_id,0,std::numeric_limits<types::material_id_t>::max()));
+    Assert(material_id<= std::numeric_limits<types::material_id>::max(),
+        ExcIndexRange(material_id,0,std::numeric_limits<types::material_id>::max()));
     // we use only material_ids in the range from 0 to types::invalid_material_id-1
     Assert(material_id < types::invalid_material_id,
         ExcIndexRange(material_id,0,types::invalid_material_id));
 
-          cells.back().material_id = static_cast<types::material_id_t>(material_id);
+          cells.back().material_id = static_cast<types::material_id>(material_id);
 
                                            // transform from ucd to
                                            // consecutive numbering
@@ -1027,14 +1027,14 @@ void GridIn<dim, spacedim>::read_msh (std::istream &in)
                >> subcelldata.boundary_lines.back().vertices[1];
 
       // to make sure that the cast wont fail
-      Assert(material_id<= std::numeric_limits<types::boundary_id_t>::max(),
-          ExcIndexRange(material_id,0,std::numeric_limits<types::boundary_id_t>::max()));
+      Assert(material_id<= std::numeric_limits<types::boundary_id>::max(),
+          ExcIndexRange(material_id,0,std::numeric_limits<types::boundary_id>::max()));
       // we use only boundary_ids in the range from 0 to types::internal_face_boundary_id-1
       Assert(material_id < types::internal_face_boundary_id,
           ExcIndexRange(material_id,0,types::internal_face_boundary_id));
 
             subcelldata.boundary_lines.back().boundary_id
-                = static_cast<types::boundary_id_t>(material_id);
+                = static_cast<types::boundary_id>(material_id);
 
                                              // transform from ucd to
                                              // consecutive numbering
@@ -1065,14 +1065,14 @@ void GridIn<dim, spacedim>::read_msh (std::istream &in)
                  >> subcelldata.boundary_quads.back().vertices[3];
 
               // to make sure that the cast wont fail
-              Assert(material_id<= std::numeric_limits<types::boundary_id_t>::max(),
-                  ExcIndexRange(material_id,0,std::numeric_limits<types::boundary_id_t>::max()));
+              Assert(material_id<= std::numeric_limits<types::boundary_id>::max(),
+                  ExcIndexRange(material_id,0,std::numeric_limits<types::boundary_id>::max()));
               // we use only boundary_ids in the range from 0 to types::internal_face_boundary_id-1
               Assert(material_id < types::internal_face_boundary_id,
                   ExcIndexRange(material_id,0,types::internal_face_boundary_id));
 
               subcelldata.boundary_quads.back().boundary_id
-                  = static_cast<types::boundary_id_t>(material_id);
+                  = static_cast<types::boundary_id>(material_id);
 
                                                // transform from gmsh to
                                                // consecutive numbering
@@ -1617,7 +1617,7 @@ void GridIn<3>::read_netcdf (const std::string &filename)
   bmarker_var->get(&*bmarker.begin(), n_bquads);
                                    // we only handle boundary
                                    // indicators that fit into an
-                                   // types::boundary_id_t. Also, we don't
+                                   // types::boundary_id. Also, we don't
                                    // take types::internal_face_boundary_id
            // as it denotes an internal face
   for (unsigned int i=0; i<bmarker.size(); ++i)
@@ -1633,7 +1633,7 @@ void GridIn<3>::read_netcdf (const std::string &filename)
         subcelldata.boundary_quads[i].vertices[v]=bvertex_indices[
           i*GeometryInfo<dim>::vertices_per_face+v];
       subcelldata.boundary_quads[i].boundary_id
-      = static_cast<types::boundary_id_t>(bmarker[i]);
+      = static_cast<types::boundary_id>(bmarker[i]);
     }
 
   GridTools::delete_unused_vertices(vertices, cells, subcelldata);
index 51baca980dcb1400f7398bddda2e5110a879934d..a58d2634a19dd7d7af6a0eac2989389172218658 100644 (file)
@@ -1162,7 +1162,7 @@ void GridOut::write_xfig (
           {
             Triangulation<dim>::face_iterator
               face = cell->face(face_reorder[f]);
-            const types::boundary_id_t bi = face->boundary_indicator();
+            const types::boundary_id bi = face->boundary_indicator();
             if (bi != types::internal_face_boundary_id)
               {
                                                  // Code for polyline
index 62990c8f5aaa4bc92c7163634a40cc858b4c5b67..cea5d080198af3589bea295ec4b01db6be1452b9 100644 (file)
@@ -1233,7 +1233,7 @@ namespace GridTools
   template <int dim, int spacedim>
   void
   get_subdomain_association (const Triangulation<dim, spacedim>  &triangulation,
-                             std::vector<types::subdomain_id_t> &subdomain)
+                             std::vector<types::subdomain_id> &subdomain)
   {
     Assert (subdomain.size() == triangulation.n_active_cells(),
             ExcDimensionMismatch (subdomain.size(),
@@ -1253,7 +1253,7 @@ namespace GridTools
   unsigned int
 
   count_cells_with_subdomain_association (const Triangulation<dim, spacedim> &triangulation,
-                                          const types::subdomain_id_t       subdomain)
+                                          const types::subdomain_id       subdomain)
   {
     unsigned int count = 0;
     for (typename Triangulation<dim, spacedim>::active_cell_iterator
@@ -2049,7 +2049,7 @@ namespace GridTools
            typename Container<dim,spacedim>::face_iterator>
   extract_boundary_mesh (const Container<dim,spacedim> &volume_mesh,
                          Container<dim-1,spacedim>     &surface_mesh,
-                         const std::set<types::boundary_id_t> &boundary_ids)
+                         const std::set<types::boundary_id> &boundary_ids)
   {
 // Assumption:
 //    We are relying below on the fact that Triangulation::create_triangulation(...) will keep the order
@@ -2103,7 +2103,7 @@ namespace GridTools
                     }
 
                   c_data.vertices[j] = map_vert_index[v_index];
-                  c_data.material_id = static_cast<types::material_id_t>(face->boundary_indicator());
+                  c_data.material_id = static_cast<types::material_id>(face->boundary_indicator());
                 }
 
               cells.push_back(c_data);
@@ -2214,7 +2214,7 @@ namespace GridTools
   std::map<CellIterator, CellIterator>
   collect_periodic_cell_pairs (const CellIterator                          &begin,
                                const typename identity<CellIterator>::type &end,
-                               const types::boundary_id_t                  boundary_component,
+                               const types::boundary_id                  boundary_component,
                                int                                         direction,
                                const dealii::Tensor<1,CellIterator::AccessorType::space_dimension>
                                  &offset)
@@ -2276,7 +2276,7 @@ namespace GridTools
   template<typename DH>
   std::map<typename DH::cell_iterator, typename DH::cell_iterator>
   collect_periodic_cell_pairs (const DH                   &dof_handler,
-                               const types::boundary_id_t boundary_component,
+                               const types::boundary_id boundary_component,
                                int                        direction,
                                const dealii::Tensor<1,DH::space_dimension>
                                  &offset)
index 63a370af004be7f17fb81d639c72106f52e2bd5c..d8c6f0e51a852beea1d0deb1718826706de4122d 100644 (file)
@@ -119,12 +119,12 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension :  SPACE_DIMENSIONS
     
     template
       void get_subdomain_association (const Triangulation<deal_II_dimension, deal_II_space_dimension>  &,
-                                     std::vector<types::subdomain_id_t> &);
+                                     std::vector<types::subdomain_id> &);
 
     template
     unsigned int count_cells_with_subdomain_association(
       const Triangulation<deal_II_dimension, deal_II_space_dimension> &,
-      const types::subdomain_id_t);
+      const types::subdomain_id);
     
     template
       double
@@ -170,7 +170,7 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension :  SPACE_DIMENSIONS
                   Container<deal_II_dimension,deal_II_space_dimension>::face_iterator>
       extract_boundary_mesh (const Container<deal_II_dimension, deal_II_space_dimension> &mesh,
                             Container<deal_II_dimension-1,deal_II_space_dimension>  &boundary_mesh,
-                            const std::set<types::boundary_id_t> &boundary_ids);
+                            const std::set<types::boundary_id> &boundary_ids);
       \}
 #endif
 #endif
@@ -187,14 +187,14 @@ for (X : TRIANGULATION_AND_DOFHANDLERS; deal_II_dimension : DIMENSIONS ; deal_II
     std::map<X::cell_iterator, X::cell_iterator>
     collect_periodic_cell_pairs(const X::cell_iterator &,
                                 const X::cell_iterator &,
-                                const types::boundary_id_t,
+                                const types::boundary_id,
                                 int,
                                 const Tensor<1,deal_II_space_dimension> &);
 
     template
     std::map<X::cell_iterator, X::cell_iterator>
     collect_periodic_cell_pairs (const X&,
-                                 const types::boundary_id_t,
+                                 const types::boundary_id,
                                  int,
                                  const Tensor<1,deal_II_space_dimension> &);
 
index 6f9355de110d14a23c6c0286259200bfbfb875bb..31a0ef4830929427e90e54f0027cc93bb3a6b412 100644 (file)
@@ -3561,7 +3561,7 @@ namespace internal
                                    switch_1->line_orientation(1),
                                    switch_1->line_orientation(2),
                                    switch_1->line_orientation(3) };
-                                const types::boundary_id_t switch_1_boundary_indicator=switch_1->boundary_indicator();
+                                const types::boundary_id switch_1_boundary_indicator=switch_1->boundary_indicator();
                                 const unsigned int switch_1_user_index=switch_1->user_index();
                                 const bool switch_1_user_flag=switch_1->user_flag_set();
 
@@ -4012,8 +4012,8 @@ namespace internal
                              // An assert to make sure that the
                              // static_cast in the next line has
                              // the chance to give reasonable results.
-                    Assert(cell->material_id()<= std::numeric_limits<types::material_id_t>::max(),
-                        ExcIndexRange(cell->material_id(),0,std::numeric_limits<types::material_id_t>::max()));
+                    Assert(cell->material_id()<= std::numeric_limits<types::material_id>::max(),
+                        ExcIndexRange(cell->material_id(),0,std::numeric_limits<types::material_id>::max()));
 
                                                      // new vertex is
                                                      // placed on the
@@ -4022,7 +4022,7 @@ namespace internal
                                                      // stored in the
                                                      // boundary class
                     triangulation.vertices[next_unused_vertex] =
-                      triangulation.get_boundary(static_cast<types::boundary_id_t>(cell->material_id()))
+                      triangulation.get_boundary(static_cast<types::boundary_id>(cell->material_id()))
                       .get_new_point_on_quad (cell);
                   }
               }
@@ -4411,7 +4411,7 @@ namespace internal
                           (cell->vertex(0) + cell->vertex(1)) / 2;
                       else
                         triangulation.vertices[next_unused_vertex] =
-                          triangulation.get_boundary(static_cast<types::boundary_id_t>(cell->material_id()))
+                          triangulation.get_boundary(static_cast<types::boundary_id>(cell->material_id()))
                           .get_new_point_on_line(cell);
                       triangulation.vertices_used[next_unused_vertex] = true;
 
@@ -5818,7 +5818,7 @@ namespace internal
                                    switch_1->line_orientation(1),
                                    switch_1->line_orientation(2),
                                    switch_1->line_orientation(3)};
-                                const types::boundary_id_t switch_1_boundary_indicator=switch_1->boundary_indicator();
+                                const types::boundary_id switch_1_boundary_indicator=switch_1->boundary_indicator();
                                 const unsigned int switch_1_user_index=switch_1->user_index();
                                 const bool switch_1_user_flag=switch_1->user_flag_set();
                                 const RefinementCase<dim-1> switch_1_refinement_case=switch_1->refinement_case();
@@ -9404,7 +9404,7 @@ Triangulation (const MeshSmoothing smooth_grid,
 {
   if (dim == 1)
     vertex_to_boundary_id_map_1d
-      = new std::map<unsigned int, types::boundary_id_t>();
+      = new std::map<unsigned int, types::boundary_id>();
 
   // connect the any_change signal to the other signals
   signals.create.connect (signals.any_change);
@@ -9469,7 +9469,7 @@ Triangulation<dim, spacedim>::set_mesh_smoothing(const MeshSmoothing mesh_smooth
 
 template <int dim, int spacedim>
 void
-Triangulation<dim, spacedim>::set_boundary (const types::boundary_id_t number,
+Triangulation<dim, spacedim>::set_boundary (const types::boundary_id number,
                                             const Boundary<dim, spacedim>& boundary_object)
 {
   Assert(number < types::internal_face_boundary_id, ExcIndexRange(number,0,types::internal_face_boundary_id));
@@ -9481,7 +9481,7 @@ Triangulation<dim, spacedim>::set_boundary (const types::boundary_id_t number,
 
 template <int dim, int spacedim>
 void
-Triangulation<dim, spacedim>::set_boundary (const types::boundary_id_t number)
+Triangulation<dim, spacedim>::set_boundary (const types::boundary_id number)
 {
   Assert(number < types::internal_face_boundary_id, ExcIndexRange(number,0,types::internal_face_boundary_id));
 
@@ -9493,13 +9493,13 @@ Triangulation<dim, spacedim>::set_boundary (const types::boundary_id_t number)
 
 template <int dim, int spacedim>
 const Boundary<dim, spacedim> &
-Triangulation<dim, spacedim>::get_boundary (const types::boundary_id_t number) const
+Triangulation<dim, spacedim>::get_boundary (const types::boundary_id number) const
 {
   Assert(number<types::internal_face_boundary_id, ExcIndexRange(number,0,types::internal_face_boundary_id));
 
   //look, if there is a boundary stored at
   //boundary_id number.
-  typename std::map<types::boundary_id_t, SmartPointer<const Boundary<dim, spacedim>, Triangulation<dim, spacedim> > >::const_iterator it
+  typename std::map<types::boundary_id, SmartPointer<const Boundary<dim, spacedim>, Triangulation<dim, spacedim> > >::const_iterator it
   = boundary.find(number);
 
   if(it != boundary.end())
@@ -9518,7 +9518,7 @@ Triangulation<dim, spacedim>::get_boundary (const types::boundary_id_t number) c
 
 
 template <int dim, int spacedim>
-std::vector<types::boundary_id_t>
+std::vector<types::boundary_id>
 Triangulation<dim, spacedim>::get_boundary_indicators () const
 {
                                    // in 1d, we store a map of all used
@@ -9526,8 +9526,8 @@ Triangulation<dim, spacedim>::get_boundary_indicators () const
                                    // purposes
   if (dim == 1)
     {
-      std::vector<types::boundary_id_t> boundary_indicators;
-      for (std::map<unsigned int, types::boundary_id_t>::const_iterator
+      std::vector<types::boundary_id> boundary_indicators;
+      for (std::map<unsigned int, types::boundary_id>::const_iterator
              p = vertex_to_boundary_id_map_1d->begin();
            p !=  vertex_to_boundary_id_map_1d->end();
            ++p)
@@ -9549,7 +9549,7 @@ Triangulation<dim, spacedim>::get_boundary_indicators () const
       const unsigned int n_bi=
         std::count(bi_exists.begin(), bi_exists.end(), true);
 
-      std::vector<types::boundary_id_t> boundary_indicators(n_bi);
+      std::vector<types::boundary_id> boundary_indicators(n_bi);
       unsigned int bi_counter=0;
       for (unsigned int i=0; i<bi_exists.size(); ++i)
         if (bi_exists[i]==true)
@@ -9586,7 +9586,7 @@ copy_triangulation (const Triangulation<dim, spacedim> &old_tria)
 
   faces         = new internal::Triangulation::TriaFaces<dim>(*old_tria.faces);
 
-  typename std::map<types::boundary_id_t, SmartPointer<const Boundary<dim, spacedim> , Triangulation<dim, spacedim> > >::const_iterator
+  typename std::map<types::boundary_id, SmartPointer<const Boundary<dim, spacedim> , Triangulation<dim, spacedim> > >::const_iterator
       bdry_iterator = old_tria.boundary.begin();
   for (; bdry_iterator != old_tria.boundary.end() ; bdry_iterator++)
     boundary[bdry_iterator->first] = bdry_iterator->second;
@@ -9604,7 +9604,7 @@ copy_triangulation (const Triangulation<dim, spacedim> &old_tria)
     {
       delete vertex_to_boundary_id_map_1d;
       vertex_to_boundary_id_map_1d
-        = (new std::map<unsigned int, types::boundary_id_t>
+        = (new std::map<unsigned int, types::boundary_id>
            (*old_tria.vertex_to_boundary_id_map_1d));
     }
 
@@ -12557,7 +12557,7 @@ unsigned int Triangulation<dim, spacedim>::max_adjacent_cells () const
 
 
 template <int dim, int spacedim>
-types::subdomain_id_t
+types::subdomain_id
 Triangulation<dim,spacedim>::locally_owned_subdomain () const
 {
   return types::invalid_subdomain_id;
@@ -14733,7 +14733,7 @@ Triangulation<dim, spacedim>::remove_refinement_listener (RefinementListener &li
 // functions that currently only exist for <1,1> and <1,2>
 // template
 // const Boundary<1,3> &
-// Triangulation<1,3>::get_boundary (const types::boundary_id_t number) const;
+// Triangulation<1,3>::get_boundary (const types::boundary_id number) const;
 
 DEAL_II_NAMESPACE_CLOSE
 
index 8f8255323c6d61342a4bdf93196e910a49b7b479..972b4696d744091700069115f687b8a956bb3b33 100644 (file)
@@ -1273,7 +1273,7 @@ bool CellAccessor<dim, spacedim>::at_boundary () const
 
 
 template <int dim, int spacedim>
-types::material_id_t CellAccessor<dim, spacedim>::material_id () const
+types::material_id CellAccessor<dim, spacedim>::material_id () const
 {
   Assert (this->used(), TriaAccessorExceptions::ExcCellNotUsed());
   return this->tria->levels[this->present_level]->cells.boundary_or_material_id[this->present_index].material_id;
@@ -1282,7 +1282,7 @@ types::material_id_t CellAccessor<dim, spacedim>::material_id () const
 
 
 template <int dim, int spacedim>
-void CellAccessor<dim, spacedim>::set_material_id (const types::material_id_t mat_id) const
+void CellAccessor<dim, spacedim>::set_material_id (const types::material_id mat_id) const
 {
   Assert (this->used(), TriaAccessorExceptions::ExcCellNotUsed());
   Assert ( mat_id < types::invalid_material_id, ExcIndexRange(mat_id,0,types::invalid_material_id));
@@ -1292,7 +1292,7 @@ void CellAccessor<dim, spacedim>::set_material_id (const types::material_id_t ma
 
 
 template <int dim, int spacedim>
-void CellAccessor<dim, spacedim>::recursively_set_material_id (const types::material_id_t mat_id) const
+void CellAccessor<dim, spacedim>::recursively_set_material_id (const types::material_id mat_id) const
 {
   set_material_id (mat_id);
 
@@ -1304,7 +1304,7 @@ void CellAccessor<dim, spacedim>::recursively_set_material_id (const types::mate
 
 
 template <int dim, int spacedim>
-types::subdomain_id_t CellAccessor<dim, spacedim>::subdomain_id () const
+types::subdomain_id CellAccessor<dim, spacedim>::subdomain_id () const
 {
   Assert (this->used(), TriaAccessorExceptions::ExcCellNotUsed());
   return this->tria->levels[this->present_level]->subdomain_ids[this->present_index];
@@ -1314,7 +1314,7 @@ types::subdomain_id_t CellAccessor<dim, spacedim>::subdomain_id () const
 
 template <int dim, int spacedim>
 void
-CellAccessor<dim, spacedim>::set_subdomain_id (const types::subdomain_id_t new_subdomain_id) const
+CellAccessor<dim, spacedim>::set_subdomain_id (const types::subdomain_id new_subdomain_id) const
 {
   Assert (this->used(), TriaAccessorExceptions::ExcCellNotUsed());
   this->tria->levels[this->present_level]->subdomain_ids[this->present_index]
@@ -1366,7 +1366,7 @@ CellAccessor<dim, spacedim>::parent () const
 template <int dim, int spacedim>
 void
 CellAccessor<dim, spacedim>::
-recursively_set_subdomain_id (const types::subdomain_id_t new_subdomain_id) const
+recursively_set_subdomain_id (const types::subdomain_id new_subdomain_id) const
 {
   set_subdomain_id (new_subdomain_id);
 
index 2548bb351646ea55261ba4d86ce0b5d8048fe588..75f26683925ed98b433c3c4fd83e6c72d86e04a5 100644 (file)
@@ -2745,14 +2745,14 @@ namespace hp
 
 
   template <>
-  unsigned int DoFHandler<1>::n_boundary_dofs (const std::set<types::boundary_id_t> &boundary_indicators) const
+  unsigned int DoFHandler<1>::n_boundary_dofs (const std::set<types::boundary_id> &boundary_indicators) const
   {
     Assert (finite_elements != 0, ExcNoFESelected());
 
                                      // check that only boundary
                                      // indicators 0 and 1 are allowed
                                      // in 1d
-    for (std::set<types::boundary_id_t>::const_iterator i=boundary_indicators.begin();
+    for (std::set<types::boundary_id>::const_iterator i=boundary_indicators.begin();
          i!=boundary_indicators.end(); ++i)
       Assert ((*i == 0) || (*i == 1),
               ExcInvalidBoundaryIndicator());
@@ -2797,7 +2797,7 @@ namespace hp
   }
 
   template <>
-  unsigned int DoFHandler<1,2>::n_boundary_dofs (const std::set<types::boundary_id_t> &) const
+  unsigned int DoFHandler<1,2>::n_boundary_dofs (const std::set<types::boundary_id> &) const
   {
     Assert(false,ExcNotImplemented());
     return 0;
@@ -2819,7 +2819,7 @@ template <>
   }
 
   template <>
-  unsigned int DoFHandler<1,3>::n_boundary_dofs (const std::set<types::boundary_id_t> &) const
+  unsigned int DoFHandler<1,3>::n_boundary_dofs (const std::set<types::boundary_id> &) const
   {
     Assert(false,ExcNotImplemented());
     return 0;
@@ -2902,7 +2902,7 @@ template <>
 
   template<int dim, int spacedim>
   unsigned int
-  DoFHandler<dim,spacedim>::n_boundary_dofs (const std::set<types::boundary_id_t> &boundary_indicators) const
+  DoFHandler<dim,spacedim>::n_boundary_dofs (const std::set<types::boundary_id> &boundary_indicators) const
   {
     Assert (finite_elements != 0, ExcNoFESelected());
     Assert (boundary_indicators.find (types::internal_face_boundary_id) == boundary_indicators.end(),
@@ -2954,7 +2954,7 @@ template <>
 
 
   template <>
-  unsigned int DoFHandler<2,3>::n_boundary_dofs (const std::set<types::boundary_id_t> &) const
+  unsigned int DoFHandler<2,3>::n_boundary_dofs (const std::set<types::boundary_id> &) const
   {
     Assert(false,ExcNotImplemented());
     return 0;
index 9b54a14f498db4cbb0856aad669cf0bd3d7a34df..411b60a7e024012f628ae8e031e995659389affc 100644 (file)
@@ -1204,7 +1204,7 @@ namespace MGTools
                 {
                   const typename MGDoFHandler<dim,spacedim>::face_iterator
                     face = cell->face(face_no);
-                  const types::boundary_id_t bi = face->boundary_indicator();
+                  const types::boundary_id bi = face->boundary_indicator();
                                                    // Face is listed in
                                                    // boundary map
                   if (function_map.find(bi) != function_map.end())
@@ -1259,7 +1259,7 @@ namespace MGTools
                 }
 
               typename MGDoFHandler<dim,spacedim>::face_iterator face = cell->face(face_no);
-              const types::boundary_id_t boundary_component = face->boundary_indicator();
+              const types::boundary_id boundary_component = face->boundary_indicator();
               if (function_map.find(boundary_component) != function_map.end())
                                                  // face is of the right component
                 {
index 99de506b59faf539c19aa6ecb2e95e1fa3108133..c598979682aa4206b9b6c3d350f8426f838d49f2 100644 (file)
@@ -228,12 +228,12 @@ namespace internal
                                           * The subdomain id we are to care
                                           * for.
                                           */
-        const types::subdomain_id_t subdomain_id;
+        const types::subdomain_id subdomain_id;
                                          /**
                                           * The material id we are to care
                                           * for.
                                           */
-        const types::material_id_t material_id;
+        const types::material_id material_id;
 
                                          /**
                                           * Some more references to input data to
@@ -253,8 +253,8 @@ namespace internal
                       const dealii::hp::MappingCollection<DH::dimension, DH::space_dimension> &mapping,
                       const bool         need_quadrature_points,
                       const unsigned int n_solution_vectors,
-                      const types::subdomain_id_t subdomain_id,
-                      const types::material_id_t material_id,
+                      const types::subdomain_id subdomain_id,
+                      const types::material_id material_id,
                       const typename FunctionMap<spacedim>::type *neumann_bc,
                       const std::vector<bool>                component_mask,
                       const Function<spacedim>                   *coefficients);
@@ -277,8 +277,8 @@ namespace internal
                   const dealii::hp::MappingCollection<DH::dimension, DH::space_dimension> &mapping,
                   const bool     need_quadrature_points,
                   const unsigned int n_solution_vectors,
-                  const types::subdomain_id_t subdomain_id,
-                  const types::material_id_t material_id,
+                  const types::subdomain_id subdomain_id,
+                  const types::material_id material_id,
                   const typename FunctionMap<spacedim>::type *neumann_bc,
                   const std::vector<bool>                component_mask,
                   const Function<spacedim>         *coefficients)
@@ -547,7 +547,7 @@ namespace internal
                                          // difference between normal
                                          // derivative and boundary function
         {
-          const types::boundary_id_t boundary_indicator = face->boundary_indicator();
+          const types::boundary_id boundary_indicator = face->boundary_indicator();
 
           Assert (parallel_data.neumann_bc->find(boundary_indicator) !=
                   parallel_data.neumann_bc->end(),
@@ -832,7 +832,7 @@ namespace internal
     {
       const unsigned int n_solution_vectors = solutions.size();
 
-      const types::subdomain_id_t subdomain_id = parallel_data.subdomain_id;
+      const types::subdomain_id subdomain_id = parallel_data.subdomain_id;
       const unsigned int material_id  = parallel_data.material_id;
 
                                        // empty our own copy of the local face
@@ -1016,8 +1016,8 @@ estimate (const Mapping<1,spacedim>      &mapping,
           const std::vector<bool> &component_mask,
           const Function<spacedim>     *coefficients,
           const unsigned int       n_threads,
-          const types::subdomain_id_t subdomain_id,
-          const types::material_id_t       material_id)
+          const types::subdomain_id subdomain_id,
+          const types::material_id       material_id)
 {
                                    // just pass on to the other function
   const std::vector<const InputVector *> solutions (1, &solution);
@@ -1040,8 +1040,8 @@ estimate (const DH   &dof_handler,
           const std::vector<bool> &component_mask,
           const Function<spacedim>     *coefficients,
           const unsigned int       n_threads,
-          const types::subdomain_id_t subdomain_id,
-          const types::material_id_t       material_id)
+          const types::subdomain_id subdomain_id,
+          const types::material_id       material_id)
 {
   Assert (DEAL_II_COMPAT_MAPPING, ExcCompatibility("mapping"));
   estimate(StaticMappingQ1<1,spacedim>::mapping, dof_handler, quadrature, neumann_bc, solution,
@@ -1062,8 +1062,8 @@ estimate (const DH   &dof_handler,
           const std::vector<bool> &component_mask,
           const Function<spacedim>     *coefficients,
           const unsigned int       n_threads,
-          const types::subdomain_id_t subdomain_id,
-          const types::material_id_t       material_id)
+          const types::subdomain_id subdomain_id,
+          const types::material_id       material_id)
 {
   Assert (DEAL_II_COMPAT_MAPPING, ExcCompatibility("mapping"));
   estimate(StaticMappingQ1<1,spacedim>::mapping, dof_handler, quadrature, neumann_bc, solutions,
@@ -1085,8 +1085,8 @@ estimate (const Mapping<1,spacedim>      &mapping,
           const std::vector<bool> &component_mask,
           const Function<spacedim>     *coefficients,
           const unsigned int       n_threads,
-          const types::subdomain_id_t subdomain_id,
-          const types::material_id_t       material_id)
+          const types::subdomain_id subdomain_id,
+          const types::material_id       material_id)
 {
                                    // just pass on to the other function
   const std::vector<const InputVector *> solutions (1, &solution);
@@ -1108,8 +1108,8 @@ estimate (const DH   &dof_handler,
           const std::vector<bool> &component_mask,
           const Function<spacedim>     *coefficients,
           const unsigned int       n_threads,
-          const types::subdomain_id_t subdomain_id,
-          const types::material_id_t       material_id)
+          const types::subdomain_id subdomain_id,
+          const types::material_id       material_id)
 {
   Assert (DEAL_II_COMPAT_MAPPING, ExcCompatibility("mapping"));
   estimate(StaticMappingQ1<1,spacedim>::mapping, dof_handler, quadrature, neumann_bc, solution,
@@ -1130,8 +1130,8 @@ estimate (const DH   &dof_handler,
           const std::vector<bool> &component_mask,
           const Function<spacedim>     *coefficients,
           const unsigned int       n_threads,
-          const types::subdomain_id_t subdomain_id,
-          const types::material_id_t       material_id)
+          const types::subdomain_id subdomain_id,
+          const types::material_id       material_id)
 {
   Assert (DEAL_II_COMPAT_MAPPING, ExcCompatibility("mapping"));
   estimate(StaticMappingQ1<1,spacedim>::mapping, dof_handler, quadrature, neumann_bc, solutions,
@@ -1153,8 +1153,8 @@ estimate (const Mapping<1,spacedim>                    &/*mapping*/,
           const std::vector<bool>                &/*component_mask_*/,
           const Function<spacedim>                   */*coefficient*/,
           const unsigned int,
-          const types::subdomain_id_t          /*subdomain_id*/,
-          const types::material_id_t                   /*material_id*/)
+          const types::subdomain_id          /*subdomain_id*/,
+          const types::material_id                   /*material_id*/)
 {
   Assert (false, ExcInternalError());
 }
@@ -1173,8 +1173,8 @@ estimate (const Mapping<1,spacedim>                    &mapping,
           const std::vector<bool>                  &component_mask_,
           const Function<spacedim>                   *coefficient,
           const unsigned int,
-          const types::subdomain_id_t         subdomain_id_,
-          const types::material_id_t                  material_id)
+          const types::subdomain_id         subdomain_id_,
+          const types::material_id                  material_id)
 {
 #ifdef DEAL_II_USE_P4EST
   if (dynamic_cast<const parallel::distributed::Triangulation<1,spacedim>*>
@@ -1189,7 +1189,7 @@ estimate (const Mapping<1,spacedim>                    &mapping,
                         "valid subdomain_id that can be passed here is the "
                         "one that corresponds to the locally owned subdomain id."));
 
-  const types::subdomain_id_t subdomain_id
+  const types::subdomain_id subdomain_id
     = ((dynamic_cast<const parallel::distributed::Triangulation<1,spacedim>*>
         (&dof_handler.get_tria())
         != 0)
@@ -1199,7 +1199,7 @@ estimate (const Mapping<1,spacedim>                    &mapping,
        :
        subdomain_id_);
 #else
-  const types::subdomain_id_t subdomain_id
+  const types::subdomain_id subdomain_id
     = subdomain_id_;
 #endif
 
@@ -1443,8 +1443,8 @@ estimate (const Mapping<dim, spacedim>      &mapping,
           const std::vector<bool> &component_mask,
           const Function<spacedim>     *coefficients,
           const unsigned int       n_threads,
-          const types::subdomain_id_t subdomain_id,
-          const types::material_id_t       material_id)
+          const types::subdomain_id subdomain_id,
+          const types::material_id       material_id)
 {
                                    // just pass on to the other function
   const std::vector<const InputVector *> solutions (1, &solution);
@@ -1466,8 +1466,8 @@ estimate (const DH                &dof_handler,
           const std::vector<bool> &component_mask,
           const Function<spacedim>     *coefficients,
           const unsigned int       n_threads,
-          const types::subdomain_id_t subdomain_id,
-          const types::material_id_t       material_id)
+          const types::subdomain_id subdomain_id,
+          const types::material_id       material_id)
 {
   Assert (DEAL_II_COMPAT_MAPPING, ExcCompatibility("mapping"));
   estimate(StaticMappingQ1<dim,spacedim>::mapping, dof_handler, quadrature, neumann_bc, solution,
@@ -1489,8 +1489,8 @@ estimate (const Mapping<dim, spacedim>      &mapping,
           const std::vector<bool> &component_mask,
           const Function<spacedim>     *coefficients,
           const unsigned int       n_threads,
-          const types::subdomain_id_t subdomain_id,
-          const types::material_id_t       material_id)
+          const types::subdomain_id subdomain_id,
+          const types::material_id       material_id)
 {
                                    // just pass on to the other function
   const std::vector<const InputVector *> solutions (1, &solution);
@@ -1512,8 +1512,8 @@ estimate (const DH                &dof_handler,
           const std::vector<bool> &component_mask,
           const Function<spacedim>     *coefficients,
           const unsigned int       n_threads,
-          const types::subdomain_id_t subdomain_id,
-          const types::material_id_t       material_id)
+          const types::subdomain_id subdomain_id,
+          const types::material_id       material_id)
 {
   Assert (DEAL_II_COMPAT_MAPPING, ExcCompatibility("mapping"));
   estimate(StaticMappingQ1<dim, spacedim>::mapping, dof_handler, quadrature, neumann_bc, solution,
@@ -1537,8 +1537,8 @@ estimate (const Mapping<dim, spacedim>                  &mapping,
           const std::vector<bool>                  &component_mask_,
           const Function<spacedim>                 *coefficients,
           const unsigned int                   ,
-          const types::subdomain_id_t          subdomain_id_,
-          const types::material_id_t                   material_id)
+          const types::subdomain_id          subdomain_id_,
+          const types::material_id                   material_id)
 {
 #ifdef DEAL_II_USE_P4EST
   if (dynamic_cast<const parallel::distributed::Triangulation<dim,spacedim>*>
@@ -1553,7 +1553,7 @@ estimate (const Mapping<dim, spacedim>                  &mapping,
                         "valid subdomain_id that can be passed here is the "
                         "one that corresponds to the locally owned subdomain id."));
 
-  const types::subdomain_id_t subdomain_id
+  const types::subdomain_id subdomain_id
     = ((dynamic_cast<const parallel::distributed::Triangulation<dim,spacedim>*>
         (&dof_handler.get_tria())
         != 0)
@@ -1563,7 +1563,7 @@ estimate (const Mapping<dim, spacedim>                  &mapping,
        :
        subdomain_id_);
 #else
-  const types::subdomain_id_t subdomain_id
+  const types::subdomain_id subdomain_id
     = subdomain_id_;
 #endif
 
@@ -1714,8 +1714,8 @@ estimate (const Mapping<dim, spacedim>                  &mapping,
           const std::vector<bool>                  &component_mask,
           const Function<spacedim>                 *coefficients,
           const unsigned int                   n_threads,
-          const types::subdomain_id_t          subdomain_id,
-          const types::material_id_t                   material_id)
+          const types::subdomain_id          subdomain_id,
+          const types::material_id                   material_id)
 {
                                    // forward to the function with the QCollection
   estimate (mapping, dof_handler,
@@ -1736,8 +1736,8 @@ void KellyErrorEstimator<dim, spacedim>::estimate (const DH
                                          const std::vector<bool>                  &component_mask,
                                          const Function<spacedim>                 *coefficients,
                                          const unsigned int                   n_threads,
-                                         const types::subdomain_id_t subdomain_id,
-                                         const types::material_id_t       material_id)
+                                         const types::subdomain_id subdomain_id,
+                                         const types::material_id       material_id)
 {
   Assert (DEAL_II_COMPAT_MAPPING, ExcCompatibility("mapping"));
   estimate(StaticMappingQ1<dim, spacedim>::mapping, dof_handler, quadrature, neumann_bc, solutions,
@@ -1757,8 +1757,8 @@ void KellyErrorEstimator<dim, spacedim>::estimate (const DH
                                          const std::vector<bool>                  &component_mask,
                                          const Function<spacedim>                 *coefficients,
                                          const unsigned int                   n_threads,
-                                         const types::subdomain_id_t subdomain_id,
-                                         const types::material_id_t       material_id)
+                                         const types::subdomain_id subdomain_id,
+                                         const types::material_id       material_id)
 {
   Assert (DEAL_II_COMPAT_MAPPING, ExcCompatibility("mapping"));
   estimate(StaticMappingQ1<dim, spacedim>::mapping, dof_handler, quadrature, neumann_bc, solutions,
index 41fcf4da9b10a9f44837bfebb30e95cda7de84ba..062fd660fa085e66e4fd250466ace77b48328af1 100644 (file)
@@ -39,7 +39,7 @@ estimate<InputVector,DH<deal_II_dimension> > (const Mapping<deal_II_dimension, d
           const Function<deal_II_dimension>     *,    \
           const unsigned int       , \
           const unsigned int       , \
-          const types::material_id_t);    \
+          const types::material_id);    \
     \
 template    \
 void    \
@@ -53,7 +53,7 @@ estimate<InputVector,DH<deal_II_dimension> > (const DH<deal_II_dimension>   &,
           const Function<deal_II_dimension>     *,    \
           const unsigned int       , \
           const unsigned int       , \
-          const types::material_id_t);    \
+          const types::material_id);    \
         \
 template    \
 void    \
@@ -68,7 +68,7 @@ estimate<InputVector,DH<deal_II_dimension> > (const Mapping<deal_II_dimension, d
           const Function<deal_II_dimension>         *,    \
           const unsigned int           , \
           const unsigned int           , \
-          const types::material_id_t);    \
+          const types::material_id);    \
     \
 template    \
 void    \
@@ -82,7 +82,7 @@ estimate<InputVector,DH<deal_II_dimension> > (const DH<deal_II_dimension>
           const Function<deal_II_dimension>         *,    \
           const unsigned int           , \
           const unsigned int           , \
-          const types::material_id_t);\
+          const types::material_id);\
 
 #if deal_II_dimension == 2 || deal_II_dimension == 1
 
@@ -100,7 +100,7 @@ estimate<InputVector,DH<deal_II_dimension,deal_II_dimension+1> > (const Mapping<
           const Function<deal_II_dimension+1>     *,    \
           const unsigned int       , \
           const unsigned int       , \
-          const types::material_id_t);    \
+          const types::material_id);    \
     \
 template    \
 void    \
@@ -114,7 +114,7 @@ estimate<InputVector,DH<deal_II_dimension,deal_II_dimension+1> > (const DH<deal_
           const Function<deal_II_dimension+1>     *,    \
           const unsigned int       , \
           const unsigned int       , \
-          const types::material_id_t);    \
+          const types::material_id);    \
         \
 template    \
 void    \
@@ -129,7 +129,7 @@ estimate<InputVector,DH<deal_II_dimension,deal_II_dimension+1> > (const Mapping<
           const Function<deal_II_dimension+1>         *,    \
           const unsigned int           , \
           const unsigned int           , \
-          const types::material_id_t);    \
+          const types::material_id);    \
     \
 template    \
 void    \
@@ -143,7 +143,7 @@ estimate<InputVector,DH<deal_II_dimension,deal_II_dimension+1> > (const DH<deal_
           const Function<deal_II_dimension+1>         *,    \
           const unsigned int           , \
           const unsigned int           , \
-          const types::material_id_t);\
+          const types::material_id);\
 
 #else
 #define INSTANTIATE_CODIM(InputVector,DH,Q)
index f6bf113d3681fa807d7277ec3b4c4553f957d6c6..04d777422d31c81e56434a61d6a71bd81877d9bd 100644 (file)
@@ -298,7 +298,7 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS;
         void interpolate_boundary_values
         (const Mapping<deal_II_dimension,deal_II_space_dimension>    &,
          const DH<deal_II_dimension,deal_II_space_dimension> &,
-         const types::boundary_id_t,
+         const types::boundary_id,
          const Function<deal_II_space_dimension>   &,
          std::map<unsigned int,double>       &,
          const std::vector<bool>    &);
@@ -306,7 +306,7 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS;
       template
         void interpolate_boundary_values (
           const DH<deal_II_dimension,deal_II_space_dimension> &,
-          const types::boundary_id_t,
+          const types::boundary_id,
           const Function<deal_II_space_dimension>   &,
           std::map<unsigned int,double>       &,
           const std::vector<bool>    &);
@@ -330,7 +330,7 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS;
         void interpolate_boundary_values
         (const Mapping<deal_II_dimension,deal_II_space_dimension>    &,
          const DH<deal_II_dimension,deal_II_space_dimension> &,
-         const types::boundary_id_t,
+         const types::boundary_id,
          const Function<deal_II_space_dimension>   &,
          ConstraintMatrix                    &,
          const std::vector<bool>             &);
@@ -338,7 +338,7 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS;
       template
         void interpolate_boundary_values (
           const DH<deal_II_dimension,deal_II_space_dimension> &,
-          const types::boundary_id_t,
+          const types::boundary_id,
           const Function<deal_II_space_dimension>   &,
           ConstraintMatrix                    &,
           const std::vector<bool>    &);
@@ -459,7 +459,7 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension :  SPACE_DIMENSIONS
          const Quadrature<deal_II_dimension-1> &,
          const Function<deal_II_dimension>   &,
          Vector<double>                      &,
-         const std::set<types::boundary_id_t> &);
+         const std::set<types::boundary_id> &);
 #endif
 
       template
@@ -469,7 +469,7 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension :  SPACE_DIMENSIONS
          const Quadrature<deal_II_dimension-1> &,
          const Function<deal_II_dimension>   &,
          Vector<double>                      &,
-         const std::set<types::boundary_id_t> &);
+         const std::set<types::boundary_id> &);
 
 #if deal_II_dimension > 1
       template
@@ -480,7 +480,7 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension :  SPACE_DIMENSIONS
          const hp::QCollection<deal_II_dimension-1> &,
          const Function<deal_II_dimension>   &,
          Vector<double>                      &,
-         const std::set<types::boundary_id_t> &);
+         const std::set<types::boundary_id> &);
 #endif
 
       template
@@ -490,7 +490,7 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension :  SPACE_DIMENSIONS
          const hp::QCollection<deal_II_dimension-1> &,
          const Function<deal_II_dimension>   &,
          Vector<double>                      &,
-         const std::set<types::boundary_id_t> &);
+         const std::set<types::boundary_id> &);
 
 
 
@@ -536,7 +536,7 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension :  SPACE_DIMENSIONS
         (const DoFHandler<deal_II_dimension>&,
          const unsigned int,
          const Function<deal_II_dimension>&,
-         const types::boundary_id_t,
+         const types::boundary_id,
          ConstraintMatrix&,
          const Mapping<deal_II_dimension>&);
       template
@@ -544,7 +544,7 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension :  SPACE_DIMENSIONS
         (const hp::DoFHandler<deal_II_dimension>&,
          const unsigned int,
          const Function<deal_II_dimension>&,
-         const types::boundary_id_t,
+         const types::boundary_id,
          ConstraintMatrix&,
          const hp::MappingCollection<deal_II_dimension>&);
       template
@@ -552,7 +552,7 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension :  SPACE_DIMENSIONS
         (const DoFHandler<deal_II_dimension>&,
          const unsigned int,
          const Function<deal_II_dimension>&,
-         const types::boundary_id_t,
+         const types::boundary_id,
          ConstraintMatrix&,
          const Mapping<deal_II_dimension>&);
       template
@@ -560,21 +560,21 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension :  SPACE_DIMENSIONS
         (const hp::DoFHandler<deal_II_dimension>&,
          const unsigned int,
          const Function<deal_II_dimension>&,
-         const types::boundary_id_t,
+         const types::boundary_id,
          ConstraintMatrix&,
          const hp::MappingCollection<deal_II_dimension>&);
       template
         void
         compute_no_normal_flux_constraints (const DoFHandler<deal_II_dimension> &dof_handler,
                                             const unsigned int     first_vector_component,
-                                            const std::set<types::boundary_id_t> &boundary_ids,
+                                            const std::set<types::boundary_id> &boundary_ids,
                                             ConstraintMatrix      &constraints,
                                             const Mapping<deal_II_dimension>    &mapping);
       template
         void
         compute_no_normal_flux_constraints (const hp::DoFHandler<deal_II_dimension> &dof_handler,
                                             const unsigned int     first_vector_component,
-                                            const std::set<types::boundary_id_t> &boundary_ids,
+                                            const std::set<types::boundary_id> &boundary_ids,
                                             ConstraintMatrix      &constraints,
                                             const Mapping<deal_II_dimension>    &mapping);
 #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.