]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Remove namespace deal_II_numbers and various outdated in namespace types.
authorWolfgang Bangerth <bangerth@math.tamu.edu>
Sun, 4 Jan 2015 21:34:29 +0000 (15:34 -0600)
committerWolfgang Bangerth <bangerth@math.tamu.edu>
Fri, 9 Jan 2015 06:56:01 +0000 (00:56 -0600)
27 files changed:
doc/news/changes.h
include/deal.II/base/index_set.h
include/deal.II/base/named_data.h
include/deal.II/base/numbers.h
include/deal.II/base/types.h
include/deal.II/lac/matrix_block.h
include/deal.II/matrix_free/dof_info.templates.h
include/deal.II/meshworker/dof_info.h
include/deal.II/meshworker/functional.h
include/deal.II/meshworker/integration_info.h
source/base/quadrature.cc
source/fe/mapping_q.cc
source/fe/mapping_q1.cc
source/grid/tria_accessor.cc
tests/base/named_data.cc
tests/deal.II/assemble_matrix_parallel_01.cc
tests/deal.II/assemble_matrix_parallel_02.cc
tests/deal.II/assemble_matrix_parallel_03.cc
tests/deal.II/assemble_matrix_parallel_04.cc
tests/deal.II/inhomogeneous_constraints.cc
tests/trilinos/assemble_matrix_parallel_01.cc
tests/trilinos/assemble_matrix_parallel_02.cc
tests/trilinos/assemble_matrix_parallel_03.cc
tests/trilinos/assemble_matrix_parallel_04.cc
tests/trilinos/assemble_matrix_parallel_05.cc
tests/trilinos/assemble_matrix_parallel_06.cc
tests/trilinos/assemble_matrix_parallel_07.cc

index fd393c79c7d14cb0fa87baeba8ded379b1f0035c..3574913212f354fe8dc2d3e0aaa2fc0d3afbb134 100644 (file)
@@ -98,7 +98,8 @@ inconvenience this causes.
   class.
 - The deprecated constructor of MPI_InitFinalize
 - The MPI support functions in namespace Utilities and Utilities::System.
-
+- Deprecated members of namespace types
+- Namespace deal_II_numbers.
 
 <!-- ----------- GENERAL IMPROVEMENTS ----------------- -->
 
index 4061ecd74d3c103302ee7cc00ebe671056b20cdb..f251756129cadae29f717e8d9748ef01318fd201 100644 (file)
@@ -499,7 +499,7 @@ IndexSet::IndexSet ()
   :
   is_compressed (true),
   index_space_size (0),
-  largest_range (deal_II_numbers::invalid_unsigned_int)
+  largest_range (numbers::invalid_unsigned_int)
 {}
 
 
@@ -509,7 +509,7 @@ IndexSet::IndexSet (const types::global_dof_index size)
   :
   is_compressed (true),
   index_space_size (size),
-  largest_range (deal_II_numbers::invalid_unsigned_int)
+  largest_range (numbers::invalid_unsigned_int)
 {}
 
 
index a516a965a70c6712492550b946ecf3ce0226f69d..dae3357b386d3aec48079d2ebc1fc9921a57664f 100644 (file)
@@ -372,7 +372,7 @@ NamedData<DATA>::find (const std::string &name) const
   const std::vector<std::string>::const_iterator
   i = std::find(names.begin(), names.end(), name);
   if (i == names.end())
-    return deal_II_numbers::invalid_unsigned_int;
+    return numbers::invalid_unsigned_int;
   return i - names.begin();
 }
 
index fca7d0ab0c8fc663e37850d97bcb6b93937c10a4..4c7da9dc078e2c82e607e5c41aaee15bea9eb746 100644 (file)
@@ -225,17 +225,6 @@ namespace numbers
 }
 
 
-//TODO[WB]: eventually remove this namespace alias
-/*
- * Namespace alias with the old name for the numbers namespace. The namespace
- * was originally called numbers, but has since been renamed to
- * dealii::numbers when everything was moved into namespace dealii.
- *
- * @deprecated
- */
-namespace deal_II_numbers = numbers;
-
-
 // --------------- inline and template functions ---------------- //
 
 namespace numbers
index 61b4654dba62a32a752cde98ed6c1919a4083d26..a9ced11de13229e313a494502d413c9876c1cb6b 100644 (file)
@@ -19,6 +19,8 @@
 
 #include <deal.II/base/config.h>
 #include <cstddef>
+
+
 DEAL_II_NAMESPACE_OPEN
 
 /**
@@ -39,21 +41,6 @@ namespace types
    */
   typedef unsigned int subdomain_id;
 
-  /**
-   * @deprecated Old name for the typedef above.
-   */
-  typedef subdomain_id subdomain_id_t DEAL_II_DEPRECATED;
-
-  /**
-   * @deprecated Use numbers::invalid_subdomain_id
-   */
-  const unsigned int invalid_subdomain_id DEAL_II_DEPRECATED = static_cast<subdomain_id>(-1);
-
-  /**
-   * @deprecated Use numbers::artificial_subdomain_id
-   */
-  const unsigned int artificial_subdomain_id DEAL_II_DEPRECATED = static_cast<subdomain_id>(-2);
-
 #ifdef DEAL_II_WITH_64BIT_INDICES
   /**
    * The type used for global indices of degrees of freedom. While in
@@ -96,12 +83,6 @@ namespace types
 #  define DEAL_II_DOF_INDEX_MPI_TYPE MPI_UNSIGNED
 #endif
 
-
-  /**
-   * @deprecated Use numbers::invalid_dof_index
-   */
-  const global_dof_index invalid_dof_index DEAL_II_DEPRECATED = static_cast<global_dof_index>(-1);
-
   /**
    * The type used to denote boundary indicators associated with every piece
    * of the boundary and, in the case of meshes that describe manifolds in
@@ -129,12 +110,6 @@ namespace types
    */
   typedef unsigned int manifold_id;
 
-
-  /**
-   * @deprecated Old name for the typedef above.
-   */
-  typedef boundary_id boundary_id_t DEAL_II_DEPRECATED;
-
   /**
    * The type used to denote material indicators associated with every cell.
    *
@@ -142,12 +117,6 @@ namespace types
    * indicate an invalid value of this type.
    */
   typedef unsigned char material_id;
-
-  /**
-   * @deprecated Old name for the typedef above.
-   */
-  typedef material_id material_id_t DEAL_II_DEPRECATED;
-
 }
 
 namespace TrilinosWrappers
index 5a390981ed957cd2a150e07c0a22a50b2044562e..f1267fc10f32c64f29b5493c2942c6e38e21f7ef 100644 (file)
@@ -582,8 +582,8 @@ template <class MATRIX>
 inline
 MatrixBlock<MATRIX>::MatrixBlock()
   :
-  row(deal_II_numbers::invalid_size_type),
-  column(deal_II_numbers::invalid_size_type)
+  row(numbers::invalid_size_type),
+  column(numbers::invalid_size_type)
 {}
 
 
index b2f89394eaf2feea5df94f5f9782e873f6862d5b..561dc08ed1ea0aacd885d35c1d6b50aeb8de299a 100644 (file)
@@ -104,7 +104,7 @@ namespace internal
           FPArrayComparator<double> >::iterator,
           bool> it = constraints.insert(next_constraint);
 
-      types::global_dof_index insert_position = deal_II_numbers::invalid_dof_index;
+      types::global_dof_index insert_position = numbers::invalid_dof_index;
       if (it.second == false)
         insert_position = it.first->second;
       else
index 6c5e31490a64ae47c003098a94643bb38054962a..6bc11b43781173cafbb0cbb3e357fba12b9cd8fe 100644 (file)
@@ -77,7 +77,7 @@ namespace MeshWorker
     /**
      * The number of the current face on the current cell.
      *
-     * This number is deal_II_numbers::invalid_unsigned_int if the info object
+     * This number is numbers::invalid_unsigned_int if the info object
      * was initialized with a cell.
      */
     unsigned int face_number;
@@ -85,7 +85,7 @@ namespace MeshWorker
     /**
      * The number of the current subface on the current face
      *
-     * This number is deal_II_numbers::invalid_unsigned_int if the info object
+     * This number is numbers::invalid_unsigned_int if the info object
      * was not initialized with a subface.
      */
     unsigned int sub_number;
@@ -308,8 +308,8 @@ namespace MeshWorker
     level_cell = c->is_level_cell();
 
     cell = typename Triangulation<dim,spacedim>::cell_iterator(*c);
-    face_number = deal_II_numbers::invalid_unsigned_int;
-    sub_number = deal_II_numbers::invalid_unsigned_int;
+    face_number = numbers::invalid_unsigned_int;
+    sub_number = numbers::invalid_unsigned_int;
     if (block_info)
       LocalResults<number>::reinit(block_info->local());
     else
@@ -326,7 +326,7 @@ namespace MeshWorker
   {
     face = static_cast<typename Triangulation<dim>::face_iterator> (f);
     face_number = face_no;
-    sub_number = deal_II_numbers::invalid_unsigned_int;
+    sub_number = numbers::invalid_unsigned_int;
   }
 
 
index 6bb519c10af577cedfd12476ee13d2e82a3d8a35..865b881e23444063402bb7fb3d2b11471c5b21e7 100644 (file)
@@ -252,7 +252,7 @@ namespace MeshWorker
     {
       BlockVector<double> *v;
       if (separate_faces &&
-          info.face_number != deal_II_numbers::invalid_unsigned_int)
+          info.face_number != numbers::invalid_unsigned_int)
         v = results.entry<BlockVector<double>*>(1);
       else
         v = results.entry<BlockVector<double>*>(0);
index bb3a5bc68a4cfa02b1e21899451b9cc994398fab..7269dac50f407bcb172253024fbd81b5d8e9536a 100644 (file)
@@ -665,13 +665,13 @@ namespace MeshWorker
     for (unsigned int i=0; i<fevalv.size(); ++i)
       {
         FEValuesBase<dim, spacedim> &febase = *fevalv[i];
-        if (info.sub_number != deal_II_numbers::invalid_unsigned_int)
+        if (info.sub_number != numbers::invalid_unsigned_int)
           {
             // This is a subface
             FESubfaceValues<dim> &fe = dynamic_cast<FESubfaceValues<dim>&> (febase);
             fe.reinit(info.cell, info.face_number, info.sub_number);
           }
-        else if (info.face_number != deal_II_numbers::invalid_unsigned_int)
+        else if (info.face_number != numbers::invalid_unsigned_int)
           {
             // This is a face
             FEFaceValues<dim> &fe = dynamic_cast<FEFaceValues<dim>&> (febase);
index a68215f47ebedfb6b86315a6937d94540b05f0af..a61d37ff7bb41243ac845da7d4b70f7a42522d8a 100644 (file)
@@ -628,8 +628,8 @@ QProjector<3>::project_to_subface (const Quadrature<2>    &quadrature,
   // indices tell, which global coordinate
   // (0->x, 1->y, 2->z) corresponds to which
   // local one
-  unsigned int xi_index   = deal_II_numbers::invalid_unsigned_int,
-               eta_index   = deal_II_numbers::invalid_unsigned_int,
+  unsigned int xi_index   = numbers::invalid_unsigned_int,
+               eta_index   = numbers::invalid_unsigned_int,
                const_index = face_no/2;
   // the xi and eta values have to be scaled
   // (by factor 0.5 or factor 1.0) depending on
@@ -1302,7 +1302,7 @@ subface (const unsigned int face_no,
   // ones.
 
   // first, define an invalid number
-  static const unsigned int e = deal_II_numbers::invalid_unsigned_int;
+  static const unsigned int e = numbers::invalid_unsigned_int;
 
   static const RefinementCase<dim-1>
   equivalent_refine_case[internal::SubfaceCase<dim>::case_isotropic+1][GeometryInfo<3>::max_children_per_face]
index 7e55c522a172bfac2f3f1250c190dd28b0e1b4ec..e297db0e21fd782be0f138b676953a2c1e84cd3a 100644 (file)
@@ -380,7 +380,7 @@ MappingQ<dim,spacedim>::fill_fe_face_values (
     p_data=&data;
 
   const unsigned int n_q_points=q.size();
-  this->compute_fill_face (cell, face_no, deal_II_numbers::invalid_unsigned_int,
+  this->compute_fill_face (cell, face_no, numbers::invalid_unsigned_int,
                            n_q_points,
                            QProjector<dim>::DataSetDescriptor::
                            face (face_no,
index 9ef3db43c1736cd7431639b2b12d7214aade498c..35295725e169cff81e742a3fe7213f2afd192ff2 100644 (file)
@@ -1028,7 +1028,7 @@ namespace internal
                   {
                     JxW_values[i] = boundary_forms[i].norm() * weights[i];
 
-                    if (subface_no!=deal_II_numbers::invalid_unsigned_int)
+                    if (subface_no!=numbers::invalid_unsigned_int)
                       {
                         const double area_ratio=GeometryInfo<dim>::subface_ratio(
                                                   cell->subface_case(face_no), subface_no);
@@ -1091,7 +1091,7 @@ fill_fe_face_values (const typename Triangulation<dim,spacedim>::cell_iterator &
 
   const unsigned int n_q_points = q.size();
 
-  compute_fill_face (cell, face_no, deal_II_numbers::invalid_unsigned_int,
+  compute_fill_face (cell, face_no, numbers::invalid_unsigned_int,
                      n_q_points,
                      DataSetDescriptor::face (face_no,
                                               cell->face_orientation(face_no),
index 7c9d633e09cd86abfffb654b1f74e54cbe0efecf..d6d13e3efd3aee30f2cf61a60bca4b873daa3fc1 100644 (file)
@@ -96,7 +96,7 @@ namespace
 
     const bool first_child_has_children=face->child(0)->has_children();
 
-    static const unsigned int e = deal_II_numbers::invalid_unsigned_int;
+    static const unsigned int e = numbers::invalid_unsigned_int;
 
     // array containing the translation of the
     // numbers,
@@ -1754,8 +1754,8 @@ CellAccessor<dim, spacedim>::neighbor_of_coarser_neighbor (const unsigned int ne
       // since then we did not find
       // our way back...
       Assert (false, ExcInternalError());
-      return std::make_pair (deal_II_numbers::invalid_unsigned_int,
-                             deal_II_numbers::invalid_unsigned_int);
+      return std::make_pair (numbers::invalid_unsigned_int,
+                             numbers::invalid_unsigned_int);
     }
 
     case 3:
index f7e2ad631acdde3a4600bd6836aaa3966a0ef5cd..f726c09f757c02c4aa98c87c05720c061012ad31 100644 (file)
@@ -47,7 +47,7 @@ test_selector(const NamedData<DATA> &data)
   for (unsigned int i=0; i<select.size(); ++i)
     {
       deallog << "Selection " << i << ':';
-      if (select(i) != deal_II_numbers::invalid_unsigned_int)
+      if (select(i) != numbers::invalid_unsigned_int)
         deallog << data.name(select(i)) << ' ' << *data(select(i));
       deallog << std::endl;
     }
index 95d31eac3bb22f04dd12230113a64026623496ce..0db28a43e17f14e831c6bce7918f636614e4a925 100644 (file)
@@ -162,7 +162,7 @@ BoundaryValues<dim>::value (const Point<dim>   &p,
 {
   double sum = 0;
   for (unsigned int d=0; d<dim; ++d)
-    sum += std::sin(deal_II_numbers::PI*p[d]);
+    sum += std::sin(numbers::PI*p[d]);
   return sum;
 }
 
index f8114c946b55b95cfc59ed9a3481bf9cc01d0546..9596bbaf4558ea1eeef5268266ef13afd0dcf9f2 100644 (file)
@@ -179,7 +179,7 @@ BoundaryValues<dim>::value (const Point<dim>   &p,
 {
   double sum = 0;
   for (unsigned int d=0; d<dim; ++d)
-    sum += std::sin(deal_II_numbers::PI*p[d]);
+    sum += std::sin(numbers::PI*p[d]);
   return sum;
 }
 
index ef1014cbfd68c593a76eb3bdf8745c0429c54fb9..a538ce2a690a244e9490535767c155cf021a7ca6 100644 (file)
@@ -162,7 +162,7 @@ BoundaryValues<dim>::value (const Point<dim>   &p,
 {
   double sum = 0;
   for (unsigned int d=0; d<dim; ++d)
-    sum += std::sin(deal_II_numbers::PI*p[d]);
+    sum += std::sin(numbers::PI*p[d]);
   return sum;
 }
 
index 6c49e229567471a4c0cceef0179a30fa902db82e..0035f1a21b3907ef0bd7129a76d0c159213dfb87 100644 (file)
@@ -178,7 +178,7 @@ BoundaryValues<dim>::value (const Point<dim>   &p,
 {
   double sum = 0;
   for (unsigned int d=0; d<dim; ++d)
-    sum += std::sin(deal_II_numbers::PI*p[d]);
+    sum += std::sin(numbers::PI*p[d]);
   return sum;
 }
 
index 827cc57c88d6b07dee7b6d37a54c4129f081f9e4..437526c946d0c5d4885cbebe5844fbc923bc578c 100644 (file)
@@ -118,7 +118,7 @@ BoundaryValues<dim>::value (const Point<dim>   &p,
 {
   double sum = 0;
   for (unsigned int d=0; d<dim; ++d)
-    sum += std::sin(deal_II_numbers::PI*p[d]);
+    sum += std::sin(numbers::PI*p[d]);
   return sum;
 }
 
index 3c1b969c64cb1a0b92a016478b7d65103b6c4f66..f83dd99ceeb6ef05c8bf188fd1fda18fd4478a97 100644 (file)
@@ -158,7 +158,7 @@ BoundaryValues<dim>::value (const Point<dim>   &p,
 {
   double sum = 0;
   for (unsigned int d=0; d<dim; ++d)
-    sum += std::sin(deal_II_numbers::PI*p[d]);
+    sum += std::sin(numbers::PI*p[d]);
   return sum;
 }
 
index ce2d131202d0730726f4a1535b0c68b99a23a63b..73fe5120beffeebbe49449704a2a05ffed2c4fc7 100644 (file)
@@ -162,7 +162,7 @@ BoundaryValues<dim>::value (const Point<dim>   &p,
 {
   double sum = 0;
   for (unsigned int d=0; d<dim; ++d)
-    sum += std::sin(deal_II_numbers::PI*p[d]);
+    sum += std::sin(numbers::PI*p[d]);
   return sum;
 }
 
index 3d2764ffbd64531f658775e4125798ec041fb4ae..71f8075c218cb1873283b2fb46545510b2e75d6d 100644 (file)
@@ -163,7 +163,7 @@ BoundaryValues<dim>::value (const Point<dim>   &p,
 {
   double sum = 0;
   for (unsigned int d=0; d<dim; ++d)
-    sum += std::sin(deal_II_numbers::PI*p[d]);
+    sum += std::sin(numbers::PI*p[d]);
   return sum;
 }
 
index 88e26813b0f6f7965494676a3ebf32b80282d91e..ea432a9c1ffe75eedeb49bab9f9c7e948dec62f3 100644 (file)
@@ -164,7 +164,7 @@ BoundaryValues<dim>::value (const Point<dim>   &p,
 {
   double sum = 0;
   for (unsigned int d=0; d<dim; ++d)
-    sum += std::sin(deal_II_numbers::PI*p[d]);
+    sum += std::sin(numbers::PI*p[d]);
   return sum;
 }
 
index ae74b9b472b0d55eccb5a3b88e0739aec665caac..bb40fbebd68ceb52f2dd79b6e5677c743e4fc5be 100644 (file)
@@ -165,7 +165,7 @@ BoundaryValues<dim>::value (const Point<dim>   &p,
 {
   double sum = 0;
   for (unsigned int d=0; d<dim; ++d)
-    sum += std::sin(deal_II_numbers::PI*p[d]);
+    sum += std::sin(numbers::PI*p[d]);
   return sum;
 }
 
index 471700dd6bd6f66bf173970098acc9edb464c8e0..10190d3a53cad1bcf13f7b4c54ee7caf2baa4ab8 100644 (file)
@@ -166,7 +166,7 @@ BoundaryValues<dim>::value (const Point<dim>   &p,
 {
   double sum = 0;
   for (unsigned int d=0; d<dim; ++d)
-    sum += std::sin(deal_II_numbers::PI*p[d]);
+    sum += std::sin(numbers::PI*p[d]);
   return sum;
 }
 
index ec33217ff9bb42ddd4925ad3bf2805748c6b1d48..c98aa8d44eba0ed1cd40a50f6d204302ee96b264 100644 (file)
@@ -163,7 +163,7 @@ BoundaryValues<dim>::value (const Point<dim>   &p,
 {
   double sum = 0;
   for (unsigned int d=0; d<dim; ++d)
-    sum += std::sin(deal_II_numbers::PI*p[d]);
+    sum += std::sin(numbers::PI*p[d]);
   return sum;
 }
 

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.