]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Rename namespace dealii::deal_II_numbers into namespace dealii::numbers.
authorWolfgang Bangerth <bangerth@math.tamu.edu>
Sat, 3 Nov 2007 03:08:43 +0000 (03:08 +0000)
committerWolfgang Bangerth <bangerth@math.tamu.edu>
Sat, 3 Nov 2007 03:08:43 +0000 (03:08 +0000)
git-svn-id: https://svn.dealii.org/trunk@15432 0785d39b-7218-0410-832d-ea1e28bc413d

90 files changed:
deal.II/base/include/base/data_out_base.h
deal.II/base/include/base/function_lib.h
deal.II/base/include/base/function_parser.h
deal.II/base/include/base/numbers.h
deal.II/base/include/base/table_indices.h
deal.II/base/include/base/utilities.h
deal.II/base/source/config.cc
deal.II/base/source/data_out_base.cc
deal.II/base/source/flow_function.cc
deal.II/base/source/function_lib_cutoff.cc
deal.II/base/source/geometry_info.cc
deal.II/base/source/parameter_handler.cc
deal.II/base/source/parsed_function.cc
deal.II/base/source/quadrature.cc
deal.II/base/source/quadrature_lib.cc
deal.II/base/source/utilities.cc
deal.II/deal.II/include/dofs/dof_accessor.templates.h
deal.II/deal.II/include/dofs/dof_constraints.templates.h
deal.II/deal.II/include/dofs/dof_handler.h
deal.II/deal.II/include/fe/fe.h
deal.II/deal.II/include/fe/fe_base.h
deal.II/deal.II/include/fe/fe_system.h
deal.II/deal.II/include/fe/mapping_cartesian.h
deal.II/deal.II/include/grid/grid_reordering_internal.h
deal.II/deal.II/include/grid/tria_accessor.templates.h
deal.II/deal.II/include/hp/dof_handler.h
deal.II/deal.II/include/hp/dof_objects.h
deal.II/deal.II/include/hp/fe_values.h
deal.II/deal.II/include/multigrid/mg_transfer_component.h
deal.II/deal.II/include/numerics/error_estimator.h
deal.II/deal.II/include/numerics/vectors.templates.h
deal.II/deal.II/source/dofs/dof_constraints.cc
deal.II/deal.II/source/dofs/dof_renumbering.cc
deal.II/deal.II/source/dofs/dof_tools.cc
deal.II/deal.II/source/fe/fe.cc
deal.II/deal.II/source/fe/fe_data.cc
deal.II/deal.II/source/fe/fe_dgq.cc
deal.II/deal.II/source/fe/fe_q.cc
deal.II/deal.II/source/fe/fe_system.cc
deal.II/deal.II/source/fe/fe_tools.cc
deal.II/deal.II/source/grid/grid_generator.cc
deal.II/deal.II/source/grid/grid_in.cc
deal.II/deal.II/source/grid/grid_out.cc
deal.II/deal.II/source/grid/grid_reordering.cc
deal.II/deal.II/source/grid/grid_tools.cc
deal.II/deal.II/source/grid/tria_accessor.cc
deal.II/deal.II/source/hp/dof_handler.cc
deal.II/deal.II/source/hp/fe_values.cc
deal.II/deal.II/source/multigrid/mg_dof_accessor.cc
deal.II/deal.II/source/multigrid/mg_dof_handler.cc
deal.II/deal.II/source/multigrid/mg_dof_tools.cc
deal.II/deal.II/source/multigrid/mg_transfer_block.cc
deal.II/deal.II/source/numerics/data_out.cc
deal.II/deal.II/source/numerics/data_out_rotation.cc
deal.II/deal.II/source/numerics/derivative_approximation.cc
deal.II/deal.II/source/numerics/error_estimator.cc
deal.II/deal.II/source/numerics/matrices.cc
deal.II/deal.II/source/numerics/time_dependent.cc
deal.II/doc/news/changes.h
deal.II/examples/step-23/step-23.cc
deal.II/examples/step-24/step-24.cc
deal.II/examples/step-25/step-25.cc
deal.II/examples/step-27/step-27.cc
deal.II/examples/step-9/step-9.cc
deal.II/lac/include/lac/block_matrix_base.h
deal.II/lac/include/lac/block_sparse_matrix_ez.h
deal.II/lac/include/lac/block_vector.h
deal.II/lac/include/lac/block_vector_base.h
deal.II/lac/include/lac/full_matrix.h
deal.II/lac/include/lac/full_matrix.templates.h
deal.II/lac/include/lac/matrix_lib.h
deal.II/lac/include/lac/matrix_lib.templates.h
deal.II/lac/include/lac/sparse_matrix.h
deal.II/lac/include/lac/sparse_matrix_ez.h
deal.II/lac/include/lac/sparsity_pattern.h
deal.II/lac/include/lac/vector.h
deal.II/lac/include/lac/vector.templates.h
deal.II/lac/source/petsc_matrix_base.cc
deal.II/lac/source/petsc_vector_base.cc
tests/base/functions_01.cc
tests/base/is_finite.cc
tests/bits/cylinder_04.cc
tests/bits/error_estimator_02.cc
tests/deal.II/line_coarsening_3d.cc
tests/fail/kelly_crash_01.cc
tests/hp/crash_17.cc
tests/hp/crash_17_compressed_set_sparsity.cc
tests/hp/crash_18.cc
tests/hp/crash_18_compressed_set_sparsity.cc
tests/lac/eigen.cc

index 42b847f4530f3f0035a82ebb464cc136bf635db8..3337780ce59b5d5d34eadd1aab3c447568d50d07 100644 (file)
@@ -406,7 +406,7 @@ class DataOutBase
                                          * patch has no neighbor on
                                          * one side.
                                          */
-       static const unsigned int no_neighbor = deal_II_numbers::invalid_unsigned_int;
+       static const unsigned int no_neighbor = numbers::invalid_unsigned_int;
                                         /** @addtogroup Exceptions
                                          * @{ */
        
index 135a0f58f4c722927bfd7824aefcb82c52449689..61a404d47a6e9aa9c6349f80179282a689154360 100644 (file)
@@ -820,7 +820,7 @@ namespace Functions
                                        * that no component is
                                        * selected.
                                        */
-      static const unsigned int no_component = deal_II_numbers::invalid_unsigned_int;
+      static const unsigned int no_component = numbers::invalid_unsigned_int;
 
                                       /**
                                        * Constructor. Arguments are the
index 10eb0158be6d2cf39b3c9ca053f969aad3212462..4afcf944e34cac8344b66b9199dea4ce19ebda7c 100644 (file)
@@ -54,7 +54,7 @@ template <typename> class Vector;
  * @verbatim
   // Define some constants that will be used by the function parser
   std::map<std::string> constants;
-  constants["pi"] = deal_II_numbers::PI;
+  constants["pi"] = numbers::PI;
   
   // Define the variables that will be used inside the expressions
   std::string variables = "x,y,z";
index 94af74c1e65691c78f0d2732ee1370b55ab7bc8a..2268f147bd1ccb4424483a025518e5c12dc37ba2 100644 (file)
@@ -34,7 +34,7 @@ DEAL_II_NAMESPACE_OPEN
  * the library as a marker for an invalid index, an invalid size of an
  * array, and similar purposes.
  */
-namespace deal_II_numbers
+namespace numbers
 {
                                   /**
                                    * Representation of the
@@ -147,6 +147,18 @@ namespace deal_II_numbers
   bool is_finite (const std::complex<long double> x);
 }
 
+
+/**
+ * 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;
+
+
+
 DEAL_II_NAMESPACE_CLOSE
 
 #endif
index 08ea523d21980cfcfd48d922583a8647c0e4f187..4670bdd6bc0e070036c998832935a6cf98ec644f 100644 (file)
@@ -171,7 +171,7 @@ class TableIndices<2> : public TableIndicesBase<2>
                                      * later indices.
                                       */
     TableIndices (const unsigned int index1,
-                  const unsigned int index2 = deal_II_numbers::invalid_unsigned_int);
+                  const unsigned int index2 = numbers::invalid_unsigned_int);
 };
 
 
@@ -214,8 +214,8 @@ class TableIndices<3> : public TableIndicesBase<3>
                                      * later indices.
                                       */
     TableIndices (const unsigned int index1,
-                  const unsigned int index2 = deal_II_numbers::invalid_unsigned_int,
-                  const unsigned int index3 = deal_II_numbers::invalid_unsigned_int);
+                  const unsigned int index2 = numbers::invalid_unsigned_int,
+                  const unsigned int index3 = numbers::invalid_unsigned_int);
 };
 
 
@@ -257,9 +257,9 @@ class TableIndices<4> : public TableIndicesBase<4>
                                      * later indices.
                                       */
     TableIndices (const unsigned int index1,
-                  const unsigned int index2 = deal_II_numbers::invalid_unsigned_int,
-                  const unsigned int index3 = deal_II_numbers::invalid_unsigned_int,
-                  const unsigned int index4 = deal_II_numbers::invalid_unsigned_int);
+                  const unsigned int index2 = numbers::invalid_unsigned_int,
+                  const unsigned int index3 = numbers::invalid_unsigned_int,
+                  const unsigned int index4 = numbers::invalid_unsigned_int);
 };
 
 
@@ -301,10 +301,10 @@ class TableIndices<5> : public TableIndicesBase<5>
                                      * later indices.
                                       */
     TableIndices (const unsigned int index1,
-                  const unsigned int index2 = deal_II_numbers::invalid_unsigned_int,
-                  const unsigned int index3 = deal_II_numbers::invalid_unsigned_int,
-                  const unsigned int index4 = deal_II_numbers::invalid_unsigned_int,
-                  const unsigned int index5 = deal_II_numbers::invalid_unsigned_int);
+                  const unsigned int index2 = numbers::invalid_unsigned_int,
+                  const unsigned int index3 = numbers::invalid_unsigned_int,
+                  const unsigned int index4 = numbers::invalid_unsigned_int,
+                  const unsigned int index5 = numbers::invalid_unsigned_int);
 };
 
 
@@ -346,11 +346,11 @@ class TableIndices<6> : public TableIndicesBase<6>
                                      * later indices.
                                       */
     TableIndices (const unsigned int index1,
-                  const unsigned int index2 = deal_II_numbers::invalid_unsigned_int,
-                  const unsigned int index3 = deal_II_numbers::invalid_unsigned_int,
-                  const unsigned int index4 = deal_II_numbers::invalid_unsigned_int,
-                  const unsigned int index5 = deal_II_numbers::invalid_unsigned_int,
-                  const unsigned int index6 = deal_II_numbers::invalid_unsigned_int);
+                  const unsigned int index2 = numbers::invalid_unsigned_int,
+                  const unsigned int index3 = numbers::invalid_unsigned_int,
+                  const unsigned int index4 = numbers::invalid_unsigned_int,
+                  const unsigned int index5 = numbers::invalid_unsigned_int,
+                  const unsigned int index6 = numbers::invalid_unsigned_int);
 };
 
 
@@ -392,12 +392,12 @@ class TableIndices<7> : public TableIndicesBase<7>
                                      * later indices.
                                       */
     TableIndices (const unsigned int index1,
-                  const unsigned int index2 = deal_II_numbers::invalid_unsigned_int,
-                  const unsigned int index3 = deal_II_numbers::invalid_unsigned_int,
-                  const unsigned int index4 = deal_II_numbers::invalid_unsigned_int,
-                  const unsigned int index5 = deal_II_numbers::invalid_unsigned_int,
-                  const unsigned int index6 = deal_II_numbers::invalid_unsigned_int,
-                  const unsigned int index7 = deal_II_numbers::invalid_unsigned_int);
+                  const unsigned int index2 = numbers::invalid_unsigned_int,
+                  const unsigned int index3 = numbers::invalid_unsigned_int,
+                  const unsigned int index4 = numbers::invalid_unsigned_int,
+                  const unsigned int index5 = numbers::invalid_unsigned_int,
+                  const unsigned int index6 = numbers::invalid_unsigned_int,
+                  const unsigned int index7 = numbers::invalid_unsigned_int);
 };
 
 
index af5ac3472a59bb68d2625e593ec5563f89c21e70..08472cb133670f511db9266c2a9f2cb4eedb6ffe 100644 (file)
@@ -48,7 +48,7 @@ namespace Utilities
                                     */
   std::string
   int_to_string (const unsigned int i,
-                const unsigned int digits = deal_II_numbers::invalid_unsigned_int);
+                const unsigned int digits = numbers::invalid_unsigned_int);
 
                                    /**
                                     * Determine how many digits are needed to
@@ -125,7 +125,7 @@ namespace Utilities
                                    *
                                    * If no integer can be read at the
                                    * indicated position, return
-                                   * (-1,deal_II_numbers::invalid_unsigned_int)
+                                   * (-1,numbers::invalid_unsigned_int)
                                    */
   std::pair<int, unsigned int>
   get_integer_at_position (const std::string &name,
index 46092dc9e1fe5bc9ac7cb9f95d0196d3e8864a10..4153b2a9ebd4f833af33cd40247b81e1681beec2 100644 (file)
@@ -19,7 +19,7 @@
 
 DEAL_II_NAMESPACE_OPEN
 
-namespace deal_II_numbers 
+namespace numbers 
 {
   bool is_finite (const double x) 
   {
index f141e53e44bf39e7ad912ac8fc0b868aa1537997..8799676162169c78dc6c67df2e4044615573be55 100644 (file)
@@ -687,7 +687,7 @@ namespace
   GmvStream::GmvStream (std::ostream& out,
                        const DataOutBase::GmvFlags f)
                  :
-                 selected_component(deal_II_numbers::invalid_unsigned_int),
+                 selected_component(numbers::invalid_unsigned_int),
                  stream(out), flags(f)
   {}
 
@@ -697,7 +697,7 @@ namespace
   GmvStream::write_point (const unsigned int,
                          const Point<dim>& p)
   {
-    Assert(selected_component != deal_II_numbers::invalid_unsigned_int,
+    Assert(selected_component != numbers::invalid_unsigned_int,
           ExcNotInitialized());
     stream << p(selected_component) << ' ';
   }
@@ -740,7 +740,7 @@ namespace
 
   TecplotStream::TecplotStream(std::ostream& out, const DataOutBase::TecplotFlags f)
                  :
-                 selected_component(deal_II_numbers::invalid_unsigned_int),
+                 selected_component(numbers::invalid_unsigned_int),
                  stream(out), flags(f)
   {}
 
@@ -750,7 +750,7 @@ namespace
   TecplotStream::write_point (const unsigned int,
                              const Point<dim>& p)
   {
-    Assert(selected_component != deal_II_numbers::invalid_unsigned_int,
+    Assert(selected_component != numbers::invalid_unsigned_int,
           ExcNotInitialized());
     stream << p(selected_component) << '\n';
   }
@@ -2782,7 +2782,7 @@ void DataOutBase::write_eps (const std::vector<Patch<dim,spacedim> > &patches,
                                             // the height field, I don't know
                                             // it.
            EpsCell2d eps_cell;
-           const double pi = deal_II_numbers::PI;
+           const double pi = numbers::PI;
            const double cx = -std::cos(pi-flags.azimut_angle * 2*pi / 360.),
                         cz = -std::cos(flags.turn_angle * 2*pi / 360.),
                         sx = std::sin(pi-flags.azimut_angle * 2*pi / 360.),
@@ -3103,7 +3103,7 @@ void DataOutBase::write_gmv (const std::vector<Patch<dim,spacedim> > &patches,
       write_nodes(patches, gmv_out);
       out << '\n';
     }
-  gmv_out.selected_component = deal_II_numbers::invalid_unsigned_int;
+  gmv_out.selected_component = numbers::invalid_unsigned_int;
 
   for (unsigned int d=spacedim;d<3;++d)
     {
index 74412a12b0e6fa41f4d57b7e118cdeca953528f3..629e98f90da6100052f94bc92249823c217a483f 100644 (file)
@@ -294,8 +294,8 @@ namespace Functions
     for (unsigned int k=0;k<n;++k)
       {
        const Point<dim>& p = points[k];
-       const double x = deal_II_numbers::PI/2. * p(0);
-       const double y = deal_II_numbers::PI/2. * p(1);
+       const double x = numbers::PI/2. * p(0);
+       const double y = numbers::PI/2. * p(1);
        const double cx = cos(x);
        const double cy = cos(y);
        const double sx = sin(x);
@@ -309,7 +309,7 @@ namespace Functions
          }
        else if (dim==3)
          {
-           const double z = deal_II_numbers::PI/2. * p(2);
+           const double z = numbers::PI/2. * p(2);
            const double cz = cos(z);
            const double sz = sin(z);
            
@@ -341,8 +341,8 @@ namespace Functions
     for (unsigned int k=0;k<n;++k)
       {
        const Point<dim>& p = points[k];
-       const double x = deal_II_numbers::PI/2. * p(0);
-       const double y = deal_II_numbers::PI/2. * p(1);
+       const double x = numbers::PI/2. * p(0);
+       const double y = numbers::PI/2. * p(1);
        const double c2x = cos(2*x);
        const double c2y = cos(2*y);
        const double s2x = sin(2*x);
@@ -352,35 +352,35 @@ namespace Functions
        
        if (dim==2)
          {
-           values[0][k][0] = -.25*deal_II_numbers::PI * s2x*s2y;
-           values[0][k][1] =  .5 *deal_II_numbers::PI * cx2*c2y;
-           values[1][k][0] = -.5 *deal_II_numbers::PI * c2x*cy2;
-           values[1][k][1] =  .25*deal_II_numbers::PI * s2x*s2y;
-           values[2][k][0] =  .25*deal_II_numbers::PI * c2x*s2y;
-           values[2][k][1] =  .25*deal_II_numbers::PI * s2x*c2y;
+           values[0][k][0] = -.25*numbers::PI * s2x*s2y;
+           values[0][k][1] =  .5 *numbers::PI * cx2*c2y;
+           values[1][k][0] = -.5 *numbers::PI * c2x*cy2;
+           values[1][k][1] =  .25*numbers::PI * s2x*s2y;
+           values[2][k][0] =  .25*numbers::PI * c2x*s2y;
+           values[2][k][1] =  .25*numbers::PI * s2x*c2y;
          }
        else if (dim==3)
          {
-           const double z = deal_II_numbers::PI/2. * p(2);
+           const double z = numbers::PI/2. * p(2);
            const double c2z = cos(2*z);
            const double s2z = sin(2*z);
            const double cz2 = .5+.5*c2z;               // cos^2 z
            
-           values[0][k][0] = -.125*deal_II_numbers::PI * s2x*s2y*s2z;
-           values[0][k][1] =  .25 *deal_II_numbers::PI * cx2*c2y*s2z;
-           values[0][k][2] =  .25 *deal_II_numbers::PI * cx2*s2y*c2z;
+           values[0][k][0] = -.125*numbers::PI * s2x*s2y*s2z;
+           values[0][k][1] =  .25 *numbers::PI * cx2*c2y*s2z;
+           values[0][k][2] =  .25 *numbers::PI * cx2*s2y*c2z;
            
-           values[1][k][0] =  .25 *deal_II_numbers::PI * c2x*cy2*s2z;
-           values[1][k][1] = -.125*deal_II_numbers::PI * s2x*s2y*s2z;
-           values[1][k][2] =  .25 *deal_II_numbers::PI * s2x*cy2*c2z;
+           values[1][k][0] =  .25 *numbers::PI * c2x*cy2*s2z;
+           values[1][k][1] = -.125*numbers::PI * s2x*s2y*s2z;
+           values[1][k][2] =  .25 *numbers::PI * s2x*cy2*c2z;
 
-           values[2][k][0] = -.5  *deal_II_numbers::PI * c2x*s2y*cz2;
-           values[2][k][1] = -.5  *deal_II_numbers::PI * s2x*c2y*cz2;
-           values[2][k][2] =  .25 *deal_II_numbers::PI * s2x*s2y*s2z;
+           values[2][k][0] = -.5  *numbers::PI * c2x*s2y*cz2;
+           values[2][k][1] = -.5  *numbers::PI * s2x*c2y*cz2;
+           values[2][k][2] =  .25 *numbers::PI * s2x*s2y*s2z;
 
-           values[3][k][0] = .125*deal_II_numbers::PI * c2x*s2y*s2z;
-           values[3][k][1] = .125*deal_II_numbers::PI * s2x*c2y*s2z;
-           values[3][k][2] = .125*deal_II_numbers::PI * s2x*s2y*c2z;
+           values[3][k][0] = .125*numbers::PI * c2x*s2y*s2z;
+           values[3][k][1] = .125*numbers::PI * s2x*c2y*s2z;
+           values[3][k][2] = .125*numbers::PI * s2x*s2y*c2z;
          }
        else
          {
@@ -405,29 +405,29 @@ namespace Functions
     for (unsigned int k=0;k<n;++k)
       {
        const Point<dim>& p = points[k];
-       const double x = deal_II_numbers::PI/2. * p(0);
-       const double y = deal_II_numbers::PI/2. * p(1);
+       const double x = numbers::PI/2. * p(0);
+       const double y = numbers::PI/2. * p(1);
        const double c2x = cos(2*x);
        const double c2y = cos(2*y);
        const double s2x = sin(2*x);
        const double s2y = sin(2*y);
-       const double pi2 = .25 * deal_II_numbers::PI * deal_II_numbers::PI;
+       const double pi2 = .25 * numbers::PI * numbers::PI;
        
        if (dim==2)
          {
-           values[0][k] = - pi2 * (1.+2.*c2x) * s2y - deal_II_numbers::PI/4. * c2x*s2y;
-           values[1][k] =   pi2 * s2x * (1.+2.*c2y) - deal_II_numbers::PI/4. * s2x*c2y;
+           values[0][k] = - pi2 * (1.+2.*c2x) * s2y - numbers::PI/4. * c2x*s2y;
+           values[1][k] =   pi2 * s2x * (1.+2.*c2y) - numbers::PI/4. * s2x*c2y;
            values[2][k] = 0.;
          }
        else if (dim==3)
          {
-           const double z = deal_II_numbers::PI * p(2);
+           const double z = numbers::PI * p(2);
            const double c2z = cos(2*z);
            const double s2z = sin(2*z);
            
-           values[0][k] = - .5*pi2 * (1.+2.*c2x) * s2y * s2z - deal_II_numbers::PI/8. * c2x * s2y * s2z;
-           values[1][k] =   .5*pi2 * s2x * (1.+2.*c2y) * s2z - deal_II_numbers::PI/8. * s2x * c2y * s2z;
-           values[2][k] = - .5*pi2 * s2x * s2y * (1.+2.*c2z) - deal_II_numbers::PI/8. * s2x * s2y * c2z;
+           values[0][k] = - .5*pi2 * (1.+2.*c2x) * s2y * s2z - numbers::PI/8. * c2x * s2y * s2z;
+           values[1][k] =   .5*pi2 * s2x * (1.+2.*c2y) * s2z - numbers::PI/8. * s2x * c2y * s2z;
+           values[2][k] = - .5*pi2 * s2x * s2y * (1.+2.*c2z) - numbers::PI/8. * s2x * s2y * c2z;
            values[3][k] = 0.;
          }
        else
@@ -444,7 +444,7 @@ namespace Functions
   
   StokesLSingularity::StokesLSingularity()
                  :
-                 omega (3./2.*deal_II_numbers::PI),
+                 omega (3./2.*numbers::PI),
                  coslo (cos(lambda*omega)),
                  lp(1.+lambda),
                  lm(1.-lambda)
@@ -639,11 +639,11 @@ namespace Functions
       {
        const Point<2>& p = points[k];
        const double x = p(0);
-       const double y = 2. * deal_II_numbers::PI * p(1);
+       const double y = 2. * numbers::PI * p(1);
        const double elx = std::exp(lbda*x);
        
        values[0][k] = 1. - elx * cos(y);
-       values[1][k] = .5 / deal_II_numbers::PI * lbda * elx * sin(y);
+       values[1][k] = .5 / numbers::PI * lbda * elx * sin(y);
        values[2][k] = -.5 * elx * elx + p_average - this->mean_pressure;
       }
   }
@@ -670,7 +670,7 @@ namespace Functions
        
                                         // u
        gradients[0][i][0] = -lbda*elx*cy;
-       gradients[0][i][1] = 2. * deal_II_numbers::PI*elx*sy;
+       gradients[0][i][1] = 2. * numbers::PI*elx*sy;
        gradients[1][i][0] = lbda*lbda/(2*M_PI)*elx*sy;
        gradients[1][i][1] =lbda*elx*cy;
                                         // p
@@ -692,7 +692,7 @@ namespace Functions
 
     if (stokes)
       {
-       const double zp = 2. * deal_II_numbers::PI;
+       const double zp = 2. * numbers::PI;
        for (unsigned int k=0;k<n;++k)
          {
            const Point<2>& p = points[k];
index 06fa53fd185403142be6ff37818900920108e9ae..480a282a131776ca0ecfc7f9379bdda76be40d40 100644 (file)
@@ -226,7 +226,7 @@ namespace Functions
        if (d>=r)
          return 0.;
        const double e = -r*r/(r*r-d*d);
-       return  ((e<-50) ? 0. : deal_II_numbers::E * exp(e));
+       return  ((e<-50) ? 0. : numbers::E * exp(e));
       }
     return 0.;
   }
@@ -254,7 +254,7 @@ namespace Functions
              values[i] = 0.;
            } else {
              const double e = -r*r/(r*r-d*d);
-             values[i] = (e<-50) ? 0. : deal_II_numbers::E * exp(e);
+             values[i] = (e<-50) ? 0. : numbers::E * exp(e);
            }
        }
     else
@@ -281,7 +281,7 @@ namespace Functions
          {
            e = -r*r/(r*r-d*d);
            if (e>-50)
-             val = deal_II_numbers::E * exp(e);
+             val = numbers::E * exp(e);
          }
 
        if (this->selected==CutOffFunctionBase<dim>::no_component)
index af85a5ee8df628887a89ab65381959add1ced405..0e006ca5c4d3ad8c45b75716fa2297810d6e1997 100644 (file)
@@ -29,7 +29,7 @@ template <int dim> const unsigned int GeometryInfo<dim>::quads_per_cell;
 template <int dim> const unsigned int GeometryInfo<dim>::hexes_per_cell;
 
 
-using namespace deal_II_numbers;
+using namespace numbers;
 
 // make sure that also the icc compiler defines (and not only declares) 
 // these variables
index 2b8ded2088436f77f9031e156d2e607c34e84127..a31ee4f02b37b6fa6cd91f5554ad2447dda25fbd 100644 (file)
@@ -269,7 +269,7 @@ namespace Patterns
 #ifdef HAVE_STD_NUMERIC_LIMITS
           std::numeric_limits<unsigned int>::max();
 #else
-          deal_II_numbers::invalid_unsigned_int;
+          numbers::invalid_unsigned_int;
 #endif
 
 
index 3ff828199c6f2454d89beab49eced38b4dc402e0..7619ae79d8fed2c5de26eea3ec24d94d0e71a203 100644 (file)
@@ -88,8 +88,8 @@ namespace Functions {
        constants[this_c[0]] = tmp;
       }
     
-    constants["pi"] = deal_II_numbers::PI;
-    constants["Pi"] = deal_II_numbers::PI;
+    constants["pi"] = numbers::PI;
+    constants["Pi"] = numbers::PI;
 
     unsigned int nn = (Utilities::split_string_list(vnames)).size();
     switch (nn)
index 0978b12a1d99e58bf26faebe81e8853c120db3d0..af50860b19b47f0f872e28dc3d801c4484d0bb58 100644 (file)
@@ -176,7 +176,7 @@ template <>
 Quadrature<1>::Quadrature (const Quadrature<0> &)
                :
                Subscriptor(),
-               n_quadrature_points (deal_II_numbers::invalid_unsigned_int),
+               n_quadrature_points (numbers::invalid_unsigned_int),
                quadrature_points (),
                weights ()
 {
@@ -1140,7 +1140,7 @@ face (const unsigned int face_no,
       default:
             Assert (false, ExcInternalError());
     }
-  return deal_II_numbers::invalid_unsigned_int;
+  return numbers::invalid_unsigned_int;
 }
 
 
@@ -1215,7 +1215,7 @@ subface (const unsigned int face_no,
       default:
             Assert (false, ExcInternalError());
     }
-  return deal_II_numbers::invalid_unsigned_int;              
+  return numbers::invalid_unsigned_int;              
 }
 
 
@@ -1239,7 +1239,7 @@ template <int dim>
 QProjector<dim>::DataSetDescriptor::
 DataSetDescriptor ()
                 :
-                dataset_offset (deal_II_numbers::invalid_unsigned_int)
+                dataset_offset (numbers::invalid_unsigned_int)
 {}
 
 
index 7e91805cea4bc9b68a02749691f68d93d28a8f2e..e2406c5a378cd63faedee671776b32f2637a55aa 100644 (file)
@@ -118,7 +118,7 @@ QGauss<1>::QGauss (const unsigned int n)
   
   for (unsigned int i=1; i<=m; ++i)
     {
-      long double z = std::cos(deal_II_numbers::PI * (i-.25)/(n+.5));
+      long double z = std::cos(numbers::PI * (i-.25)/(n+.5));
 
       long double pp;
       long double p1, p2, p3;
index 57fbc12847be6eb4425fb044b6578b18e3602e47..be1ae32579b1acfbe60becb84605f29ae54fa7bb 100644 (file)
@@ -58,7 +58,7 @@ namespace Utilities
   {
                                     // if second argument is invalid, then do
                                     // not pad the resulting string at all
-    if (digits == deal_II_numbers::invalid_unsigned_int)
+    if (digits == numbers::invalid_unsigned_int)
       return int_to_string (i, needed_digits(i));
     
     
@@ -291,11 +291,11 @@ namespace Utilities
        else
          {
            Assert (false, ExcNotImplemented());
-           return std::make_pair (-1, deal_II_numbers::invalid_unsigned_int);
+           return std::make_pair (-1, numbers::invalid_unsigned_int);
          }
       }
     else
-      return std::make_pair (-1, deal_II_numbers::invalid_unsigned_int);
+      return std::make_pair (-1, numbers::invalid_unsigned_int);
   }
 
   
index 393ba04d52e206e3d2430c4425fa5c64dd1e28ca..b78b44a424e485c6b76be31fb36dda7f7cf5c389 100644 (file)
@@ -34,8 +34,8 @@ template <int structdim, class DH>
 DoFAccessor<structdim,DH>::DoFAccessor ()
                 :
                DoFObjectAccessor_Inheritance<structdim, DH::dimension>::BaseClass (0,
-                                                                                   deal_II_numbers::invalid_unsigned_int,
-                                                                                   deal_II_numbers::invalid_unsigned_int),
+                                                                                   numbers::invalid_unsigned_int,
+                                                                                   numbers::invalid_unsigned_int),
                dof_handler(0)
 {
   Assert (false, ExcInvalidObject());
index 6a88ad2b795ad5bd9798cafda184251a93b4273e..c264bbc178f26ec8e8d257f9e1deda30661730f8 100644 (file)
@@ -175,7 +175,7 @@ ConstraintMatrix::condense (SparseMatrix<number> &uncondensed) const
                                   // which line in the constraint matrix
                                   // handles this index
   std::vector<unsigned int> distribute (sparsity.n_rows(),
-                                        deal_II_numbers::invalid_unsigned_int);
+                                        numbers::invalid_unsigned_int);
   
   for (unsigned int c=0; c<lines.size(); ++c)
     distribute[lines[c].line] = c;
@@ -183,7 +183,7 @@ ConstraintMatrix::condense (SparseMatrix<number> &uncondensed) const
   const unsigned int n_rows = sparsity.n_rows();
   for (unsigned int row=0; row<n_rows; ++row)
     {
-      if (distribute[row] == deal_II_numbers::invalid_unsigned_int)
+      if (distribute[row] == numbers::invalid_unsigned_int)
                                         // regular line. loop over cols
         {
           for (typename SparseMatrix<number>::iterator
@@ -200,7 +200,7 @@ ConstraintMatrix::condense (SparseMatrix<number> &uncondensed) const
               Assert (column != SparsityPattern::invalid_entry,
                       ExcMatrixNotClosed());
            
-              if (distribute[column] != deal_II_numbers::invalid_unsigned_int)
+              if (distribute[column] != numbers::invalid_unsigned_int)
                                                  // distribute entry at
                                                  // regular row @p row
                                                  // and irregular column
@@ -237,7 +237,7 @@ ConstraintMatrix::condense (SparseMatrix<number> &uncondensed) const
               Assert (column != SparsityPattern::invalid_entry,
                       ExcMatrixNotClosed());
 
-              if (distribute[column] == deal_II_numbers::invalid_unsigned_int)
+              if (distribute[column] == numbers::invalid_unsigned_int)
                                                  // distribute entry at
                                                  // irregular row
                                                  // @p row and regular
@@ -314,13 +314,13 @@ ConstraintMatrix::condense (BlockSparseMatrix<number> &uncondensed) const
   
                                   // store for each index whether it must be
                                   // distributed or not. If entry is
-                                  // deal_II_numbers::invalid_unsigned_int,
+                                  // numbers::invalid_unsigned_int,
                                   // no distribution is necessary.
                                   // otherwise, the number states which line
                                   // in the constraint matrix handles this
                                   // index
   std::vector<unsigned int> distribute (sparsity.n_rows(),
-                                        deal_II_numbers::invalid_unsigned_int);
+                                        numbers::invalid_unsigned_int);
   
   for (unsigned int c=0; c<lines.size(); ++c)
     distribute[lines[c].line] = c;
@@ -334,7 +334,7 @@ ConstraintMatrix::condense (BlockSparseMatrix<number> &uncondensed) const
        block_index = index_mapping.global_to_local(row);
       const unsigned int block_row = block_index.first;
       
-      if (distribute[row] == deal_II_numbers::invalid_unsigned_int)
+      if (distribute[row] == numbers::invalid_unsigned_int)
                                         // regular line. loop over
                                         // all columns and see
                                         // whether this column must
@@ -357,7 +357,7 @@ ConstraintMatrix::condense (BlockSparseMatrix<number> &uncondensed) const
                   const unsigned int global_col
                     = index_mapping.local_to_global(block_col,entry->column());
                    
-                  if (distribute[global_col] != deal_II_numbers::invalid_unsigned_int)
+                  if (distribute[global_col] != numbers::invalid_unsigned_int)
                                                      // distribute entry at
                                                      // regular row @p row
                                                      // and irregular column
@@ -396,7 +396,7 @@ ConstraintMatrix::condense (BlockSparseMatrix<number> &uncondensed) const
                     = index_mapping.local_to_global (block_col, entry->column());
                    
                   if (distribute[global_col] ==
-                      deal_II_numbers::invalid_unsigned_int)
+                      numbers::invalid_unsigned_int)
                                                      // distribute
                                                      // entry at
                                                      // irregular
index 6cf0ba08e97c606aa920677113a03cb86d0b3b35..1f9ec0668ff1d1da02bf778089431176e8815cf9 100644 (file)
@@ -156,7 +156,7 @@ class DoFHandler  :  public Subscriptor
                                      * certain value, but rather take
                                      * its symbolic name.
                                      */
-    static const unsigned int invalid_dof_index = deal_II_numbers::invalid_unsigned_int;
+    static const unsigned int invalid_dof_index = numbers::invalid_unsigned_int;
 
                                     /**
                                      * The default index of the
index 195fc95c63826c87ca676339feb64f3c9dc699e2..4c8006bdf3694bd3442823683bf73a9ed62857c4 100644 (file)
@@ -2610,8 +2610,8 @@ FiniteElement<dim>::block_to_base_index (const unsigned int index) const
     if (first_block_of_base_table[i] <= index)
       return std::pair<unsigned int, unsigned int>(static_cast<unsigned int> (i),
                                                   index - first_block_of_base_table[i]);
-  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);
 }
 
 
index 6c642008209c61da988c31379d22cd723e0413ed..bec4e3cc44faf436b951fee0b8491b0416b38f40 100644 (file)
@@ -445,7 +445,7 @@ class FiniteElementData
                       const unsigned int n_components,
                       const unsigned int degree,
                       const Conformity conformity = unknown,
-                      const unsigned int n_blocks = deal_II_numbers::invalid_unsigned_int);
+                      const unsigned int n_blocks = numbers::invalid_unsigned_int);
 
                                     /**
                                      * Number of dofs per vertex.
@@ -735,7 +735,7 @@ FiniteElementData<dim>::n_dofs_per_object () const
       default:
            Assert (false, ExcInternalError());
     }
-  return deal_II_numbers::invalid_unsigned_int;
+  return numbers::invalid_unsigned_int;
 }
 
 
index bd42e9fb3318b3722cd852fb6c79d1530fe13374..a8abf92fd789d0d366795ce8c5affa0ed6b3b530 100644 (file)
@@ -689,7 +689,7 @@ class FESystem : public FiniteElement<dim>
                                      * face or subface number is
                                      * invalid.
                                      */
-    static const unsigned int invalid_face_number = deal_II_numbers::invalid_unsigned_int;
+    static const unsigned int invalid_face_number = numbers::invalid_unsigned_int;
     
                                     /**
                                      * Pairs of multiplicity and
index bdc3ff0a540bf6955f7d3ce7f8860517bf8f513e..5a4282c1b45bdd00495790ff9e270795aca823ba 100644 (file)
@@ -218,7 +218,7 @@ class MappingCartesian : public Mapping<dim>
                                      * face or subface number is
                                      * invalid.
                                      */
-    static const unsigned int invalid_face_number = deal_II_numbers::invalid_unsigned_int;    
+    static const unsigned int invalid_face_number = numbers::invalid_unsigned_int;    
 };
 
 /*@}*/
index 54f40cad68cddb8b7bc862df9785fca801bd0d9c..8e9d4cac440c8a8af80b0362a6156016d5666cb8 100644 (file)
@@ -531,7 +531,7 @@ namespace internal
                                           * class of parallel edges
                                           * the edge falls in when
                                           * oriented.
-                                          * deal_II_numbers::invalid_unsigned_int
+                                          * numbers::invalid_unsigned_int
                                           * means not yet
                                           * decided. This is also the
                                           * default value after
index 4a7183ff5888d7607acd390f78580f7c9177553b..f7a251b7bd0200ed5001c77da071582306a4864f 100644 (file)
@@ -1307,7 +1307,7 @@ unsigned int
 CellAccessor<1>::face_index (const unsigned int) const 
 {
   Assert (false, ExcImpossibleInDim(1));
-  return deal_II_numbers::invalid_unsigned_int;
+  return numbers::invalid_unsigned_int;
 }
 
 
index 82014169e4b2da275952e53ff93b187849e79ce5..b2a495dae5254b36766f05ce05dc5bc03f4ac64f 100644 (file)
@@ -103,7 +103,7 @@ namespace hp
                                         * certain value, but rather take
                                         * its symbolic name.
                                         */
-      static const unsigned int invalid_dof_index = deal_II_numbers::invalid_unsigned_int;
+      static const unsigned int invalid_dof_index = numbers::invalid_unsigned_int;
 
                                       /**
                                        * The default index of the
@@ -127,7 +127,7 @@ namespace hp
                                        * corresponds to an invalid
                                        * value.
                                        */
-      static const unsigned int default_fe_index = deal_II_numbers::invalid_unsigned_int;
+      static const unsigned int default_fe_index = numbers::invalid_unsigned_int;
 
       
                                        /**
@@ -1459,7 +1459,7 @@ namespace hp
     Assert (vertex_index < vertex_dofs_offsets.size(),
            ExcIndexRange (vertex_index, 0, vertex_dofs_offsets.size()));
     Assert (vertex_dofs_offsets[vertex_index] !=
-           deal_II_numbers::invalid_unsigned_int,
+           numbers::invalid_unsigned_int,
            ExcMessage ("This vertex is unused and has no DoFs associated with it"));
 
                                     // hop along the list of index
@@ -1477,7 +1477,7 @@ namespace hp
 
        const unsigned int this_fe_index = *pointer;
        
-       Assert (this_fe_index != deal_II_numbers::invalid_unsigned_int,
+       Assert (this_fe_index != numbers::invalid_unsigned_int,
                ExcInternalError());
        Assert (this_fe_index < finite_elements->size(),
                ExcInternalError());
@@ -1512,7 +1512,7 @@ namespace hp
     Assert (fe_index < finite_elements->size(),
            ExcInternalError());
     Assert (vertex_dofs_offsets[vertex_index] !=
-           deal_II_numbers::invalid_unsigned_int,
+           numbers::invalid_unsigned_int,
            ExcMessage ("This vertex is unused and has no DoFs associated with it"));
 
                                     // hop along the list of index
@@ -1530,7 +1530,7 @@ namespace hp
 
        const unsigned int this_fe_index = *pointer;
        
-       Assert (this_fe_index != deal_II_numbers::invalid_unsigned_int,
+       Assert (this_fe_index != numbers::invalid_unsigned_int,
                ExcInternalError());
        Assert (this_fe_index < finite_elements->size(),
                ExcInternalError());
@@ -1558,7 +1558,7 @@ namespace hp
                        "this DoFHandler"));
 
                                     // if this vertex is unused, return 0
-    if (vertex_dofs_offsets[vertex_index] == deal_II_numbers::invalid_unsigned_int)
+    if (vertex_dofs_offsets[vertex_index] == numbers::invalid_unsigned_int)
       return 0;
 
                                     // hop along the list of index
@@ -1567,7 +1567,7 @@ namespace hp
     const unsigned int starting_offset = vertex_dofs_offsets[vertex_index];
     const unsigned int *pointer        = &vertex_dofs[starting_offset];
 
-    Assert (*pointer != deal_II_numbers::invalid_unsigned_int,
+    Assert (*pointer != numbers::invalid_unsigned_int,
            ExcInternalError());
     
     unsigned int counter = 0;
@@ -1577,7 +1577,7 @@ namespace hp
 
        const unsigned int this_fe_index = *pointer;
        
-       if (this_fe_index == deal_II_numbers::invalid_unsigned_int)
+       if (this_fe_index == numbers::invalid_unsigned_int)
          return counter;
        else
          {
@@ -1604,7 +1604,7 @@ namespace hp
                                     // make sure we don't ask on
                                     // unused vertices
     Assert (vertex_dofs_offsets[vertex_index] !=
-           deal_II_numbers::invalid_unsigned_int,
+           numbers::invalid_unsigned_int,
            ExcInternalError());
 
                                     // hop along the list of index
@@ -1613,7 +1613,7 @@ namespace hp
     const unsigned int starting_offset = vertex_dofs_offsets[vertex_index];
     const unsigned int *pointer        = &vertex_dofs[starting_offset];
 
-    Assert (*pointer != deal_II_numbers::invalid_unsigned_int,
+    Assert (*pointer != numbers::invalid_unsigned_int,
            ExcInternalError());
     
     unsigned int counter = 0;
@@ -1629,7 +1629,7 @@ namespace hp
        if (counter == n)
          return this_fe_index;
 
-       Assert (this_fe_index != deal_II_numbers::invalid_unsigned_int,
+       Assert (this_fe_index != numbers::invalid_unsigned_int,
                ExcInternalError());
        
        pointer += (*finite_elements)[this_fe_index].dofs_per_vertex + 1;
@@ -1658,7 +1658,7 @@ namespace hp
                                     // make sure we don't ask on
                                     // unused vertices
     Assert (vertex_dofs_offsets[vertex_index] !=
-           deal_II_numbers::invalid_unsigned_int,
+           numbers::invalid_unsigned_int,
            ExcInternalError());
 
                                     // hop along the list of index
@@ -1667,7 +1667,7 @@ namespace hp
     const unsigned int starting_offset = vertex_dofs_offsets[vertex_index];
     const unsigned int *pointer        = &vertex_dofs[starting_offset];
 
-    Assert (*pointer != deal_II_numbers::invalid_unsigned_int,
+    Assert (*pointer != numbers::invalid_unsigned_int,
            ExcInternalError());
     
     while (true)
@@ -1679,7 +1679,7 @@ namespace hp
        Assert (this_fe_index < finite_elements->size(),
                ExcInternalError());
 
-       if (this_fe_index == deal_II_numbers::invalid_unsigned_int)
+       if (this_fe_index == numbers::invalid_unsigned_int)
          return false;
        else
          if (this_fe_index == fe_index)
index 745fafd82b5cf7e9f382032a3410e07271fb5e09..a393750e2ae9faed16286e2dc882fa92bb17d122 100644 (file)
@@ -285,7 +285,7 @@ namespace internal
                                        // make sure we are on an
                                        // object for which DoFs have
                                        // been allocated at all
-      Assert (dof_offsets[obj_index] != deal_II_numbers::invalid_unsigned_int,
+      Assert (dof_offsets[obj_index] != numbers::invalid_unsigned_int,
               ExcMessage ("You are trying to access degree of freedom "
                           "information for an object on which no such "
                           "information is available"));
@@ -321,7 +321,7 @@ namespace internal
           const unsigned int *pointer        = &dofs[starting_offset];
           while (true)
             {
-              Assert (*pointer != deal_II_numbers::invalid_unsigned_int,
+              Assert (*pointer != numbers::invalid_unsigned_int,
                       ExcInternalError());
               if (*pointer == fe_index)
                 return *(pointer + 1 + local_index);
@@ -367,7 +367,7 @@ namespace internal
                                        // make sure we are on an
                                        // object for which DoFs have
                                        // been allocated at all
-      Assert (dof_offsets[obj_index] != deal_II_numbers::invalid_unsigned_int,
+      Assert (dof_offsets[obj_index] != numbers::invalid_unsigned_int,
               ExcMessage ("You are trying to access degree of freedom "
                           "information for an object on which no such "
                           "information is available"));
@@ -403,7 +403,7 @@ namespace internal
           unsigned int      *pointer         = &dofs[starting_offset];
           while (true)
             {
-              Assert (*pointer != deal_II_numbers::invalid_unsigned_int,
+              Assert (*pointer != numbers::invalid_unsigned_int,
                       ExcInternalError());
               if (*pointer == fe_index)
                 {
@@ -439,7 +439,7 @@ namespace internal
                                        // make sure we are on an
                                        // object for which DoFs have
                                        // been allocated at all
-      if (dof_offsets[obj_index] == deal_II_numbers::invalid_unsigned_int)
+      if (dof_offsets[obj_index] == numbers::invalid_unsigned_int)
        return 0;
       
                                        // if we are on a cell, then the
@@ -467,7 +467,7 @@ namespace internal
           unsigned int counter = 0;
           while (true)
             {
-              if (*pointer == deal_II_numbers::invalid_unsigned_int)
+              if (*pointer == numbers::invalid_unsigned_int)
                                                  // end of list reached
                 return counter;
               else
@@ -504,7 +504,7 @@ namespace internal
                                        // make sure we are on an
                                        // object for which DoFs have
                                        // been allocated at all
-      Assert (dof_offsets[obj_index] != deal_II_numbers::invalid_unsigned_int,
+      Assert (dof_offsets[obj_index] != numbers::invalid_unsigned_int,
               ExcMessage ("You are trying to access degree of freedom "
                           "information for an object on which no such "
                           "information is available"));
@@ -542,7 +542,7 @@ namespace internal
           unsigned int counter = 0;
           while (true)
             {
-              Assert (*pointer != deal_II_numbers::invalid_unsigned_int,
+              Assert (*pointer != numbers::invalid_unsigned_int,
                       ExcInternalError());
 
               const unsigned int fe_index = *pointer;
@@ -588,7 +588,7 @@ namespace internal
                                        // make sure we are on an
                                        // object for which DoFs have
                                        // been allocated at all
-      Assert (dof_offsets[obj_index] != deal_II_numbers::invalid_unsigned_int,
+      Assert (dof_offsets[obj_index] != numbers::invalid_unsigned_int,
               ExcMessage ("You are trying to access degree of freedom "
                           "information for an object on which no such "
                           "information is available"));
@@ -623,7 +623,7 @@ namespace internal
           const unsigned int *pointer        = &dofs[starting_offset];
           while (true)
             {
-              if (*pointer == deal_II_numbers::invalid_unsigned_int)
+              if (*pointer == numbers::invalid_unsigned_int)
                                                  // end of list reached
                 return false;
               else
index 11298a14148463967b622d9bf032604e2fe966a2..ba36a94d52c453a1f2d4cfec8cfe7c03a1eba65e 100644 (file)
@@ -390,9 +390,9 @@ namespace hp
                                         */
       void
       reinit (const typename hp::DoFHandler<dim>::cell_iterator &cell,
-              const unsigned int q_index = deal_II_numbers::invalid_unsigned_int,
-              const unsigned int mapping_index = deal_II_numbers::invalid_unsigned_int,
-              const unsigned int fe_index = deal_II_numbers::invalid_unsigned_int);
+              const unsigned int q_index = numbers::invalid_unsigned_int,
+              const unsigned int mapping_index = numbers::invalid_unsigned_int,
+              const unsigned int fe_index = numbers::invalid_unsigned_int);
 
                                        /**
                                         * Like the previous function,
@@ -425,9 +425,9 @@ namespace hp
                                         */
       void
       reinit (const typename dealii::DoFHandler<dim>::cell_iterator &cell,
-              const unsigned int q_index = deal_II_numbers::invalid_unsigned_int,
-              const unsigned int mapping_index = deal_II_numbers::invalid_unsigned_int,
-              const unsigned int fe_index = deal_II_numbers::invalid_unsigned_int);
+              const unsigned int q_index = numbers::invalid_unsigned_int,
+              const unsigned int mapping_index = numbers::invalid_unsigned_int,
+              const unsigned int fe_index = numbers::invalid_unsigned_int);
 
                                        /**
                                         * Like the previous function,
@@ -460,9 +460,9 @@ namespace hp
                                         */
       void
       reinit (const typename MGDoFHandler<dim>::cell_iterator &cell,
-              const unsigned int q_index = deal_II_numbers::invalid_unsigned_int,
-              const unsigned int mapping_index = deal_II_numbers::invalid_unsigned_int,
-              const unsigned int fe_index = deal_II_numbers::invalid_unsigned_int);
+              const unsigned int q_index = numbers::invalid_unsigned_int,
+              const unsigned int mapping_index = numbers::invalid_unsigned_int,
+              const unsigned int fe_index = numbers::invalid_unsigned_int);
       
                                        /**
                                         * Like the previous function,
@@ -496,9 +496,9 @@ namespace hp
                                         */
       void
       reinit (const typename Triangulation<dim>::cell_iterator &cell,
-              const unsigned int q_index = deal_II_numbers::invalid_unsigned_int,
-              const unsigned int mapping_index = deal_II_numbers::invalid_unsigned_int,
-              const unsigned int fe_index = deal_II_numbers::invalid_unsigned_int);
+              const unsigned int q_index = numbers::invalid_unsigned_int,
+              const unsigned int mapping_index = numbers::invalid_unsigned_int,
+              const unsigned int fe_index = numbers::invalid_unsigned_int);
   };
 
 
@@ -684,9 +684,9 @@ namespace hp
       void
       reinit (const typename hp::DoFHandler<dim>::cell_iterator &cell,
               const unsigned int face_no,
-              const unsigned int q_index = deal_II_numbers::invalid_unsigned_int,
-              const unsigned int mapping_index = deal_II_numbers::invalid_unsigned_int,
-              const unsigned int fe_index = deal_II_numbers::invalid_unsigned_int);
+              const unsigned int q_index = numbers::invalid_unsigned_int,
+              const unsigned int mapping_index = numbers::invalid_unsigned_int,
+              const unsigned int fe_index = numbers::invalid_unsigned_int);
 
                                        /**
                                         * Like the previous function,
@@ -720,9 +720,9 @@ namespace hp
       void
       reinit (const typename dealii::DoFHandler<dim>::cell_iterator &cell,
               const unsigned int face_no,
-              const unsigned int q_index = deal_II_numbers::invalid_unsigned_int,
-              const unsigned int mapping_index = deal_II_numbers::invalid_unsigned_int,
-              const unsigned int fe_index = deal_II_numbers::invalid_unsigned_int);
+              const unsigned int q_index = numbers::invalid_unsigned_int,
+              const unsigned int mapping_index = numbers::invalid_unsigned_int,
+              const unsigned int fe_index = numbers::invalid_unsigned_int);
 
                                        /**
                                         * Like the previous function,
@@ -756,9 +756,9 @@ namespace hp
       void
       reinit (const typename MGDoFHandler<dim>::cell_iterator &cell,
               const unsigned int face_no,
-              const unsigned int q_index = deal_II_numbers::invalid_unsigned_int,
-              const unsigned int mapping_index = deal_II_numbers::invalid_unsigned_int,
-              const unsigned int fe_index = deal_II_numbers::invalid_unsigned_int);
+              const unsigned int q_index = numbers::invalid_unsigned_int,
+              const unsigned int mapping_index = numbers::invalid_unsigned_int,
+              const unsigned int fe_index = numbers::invalid_unsigned_int);
       
                                        /**
                                         * Like the previous function,
@@ -793,9 +793,9 @@ namespace hp
       void
       reinit (const typename Triangulation<dim>::cell_iterator &cell,
               const unsigned int face_no,
-              const unsigned int q_index = deal_II_numbers::invalid_unsigned_int,
-              const unsigned int mapping_index = deal_II_numbers::invalid_unsigned_int,
-              const unsigned int fe_index = deal_II_numbers::invalid_unsigned_int);
+              const unsigned int q_index = numbers::invalid_unsigned_int,
+              const unsigned int mapping_index = numbers::invalid_unsigned_int,
+              const unsigned int fe_index = numbers::invalid_unsigned_int);
   };
 
 
@@ -945,9 +945,9 @@ namespace hp
       reinit (const typename hp::DoFHandler<dim>::cell_iterator &cell,
               const unsigned int face_no,
               const unsigned int subface_no,
-              const unsigned int q_index = deal_II_numbers::invalid_unsigned_int,
-              const unsigned int mapping_index = deal_II_numbers::invalid_unsigned_int,
-              const unsigned int fe_index = deal_II_numbers::invalid_unsigned_int);
+              const unsigned int q_index = numbers::invalid_unsigned_int,
+              const unsigned int mapping_index = numbers::invalid_unsigned_int,
+              const unsigned int fe_index = numbers::invalid_unsigned_int);
 
                                        /**
                                         * Like the previous function,
@@ -982,9 +982,9 @@ namespace hp
       reinit (const typename dealii::DoFHandler<dim>::cell_iterator &cell,
               const unsigned int face_no,
               const unsigned int subface_no,
-              const unsigned int q_index = deal_II_numbers::invalid_unsigned_int,
-              const unsigned int mapping_index = deal_II_numbers::invalid_unsigned_int,
-              const unsigned int fe_index = deal_II_numbers::invalid_unsigned_int);
+              const unsigned int q_index = numbers::invalid_unsigned_int,
+              const unsigned int mapping_index = numbers::invalid_unsigned_int,
+              const unsigned int fe_index = numbers::invalid_unsigned_int);
 
                                        /**
                                         * Like the previous function,
@@ -1019,9 +1019,9 @@ namespace hp
       reinit (const typename MGDoFHandler<dim>::cell_iterator &cell,
               const unsigned int face_no,
               const unsigned int subface_no,
-              const unsigned int q_index = deal_II_numbers::invalid_unsigned_int,
-              const unsigned int mapping_index = deal_II_numbers::invalid_unsigned_int,
-              const unsigned int fe_index = deal_II_numbers::invalid_unsigned_int);
+              const unsigned int q_index = numbers::invalid_unsigned_int,
+              const unsigned int mapping_index = numbers::invalid_unsigned_int,
+              const unsigned int fe_index = numbers::invalid_unsigned_int);
       
                                        /**
                                         * Like the previous function,
@@ -1057,9 +1057,9 @@ namespace hp
       reinit (const typename Triangulation<dim>::cell_iterator &cell,
               const unsigned int face_no,
               const unsigned int subface_no,
-              const unsigned int q_index = deal_II_numbers::invalid_unsigned_int,
-              const unsigned int mapping_index = deal_II_numbers::invalid_unsigned_int,
-              const unsigned int fe_index = deal_II_numbers::invalid_unsigned_int);
+              const unsigned int q_index = numbers::invalid_unsigned_int,
+              const unsigned int mapping_index = numbers::invalid_unsigned_int,
+              const unsigned int fe_index = numbers::invalid_unsigned_int);
   };
   
 }
index a4b66e5e6a7512060a4028465f0a0fcbdc42b776..23ac1643a3af1835b48665cf88bf485bbd1f279c 100644 (file)
@@ -249,7 +249,7 @@ class MGTransferSelect : public MGTransferBase<Vector<number> >,
                                      * component. Handle with care!
                                      */
     void select (const unsigned int component,
-                const unsigned int mg_component = deal_II_numbers::invalid_unsigned_int);
+                const unsigned int mg_component = numbers::invalid_unsigned_int);
     
     virtual void prolongate (const unsigned int    to_level,
                             Vector<number>       &dst,
@@ -395,7 +395,7 @@ MGTransferSelect<number>::select(const unsigned int component,
                                 const unsigned int mg_component)
 {
   selected_component = component;
-  mg_selected_component = (mg_component == deal_II_numbers::invalid_unsigned_int)
+  mg_selected_component = (mg_component == numbers::invalid_unsigned_int)
                          ? component
                          : mg_component;
 }
index 0c450fd7ef40489ec774deb2e324633d878d223b..f2f342ff57bc7876f6f516f68ed8dfe837619f18 100644 (file)
@@ -274,7 +274,7 @@ class KellyErrorEstimator
                                      * indicates whether we shall compute
                                      * indicators for all cells (in case its
                                      * value is the default,
-                                     * <tt>deal_II_numbers::invalid_unsigned_int</tt>),
+                                     * <tt>numbers::invalid_unsigned_int</tt>),
                                      * or only for the cells belonging to a
                                      * certain subdomain with the given
                                      * indicator. The latter case is used for
@@ -319,8 +319,8 @@ class KellyErrorEstimator
                          const std::vector<bool> &component_mask = std::vector<bool>(),
                          const Function<dim>     *coefficients   = 0,
                          const unsigned int       n_threads = multithread_info.n_default_threads,
-                          const unsigned int       subdomain_id = deal_II_numbers::invalid_unsigned_int,
-                          const unsigned int       material_id = deal_II_numbers::invalid_unsigned_int);
+                          const unsigned int       subdomain_id = numbers::invalid_unsigned_int,
+                          const unsigned int       material_id = numbers::invalid_unsigned_int);
     
                                     /**
                                      * Calls the @p estimate
@@ -336,8 +336,8 @@ class KellyErrorEstimator
                          const std::vector<bool> &component_mask = std::vector<bool>(),
                          const Function<dim>     *coefficients   = 0,
                          const unsigned int       n_threads = multithread_info.n_default_threads,
-                          const unsigned int       subdomain_id = deal_II_numbers::invalid_unsigned_int,
-                          const unsigned int       material_id = deal_II_numbers::invalid_unsigned_int);
+                          const unsigned int       subdomain_id = numbers::invalid_unsigned_int,
+                          const unsigned int       material_id = numbers::invalid_unsigned_int);
     
                                     /**
                                      * Same function as above, but
@@ -376,8 +376,8 @@ class KellyErrorEstimator
                          const std::vector<bool>     &component_mask = std::vector<bool>(),
                          const Function<dim>         *coefficients   = 0,
                          const unsigned int           n_threads = multithread_info.n_default_threads,
-                          const unsigned int           subdomain_id = deal_II_numbers::invalid_unsigned_int,
-                          const unsigned int           material_id = deal_II_numbers::invalid_unsigned_int);
+                          const unsigned int           subdomain_id = numbers::invalid_unsigned_int,
+                          const unsigned int           material_id = numbers::invalid_unsigned_int);
 
                                     /**
                                      * Calls the @p estimate
@@ -393,8 +393,8 @@ class KellyErrorEstimator
                          const std::vector<bool>     &component_mask = std::vector<bool>(),
                          const Function<dim>         *coefficients   = 0,
                          const unsigned int           n_threads = multithread_info.n_default_threads,
-                          const unsigned int           subdomain_id = deal_II_numbers::invalid_unsigned_int,
-                          const unsigned int           material_id = deal_II_numbers::invalid_unsigned_int);
+                          const unsigned int           subdomain_id = numbers::invalid_unsigned_int,
+                          const unsigned int           material_id = numbers::invalid_unsigned_int);
 
 
                                     /**
@@ -413,8 +413,8 @@ class KellyErrorEstimator
                          const std::vector<bool> &component_mask = std::vector<bool>(),
                          const Function<dim>     *coefficients   = 0,
                          const unsigned int       n_threads = multithread_info.n_default_threads,
-                          const unsigned int       subdomain_id = deal_II_numbers::invalid_unsigned_int,
-                          const unsigned int       material_id = deal_II_numbers::invalid_unsigned_int);
+                          const unsigned int       subdomain_id = numbers::invalid_unsigned_int,
+                          const unsigned int       material_id = numbers::invalid_unsigned_int);
 
 
                                     /**
@@ -432,8 +432,8 @@ class KellyErrorEstimator
                          const std::vector<bool> &component_mask = std::vector<bool>(),
                          const Function<dim>     *coefficients   = 0,
                          const unsigned int       n_threads = multithread_info.n_default_threads,
-                          const unsigned int       subdomain_id = deal_II_numbers::invalid_unsigned_int,
-                          const unsigned int       material_id = deal_II_numbers::invalid_unsigned_int);
+                          const unsigned int       subdomain_id = numbers::invalid_unsigned_int,
+                          const unsigned int       material_id = numbers::invalid_unsigned_int);
 
 
                                     /**
@@ -452,8 +452,8 @@ class KellyErrorEstimator
                          const std::vector<bool>     &component_mask = std::vector<bool>(),
                          const Function<dim>         *coefficients   = 0,
                          const unsigned int           n_threads = multithread_info.n_default_threads,
-                          const unsigned int           subdomain_id = deal_II_numbers::invalid_unsigned_int,
-                          const unsigned int           material_id = deal_II_numbers::invalid_unsigned_int);
+                          const unsigned int           subdomain_id = numbers::invalid_unsigned_int,
+                          const unsigned int           material_id = numbers::invalid_unsigned_int);
 
 
                                     /**
@@ -471,8 +471,8 @@ class KellyErrorEstimator
                          const std::vector<bool>     &component_mask = std::vector<bool>(),
                          const Function<dim>         *coefficients   = 0,
                          const unsigned int           n_threads = multithread_info.n_default_threads,
-                          const unsigned int           subdomain_id = deal_II_numbers::invalid_unsigned_int,
-                          const unsigned int           material_id = deal_II_numbers::invalid_unsigned_int);
+                          const unsigned int           subdomain_id = numbers::invalid_unsigned_int,
+                          const unsigned int           material_id = numbers::invalid_unsigned_int);
     
     
                                     /**
@@ -857,8 +857,8 @@ class KellyErrorEstimator<1>
                          const std::vector<bool> &component_mask = std::vector<bool>(),
                          const Function<1>     *coefficients   = 0,
                          const unsigned int       n_threads = multithread_info.n_default_threads,
-                          const unsigned int       subdomain_id = deal_II_numbers::invalid_unsigned_int,
-                          const unsigned int       material_id = deal_II_numbers::invalid_unsigned_int);
+                          const unsigned int       subdomain_id = numbers::invalid_unsigned_int,
+                          const unsigned int       material_id = numbers::invalid_unsigned_int);
 
                                     /**
                                      * Calls the @p estimate
@@ -874,8 +874,8 @@ class KellyErrorEstimator<1>
                          const std::vector<bool> &component_mask = std::vector<bool>(),
                          const Function<1>     *coefficients   = 0,
                          const unsigned int       n_threads = multithread_info.n_default_threads,
-                          const unsigned int       subdomain_id = deal_II_numbers::invalid_unsigned_int,
-                          const unsigned int       material_id = deal_II_numbers::invalid_unsigned_int);
+                          const unsigned int       subdomain_id = numbers::invalid_unsigned_int,
+                          const unsigned int       material_id = numbers::invalid_unsigned_int);
     
                                     /**
                                      * Same function as above, but
@@ -914,8 +914,8 @@ class KellyErrorEstimator<1>
                          const std::vector<bool>     &component_mask = std::vector<bool>(),
                          const Function<1>         *coefficients   = 0,
                          const unsigned int           n_threads = multithread_info.n_default_threads,
-                          const unsigned int           subdomain_id = deal_II_numbers::invalid_unsigned_int,
-                          const unsigned int           material_id = deal_II_numbers::invalid_unsigned_int);
+                          const unsigned int           subdomain_id = numbers::invalid_unsigned_int,
+                          const unsigned int           material_id = numbers::invalid_unsigned_int);
 
                                     /**
                                      * Calls the @p estimate
@@ -931,8 +931,8 @@ class KellyErrorEstimator<1>
                          const std::vector<bool>     &component_mask = std::vector<bool>(),
                          const Function<1>         *coefficients   = 0,
                          const unsigned int           n_threads = multithread_info.n_default_threads,
-                          const unsigned int           subdomain_id = deal_II_numbers::invalid_unsigned_int,
-                          const unsigned int           material_id = deal_II_numbers::invalid_unsigned_int);
+                          const unsigned int           subdomain_id = numbers::invalid_unsigned_int,
+                          const unsigned int           material_id = numbers::invalid_unsigned_int);
 
 
                                     /**
@@ -951,8 +951,8 @@ class KellyErrorEstimator<1>
                          const std::vector<bool> &component_mask = std::vector<bool>(),
                          const Function<1>     *coefficients   = 0,
                          const unsigned int       n_threads = multithread_info.n_default_threads,
-                          const unsigned int       subdomain_id = deal_II_numbers::invalid_unsigned_int,
-                          const unsigned int       material_id = deal_II_numbers::invalid_unsigned_int);
+                          const unsigned int       subdomain_id = numbers::invalid_unsigned_int,
+                          const unsigned int       material_id = numbers::invalid_unsigned_int);
 
 
                                     /**
@@ -970,8 +970,8 @@ class KellyErrorEstimator<1>
                          const std::vector<bool> &component_mask = std::vector<bool>(),
                          const Function<1>     *coefficients   = 0,
                          const unsigned int       n_threads = multithread_info.n_default_threads,
-                          const unsigned int       subdomain_id = deal_II_numbers::invalid_unsigned_int,
-                          const unsigned int       material_id = deal_II_numbers::invalid_unsigned_int);
+                          const unsigned int       subdomain_id = numbers::invalid_unsigned_int,
+                          const unsigned int       material_id = numbers::invalid_unsigned_int);
 
 
                                     /**
@@ -990,8 +990,8 @@ class KellyErrorEstimator<1>
                          const std::vector<bool>     &component_mask = std::vector<bool>(),
                          const Function<1>         *coefficients   = 0,
                          const unsigned int           n_threads = multithread_info.n_default_threads,
-                          const unsigned int           subdomain_id = deal_II_numbers::invalid_unsigned_int,
-                          const unsigned int           material_id = deal_II_numbers::invalid_unsigned_int);
+                          const unsigned int           subdomain_id = numbers::invalid_unsigned_int,
+                          const unsigned int           material_id = numbers::invalid_unsigned_int);
 
 
                                     /**
@@ -1009,8 +1009,8 @@ class KellyErrorEstimator<1>
                          const std::vector<bool>     &component_mask = std::vector<bool>(),
                          const Function<1>         *coefficients   = 0,
                          const unsigned int           n_threads = multithread_info.n_default_threads,
-                          const unsigned int           subdomain_id = deal_II_numbers::invalid_unsigned_int,
-                          const unsigned int           material_id = deal_II_numbers::invalid_unsigned_int);
+                          const unsigned int           subdomain_id = numbers::invalid_unsigned_int,
+                          const unsigned int           material_id = numbers::invalid_unsigned_int);
     
                                     /**
                                      * Exception
index 5ac81c10307644e7a8c6f7b6f6567a3c2fbc74bf..c5aade3845b97f80f87e2463affb2ceb2e48da57 100644 (file)
@@ -1514,7 +1514,7 @@ interpolate_boundary_values (const Mapping<dim>            &mapping,
                                  :
                                  i+4*fe.dofs_per_vertex+8*fe.dofs_per_line))
                                :
-                               deal_II_numbers::invalid_unsigned_int)));
+                               numbers::invalid_unsigned_int)));
                         Assert (cell_i < fe.dofs_per_cell, ExcInternalError());
 
                                                          // make sure
@@ -2167,7 +2167,7 @@ namespace internal
             }
                                            // append result of this cell
                                            // to the end of the vector
-          Assert (deal_II_numbers::is_finite(diff), ExcInternalError());
+          Assert (numbers::is_finite(diff), ExcInternalError());
           difference(index) = diff;
         }
     }
index f89b02c54baa959ac1fb899a4c95d3aadb870b09..7f0bbaca5276457fb408ae4c14cc1d99bf1f03ab 100644 (file)
@@ -814,13 +814,13 @@ void ConstraintMatrix::condense (SparsityPattern &sparsity) const
   
                                   // store for each index whether it must be
                                   // distributed or not. If entry is
-                                  // deal_II_numbers::invalid_unsigned_int,
+                                  // numbers::invalid_unsigned_int,
                                   // no distribution is necessary.
                                   // otherwise, the number states which line
                                   // in the constraint matrix handles this
                                   // index
   std::vector<unsigned int> distribute(sparsity.n_rows(),
-                                       deal_II_numbers::invalid_unsigned_int);
+                                       numbers::invalid_unsigned_int);
   
   for (unsigned int c=0; c<lines.size(); ++c)
     distribute[lines[c].line] = c;
@@ -828,7 +828,7 @@ void ConstraintMatrix::condense (SparsityPattern &sparsity) const
   const unsigned int n_rows = sparsity.n_rows();
   for (unsigned int row=0; row<n_rows; ++row)
     {
-      if (distribute[row] == deal_II_numbers::invalid_unsigned_int)
+      if (distribute[row] == numbers::invalid_unsigned_int)
        {
                                           // regular line. loop over cols all
                                           // valid cols. note that this
@@ -848,7 +848,7 @@ void ConstraintMatrix::condense (SparsityPattern &sparsity) const
                                           // added ones only takes two
                                           // comparisons (column index valid,
                                           // distribute[column] necessarily
-                                          // ==deal_II_numbers::invalid_unsigned_int),
+                                          // ==numbers::invalid_unsigned_int),
                                           // it is cheaper to not do so and
                                           // run right until the end of the
                                           // line
@@ -859,7 +859,7 @@ void ConstraintMatrix::condense (SparsityPattern &sparsity) const
            {
              const unsigned int column = entry->column();
 
-              if (distribute[column] != deal_II_numbers::invalid_unsigned_int)
+              if (distribute[column] != numbers::invalid_unsigned_int)
                 {
                                                    // distribute entry
                                                    // at regular row
@@ -884,7 +884,7 @@ void ConstraintMatrix::condense (SparsityPattern &sparsity) const
                (entry != sparsity.end(row)) && entry->is_valid_entry(); ++entry)
             {
               const unsigned int column = entry->column();
-              if (distribute[column] == deal_II_numbers::invalid_unsigned_int)
+              if (distribute[column] == numbers::invalid_unsigned_int)
                                                  // distribute entry at irregular
                                                  // row @p{row} and regular column
                                                  // sparsity.colnums[j]
@@ -918,13 +918,13 @@ void ConstraintMatrix::condense (CompressedSparsityPattern &sparsity) const
   
                                   // store for each index whether it must be
                                   // distributed or not. If entry is
-                                  // deal_II_numbers::invalid_unsigned_int,
+                                  // numbers::invalid_unsigned_int,
                                   // no distribution is necessary.
                                   // otherwise, the number states which line
                                   // in the constraint matrix handles this
                                   // index
   std::vector<unsigned int> distribute(sparsity.n_rows(),
-                                       deal_II_numbers::invalid_unsigned_int);
+                                       numbers::invalid_unsigned_int);
   
   for (unsigned int c=0; c<lines.size(); ++c)
     distribute[lines[c].line] = c;
@@ -932,7 +932,7 @@ void ConstraintMatrix::condense (CompressedSparsityPattern &sparsity) const
   const unsigned int n_rows = sparsity.n_rows();
   for (unsigned int row=0; row<n_rows; ++row)
     {
-      if (distribute[row] == deal_II_numbers::invalid_unsigned_int)
+      if (distribute[row] == numbers::invalid_unsigned_int)
                                         // regular line. loop over
                                         // cols. note that as we
                                         // proceed to distribute
@@ -942,7 +942,7 @@ void ConstraintMatrix::condense (CompressedSparsityPattern &sparsity) const
          {
            const unsigned int column = sparsity.column_number(row,j);
 
-           if (distribute[column] != deal_II_numbers::invalid_unsigned_int)
+           if (distribute[column] != numbers::invalid_unsigned_int)
              {
                                                 // distribute entry
                                                 // at regular row
@@ -1020,7 +1020,7 @@ void ConstraintMatrix::condense (CompressedSparsityPattern &sparsity) const
          {
            const unsigned int column = sparsity.column_number(row,j);
 
-           if (distribute[column] == deal_II_numbers::invalid_unsigned_int)
+           if (distribute[column] == numbers::invalid_unsigned_int)
                                               // distribute entry at irregular
                                               // row @p{row} and regular column
                                               // sparsity.colnums[j]
@@ -1052,13 +1052,13 @@ void ConstraintMatrix::condense (CompressedSetSparsityPattern &sparsity) const
   
                                   // store for each index whether it must be
                                   // distributed or not. If entry is
-                                  // deal_II_numbers::invalid_unsigned_int,
+                                  // numbers::invalid_unsigned_int,
                                   // no distribution is necessary.
                                   // otherwise, the number states which line
                                   // in the constraint matrix handles this
                                   // index
   std::vector<unsigned int> distribute(sparsity.n_rows(),
-                                       deal_II_numbers::invalid_unsigned_int);
+                                       numbers::invalid_unsigned_int);
   
   for (unsigned int c=0; c<lines.size(); ++c)
     distribute[lines[c].line] = c;
@@ -1066,7 +1066,7 @@ void ConstraintMatrix::condense (CompressedSetSparsityPattern &sparsity) const
   const unsigned int n_rows = sparsity.n_rows();
   for (unsigned int row=0; row<n_rows; ++row)
     {
-      if (distribute[row] == deal_II_numbers::invalid_unsigned_int)
+      if (distribute[row] == numbers::invalid_unsigned_int)
        {
                                           // regular line. loop over
                                           // cols. note that as we proceed to
@@ -1078,7 +1078,7 @@ void ConstraintMatrix::condense (CompressedSetSparsityPattern &sparsity) const
            {
              const unsigned int column = *col_num;
              
-             if (distribute[column] != deal_II_numbers::invalid_unsigned_int)
+             if (distribute[column] != numbers::invalid_unsigned_int)
                {
                  // row
                  unsigned int old_rowlength = sparsity.row_length(row);
@@ -1108,7 +1108,7 @@ void ConstraintMatrix::condense (CompressedSetSparsityPattern &sparsity) const
            {
              const unsigned int column = *col_num;
              
-             if (distribute[column] == deal_II_numbers::invalid_unsigned_int)
+             if (distribute[column] == numbers::invalid_unsigned_int)
                // distribute entry at irregular
                // row @p{row} and regular column
                // sparsity.colnums[j]
@@ -1152,13 +1152,13 @@ void ConstraintMatrix::condense (BlockSparsityPattern &sparsity) const
   
                                   // store for each index whether it must be
                                   // distributed or not. If entry is
-                                  // deal_II_numbers::invalid_unsigned_int,
+                                  // numbers::invalid_unsigned_int,
                                   // no distribution is necessary.
                                   // otherwise, the number states which line
                                   // in the constraint matrix handles this
                                   // index
   std::vector<unsigned int> distribute (sparsity.n_rows(),
-                                        deal_II_numbers::invalid_unsigned_int);
+                                        numbers::invalid_unsigned_int);
   
   for (unsigned int c=0; c<lines.size(); ++c)
     distribute[lines[c].line] = c;
@@ -1172,7 +1172,7 @@ void ConstraintMatrix::condense (BlockSparsityPattern &sparsity) const
        block_index = index_mapping.global_to_local(row);
       const unsigned int block_row = block_index.first;
       
-      if (distribute[row] == deal_II_numbers::invalid_unsigned_int)
+      if (distribute[row] == numbers::invalid_unsigned_int)
                                         // regular line. loop over
                                         // all columns and see
                                         // whether this column must
@@ -1199,7 +1199,7 @@ void ConstraintMatrix::condense (BlockSparsityPattern &sparsity) const
                   const unsigned int global_col
                     = index_mapping.local_to_global(block_col, entry->column());
                   
-                  if (distribute[global_col] != deal_II_numbers::invalid_unsigned_int)
+                  if (distribute[global_col] != numbers::invalid_unsigned_int)
                                                      // distribute entry at regular
                                                      // row @p{row} and irregular column
                                                      // global_col
@@ -1233,7 +1233,7 @@ void ConstraintMatrix::condense (BlockSparsityPattern &sparsity) const
                   const unsigned int global_col
                     = index_mapping.local_to_global (block_col, entry->column());
                   
-                  if (distribute[global_col] == deal_II_numbers::invalid_unsigned_int)
+                  if (distribute[global_col] == numbers::invalid_unsigned_int)
                                                      // distribute entry at irregular
                                                      // row @p{row} and regular column
                                                      // global_col.
@@ -1278,13 +1278,13 @@ void ConstraintMatrix::condense (BlockCompressedSparsityPattern &sparsity) const
   
                                   // store for each index whether it must be
                                   // distributed or not. If entry is
-                                  // deal_II_numbers::invalid_unsigned_int,
+                                  // numbers::invalid_unsigned_int,
                                   // no distribution is necessary.
                                   // otherwise, the number states which line
                                   // in the constraint matrix handles this
                                   // index
   std::vector<unsigned int> distribute (sparsity.n_rows(),
-                                        deal_II_numbers::invalid_unsigned_int);
+                                        numbers::invalid_unsigned_int);
   
   for (unsigned int c=0; c<lines.size(); ++c)
     distribute[lines[c].line] = static_cast<signed int>(c);
@@ -1299,7 +1299,7 @@ void ConstraintMatrix::condense (BlockCompressedSparsityPattern &sparsity) const
       const unsigned int block_row = block_index.first;
       const unsigned int local_row = block_index.second;
       
-      if (distribute[row] == deal_II_numbers::invalid_unsigned_int)
+      if (distribute[row] == numbers::invalid_unsigned_int)
                                         // regular line. loop over
                                         // all columns and see
                                         // whether this column must
@@ -1336,7 +1336,7 @@ void ConstraintMatrix::condense (BlockCompressedSparsityPattern &sparsity) const
                    = index_mapping.local_to_global(block_col,
                                                    block_sparsity.column_number(local_row,j));
                    
-                 if (distribute[global_col] != deal_II_numbers::invalid_unsigned_int)
+                 if (distribute[global_col] != numbers::invalid_unsigned_int)
                                                     // distribute entry at regular
                                                     // row @p{row} and irregular column
                                                     // global_col
@@ -1368,7 +1368,7 @@ void ConstraintMatrix::condense (BlockCompressedSparsityPattern &sparsity) const
                    = index_mapping.local_to_global (block_col,
                                                     block_sparsity.column_number(local_row,j));
                    
-                 if (distribute[global_col] == deal_II_numbers::invalid_unsigned_int)
+                 if (distribute[global_col] == numbers::invalid_unsigned_int)
                                                     // distribute entry at irregular
                                                     // row @p{row} and regular column
                                                     // global_col.
@@ -1412,13 +1412,13 @@ void ConstraintMatrix::condense (BlockCompressedSetSparsityPattern &sparsity) co
   
                                   // store for each index whether it must be
                                   // distributed or not. If entry is
-                                  // deal_II_numbers::invalid_unsigned_int,
+                                  // numbers::invalid_unsigned_int,
                                   // no distribution is necessary.
                                   // otherwise, the number states which line
                                   // in the constraint matrix handles this
                                   // index
   std::vector<unsigned int> distribute (sparsity.n_rows(),
-                                        deal_II_numbers::invalid_unsigned_int);
+                                        numbers::invalid_unsigned_int);
   
   for (unsigned int c=0; c<lines.size(); ++c)
     distribute[lines[c].line] = static_cast<signed int>(c);
@@ -1433,7 +1433,7 @@ void ConstraintMatrix::condense (BlockCompressedSetSparsityPattern &sparsity) co
       const unsigned int block_row = block_index.first;
       const unsigned int local_row = block_index.second;
       
-      if (distribute[row] == deal_II_numbers::invalid_unsigned_int)
+      if (distribute[row] == numbers::invalid_unsigned_int)
                                         // regular line. loop over
                                         // all columns and see
                                         // whether this column must
@@ -1471,7 +1471,7 @@ void ConstraintMatrix::condense (BlockCompressedSetSparsityPattern &sparsity) co
                  const unsigned int global_col
                    = index_mapping.local_to_global(block_col, *j);
                    
-                 if (distribute[global_col] != deal_II_numbers::invalid_unsigned_int)
+                 if (distribute[global_col] != numbers::invalid_unsigned_int)
                                                     // distribute entry at regular
                                                     // row @p{row} and irregular column
                                                     // global_col
@@ -1504,7 +1504,7 @@ void ConstraintMatrix::condense (BlockCompressedSetSparsityPattern &sparsity) co
                  const unsigned int global_col
                    = index_mapping.local_to_global (block_col, *j);
                    
-                 if (distribute[global_col] == deal_II_numbers::invalid_unsigned_int)
+                 if (distribute[global_col] == numbers::invalid_unsigned_int)
                                                     // distribute entry at irregular
                                                     // row @p{row} and regular column
                                                     // global_col.
index 886d0cbb4e2edf2dc4672c54baf0ad1c00932b66..f7b73d35f21226621b6c96b84119ea20a63ebddd 100644 (file)
@@ -1496,13 +1496,13 @@ compute_subdomain_wise (std::vector<unsigned int> &new_dof_indices,
                                    // same subdomain, then they will be in
                                    // this order also after reordering
   std::fill (new_dof_indices.begin(), new_dof_indices.end(),
-             deal_II_numbers::invalid_unsigned_int);
+             numbers::invalid_unsigned_int);
   unsigned int next_free_index = 0;
   for (unsigned int subdomain=0; subdomain<n_subdomains; ++subdomain)
     for (unsigned int i=0; i<n_dofs; ++i)
       if (subdomain_association[i] == subdomain)
         {
-          Assert (new_dof_indices[i] == deal_II_numbers::invalid_unsigned_int,
+          Assert (new_dof_indices[i] == numbers::invalid_unsigned_int,
                   ExcInternalError());
           new_dof_indices[i] = next_free_index;
           ++next_free_index;
@@ -1511,7 +1511,7 @@ compute_subdomain_wise (std::vector<unsigned int> &new_dof_indices,
                                    // we should have numbered all dofs
   Assert (next_free_index == n_dofs, ExcInternalError());
   Assert (std::find (new_dof_indices.begin(), new_dof_indices.end(),
-                     deal_II_numbers::invalid_unsigned_int)
+                     numbers::invalid_unsigned_int)
           == new_dof_indices.end(),
           ExcInternalError());
 }
index 4d0b6fe710566cd640448ab6d658fa4ffa43042e..55ae34f1e2c6b53e7db04d1568a3ee388ac74833 100644 (file)
@@ -3279,7 +3279,7 @@ DoFTools::extract_boundary_dofs (const DH                      &dof_handler,
                            :
                            i+4*fe.dofs_per_vertex+8*fe.dofs_per_line))
                          :
-                         deal_II_numbers::invalid_unsigned_int)));
+                         numbers::invalid_unsigned_int)));
                   if (fe.is_primitive (cell_index))
                     selected_dofs[face_dof_indices[i]]
                       = (component_select[fe.face_system_to_component_index(i).first]
@@ -3617,7 +3617,7 @@ DoFTools::get_subdomain_association (const DH                  &dof_handler,
 
                                    // preset all values by an invalid value
   std::fill_n (subdomain_association.begin(), dof_handler.n_dofs(),
-               deal_II_numbers::invalid_unsigned_int);
+               numbers::invalid_unsigned_int);
 
   std::vector<unsigned int> local_dof_indices;
   local_dof_indices.reserve (max_dofs_per_cell(dof_handler));
@@ -3646,7 +3646,7 @@ DoFTools::get_subdomain_association (const DH                  &dof_handler,
 
   Assert (std::find (subdomain_association.begin(),
                      subdomain_association.end(),
-                     deal_II_numbers::invalid_unsigned_int)
+                     numbers::invalid_unsigned_int)
           == subdomain_association.end(),
           ExcInternalError());
 }
@@ -4158,7 +4158,7 @@ compute_intergrid_transfer_representation (
       const unsigned int parameter_dof = weight_mapping[i];
                                       // if this global dof is a
                                       // parameter
-      if (parameter_dof != deal_II_numbers::invalid_unsigned_int)
+      if (parameter_dof != numbers::invalid_unsigned_int)
        {
          Assert (parameter_dof < n_global_parm_dofs, ExcInternalError());
          Assert (inverse_weight_mapping[parameter_dof] == DoFHandler<dim>::invalid_dof_index,
index 91abd8868347707d40bee6f0697e5ca5e843fd30..6b521a831af3cefa7f57c4a447f14fa2fb4c15a0 100644 (file)
@@ -496,8 +496,8 @@ FiniteElement<dim>::interface_constraints_size () const
       default:
             Assert (false, ExcNotImplemented());
     };
-  return TableIndices<2> (deal_II_numbers::invalid_unsigned_int,
-                          deal_II_numbers::invalid_unsigned_int);
+  return TableIndices<2> (numbers::invalid_unsigned_int,
+                          numbers::invalid_unsigned_int);
 }
 
 
index 2457fdaaa1aefadbf8782fa522652661e6358035..7b7588d9e978bafd32d0b82e1a1497d0a64dd281 100644 (file)
@@ -76,7 +76,7 @@ FiniteElementData (const std::vector<unsigned int> &dofs_per_object,
                               GeometryInfo<dim>::quads_per_cell * dofs_per_quad +
                               GeometryInfo<dim>::hexes_per_cell * dofs_per_hex),
                components(n_components),
-               blocks(n_blocks == deal_II_numbers::invalid_unsigned_int
+               blocks(n_blocks == numbers::invalid_unsigned_int
                       ? n_components : n_blocks),
                degree(degree),
                conforming_space(conformity)
index 7ffdc580851c9ae58100922923bd581f3ac96b64..3b492aa9a0c9c544aadbb7077ffb05e767c84a7e 100644 (file)
@@ -37,7 +37,7 @@ namespace
       if (i*i == N)
        return i;
     Assert (false, ExcInternalError());
-    return deal_II_numbers::invalid_unsigned_int;
+    return numbers::invalid_unsigned_int;
   }
 
 
@@ -50,7 +50,7 @@ namespace
       if (i*i*i == N)
        return i;
     Assert (false, ExcInternalError());
-    return deal_II_numbers::invalid_unsigned_int;
+    return numbers::invalid_unsigned_int;
   }
 
 
index 0d49d97f1b0e814b51da27d80e10bde511a07b22..52ad254040aa23cef279ce5108f231793344e56a 100644 (file)
@@ -82,7 +82,7 @@ namespace FE_Q_Helper
        if (i*i == N)
          return i;
       Assert (false, ExcInternalError());
-      return deal_II_numbers::invalid_unsigned_int;
+      return numbers::invalid_unsigned_int;
     }
 
 
@@ -99,7 +99,7 @@ namespace FE_Q_Helper
        if (i*i*i == N)
          return i;
       Assert (false, ExcInternalError());
-      return deal_II_numbers::invalid_unsigned_int;
+      return numbers::invalid_unsigned_int;
     }
 
 
index 4c01c2037ddb7bfb87f36f1ae59f7c96bba6d05e..3e21d7dc18be656435b616761dbd3b31466d3fe6 100644 (file)
@@ -1019,8 +1019,8 @@ FESystem<dim>::build_cell_tables()
                                   // non-primitive shape functions,
                                   // have a special invalid index.
   const std::pair<unsigned int, unsigned int>
-    non_primitive_index (deal_II_numbers::invalid_unsigned_int,
-                        deal_II_numbers::invalid_unsigned_int);
+    non_primitive_index (numbers::invalid_unsigned_int,
+                        numbers::invalid_unsigned_int);
   
                                   // First enumerate vertex indices,
                                   // where we first enumerate all
@@ -1193,8 +1193,8 @@ FESystem<dim>::build_face_tables()
                                   // functions, have a special
                                   // invalid index
   const std::pair<unsigned int, unsigned int>
-    non_primitive_index (deal_II_numbers::invalid_unsigned_int,
-                        deal_II_numbers::invalid_unsigned_int);
+    non_primitive_index (numbers::invalid_unsigned_int,
+                        numbers::invalid_unsigned_int);
   
                                   // 1. Vertices
   unsigned int total_index = 0;
index f3f21ea26dde9e9262c07f366809a5b400cccb7f..f56f75ca493dfba25bb6a5b729bbbf917cd8b90f 100644 (file)
@@ -480,7 +480,7 @@ void FETools::get_projection_matrix (const FiniteElement<dim> &fe1,
                                   // Choose a quadrature rule
                                   // Gauss is exact up to degree 2n-1
   const unsigned int degree = std::max(fe1.tensor_degree(), fe2.tensor_degree());
-  Assert (degree != deal_II_numbers::invalid_unsigned_int,
+  Assert (degree != numbers::invalid_unsigned_int,
          ExcNotImplemented());
   
   QGauss<dim> quadrature(degree+1);
index 70adfd55c7e6e69baf3ed695420d7cb7e10a0296..bca963cf9828ee41eda63f4704a4e6987a4ccefd 100644 (file)
@@ -203,15 +203,15 @@ GridGenerator::moebius (
     
   
   std::vector<Point<dim> > vertices (4*n_cells);
-  double beta_step=n_rotations*deal_II_numbers::PI/2.0/n_cells;
-  double alpha_step=2.0*deal_II_numbers::PI/n_cells;
+  double beta_step=n_rotations*numbers::PI/2.0/n_cells;
+  double alpha_step=2.0*numbers::PI/n_cells;
   
   for (unsigned int i=0; i<n_cells; ++i)
     for (unsigned int j=0; j<4; ++j)
       {
-       vertices[4*i+j][0]=R*std::cos(i*alpha_step)+r*std::cos(i*beta_step+j*deal_II_numbers::PI/2.0)*std::cos(i*alpha_step);
-       vertices[4*i+j][1]=R*std::sin(i*alpha_step)+r*std::cos(i*beta_step+j*deal_II_numbers::PI/2.0)*std::sin(i*alpha_step);
-       vertices[4*i+j][2]=r*std::sin(i*beta_step+j*deal_II_numbers::PI/2.0);
+       vertices[4*i+j][0]=R*std::cos(i*alpha_step)+r*std::cos(i*beta_step+j*numbers::PI/2.0)*std::cos(i*alpha_step);
+       vertices[4*i+j][1]=R*std::sin(i*alpha_step)+r*std::cos(i*beta_step+j*numbers::PI/2.0)*std::sin(i*alpha_step);
+       vertices[4*i+j][2]=r*std::sin(i*beta_step+j*numbers::PI/2.0);
       }
 
   unsigned int offset=0;
@@ -1387,7 +1387,7 @@ void GridGenerator::hyper_shell (Triangulation<dim>   &tria,
   Assert ((inner_radius > 0) && (inner_radius < outer_radius),
          ExcInvalidRadii ());
   
-  const double pi = deal_II_numbers::PI;
+  const double pi = numbers::PI;
   
                                   // determine the number of cells
                                   // for the grid. if not provided by
@@ -1557,7 +1557,7 @@ GridGenerator::half_hyper_shell (Triangulation<dim>   &tria,
   Assert ((inner_radius > 0) && (inner_radius < outer_radius),
          ExcInvalidRadii ());
   
-  const double pi     = deal_II_numbers::PI;
+  const double pi     = numbers::PI;
                                   // determine the number of cells
                                   // for the grid. if not provided by
                                   // the user determine it such that
@@ -2202,7 +2202,7 @@ void GridGenerator::cylinder_shell (Triangulation<dim>   &tria,
   Assert ((inner_radius > 0) && (inner_radius < outer_radius),
          ExcInvalidRadii ());
   
-  const double pi = deal_II_numbers::PI;
+  const double pi = numbers::PI;
   
                                   // determine the number of cells
                                   // for the grid. if not provided by
index cfd26afc278dc41134768518ae7be2e4b3cfe127..6d7f20009cbfaaeac8987584a027843f9139c393 100644 (file)
@@ -129,7 +129,7 @@ void GridIn<dim>::read_ucd (std::istream &in)
              {
                                                 // no such vertex index
                AssertThrow (false, ExcInvalidVertexIndex(cell, cells.back().vertices[i]));
-               cells.back().vertices[i] = deal_II_numbers::invalid_unsigned_int;
+               cells.back().vertices[i] = numbers::invalid_unsigned_int;
              };
        }
       else
@@ -156,7 +156,7 @@ void GridIn<dim>::read_ucd (std::istream &in)
                               ExcInvalidVertexIndex(cell,
                                                     subcelldata.boundary_lines.back().vertices[i]));
                  subcelldata.boundary_lines.back().vertices[i]
-                   = deal_II_numbers::invalid_unsigned_int;
+                   = numbers::invalid_unsigned_int;
                };
          }
        else
@@ -186,7 +186,7 @@ void GridIn<dim>::read_ucd (std::istream &in)
                            ExcInvalidVertexIndex(cell,
                                                  subcelldata.boundary_quads.back().vertices[i]));
                    subcelldata.boundary_quads.back().vertices[i] =
-                     deal_II_numbers::invalid_unsigned_int;
+                     numbers::invalid_unsigned_int;
                  };
              
            }
@@ -667,7 +667,7 @@ void GridIn<dim>::read_msh (std::istream &in)
              {
                                                 // no such vertex index
                AssertThrow (false, ExcInvalidVertexIndex(cell, cells.back().vertices[i]));
-               cells.back().vertices[i] = deal_II_numbers::invalid_unsigned_int;
+               cells.back().vertices[i] = numbers::invalid_unsigned_int;
              };
        }
       else
@@ -694,7 +694,7 @@ void GridIn<dim>::read_msh (std::istream &in)
                               ExcInvalidVertexIndex(cell,
                                                     subcelldata.boundary_lines.back().vertices[i]));
                  subcelldata.boundary_lines.back().vertices[i] =
-                   deal_II_numbers::invalid_unsigned_int;
+                   numbers::invalid_unsigned_int;
                };
          }
        else
@@ -724,7 +724,7 @@ void GridIn<dim>::read_msh (std::istream &in)
                            ExcInvalidVertexIndex(cell,
                                                  subcelldata.boundary_quads.back().vertices[i]));
                    subcelldata.boundary_quads.back().vertices[i] =
-                     deal_II_numbers::invalid_unsigned_int;
+                     numbers::invalid_unsigned_int;
                  };
              
            }
index a2f04de33354ad98b277330a448067377bc34fb1..9d2457ccbc3100fc54205d1551554f22794fc140 100644 (file)
@@ -1537,7 +1537,7 @@ void GridOut::write_eps (
                                         // is in direction of the viewer, but
                                         // I am too tired at present to fix
                                         // this
-       const double pi = deal_II_numbers::PI;
+       const double pi = numbers::PI;
        const double z_angle    = eps_flags_3.azimut_angle;
        const double turn_angle = eps_flags_3.turn_angle;
        const Point<dim> view_direction(-std::sin(z_angle * 2.*pi / 360.) * std::sin(turn_angle * 2.*pi / 360.),
index 5a5be56fab0d284494f07835a506955c47b7546d..4595e6ec0a37657eed16a97860de098a51af208e 100644 (file)
@@ -231,10 +231,10 @@ namespace internal
                  const unsigned int initv1)
                    :
                    v0(initv0), v1(initv1),
-                   Q0(deal_II_numbers::invalid_unsigned_int),
-                    Q1(deal_II_numbers::invalid_unsigned_int),
-                   lsn0(deal_II_numbers::invalid_unsigned_int),
-                    lsn1(deal_II_numbers::invalid_unsigned_int),
+                   Q0(numbers::invalid_unsigned_int),
+                    Q1(numbers::invalid_unsigned_int),
+                   lsn0(numbers::invalid_unsigned_int),
+                    lsn1(numbers::invalid_unsigned_int),
                    Oriented(false)
     {}
 
@@ -342,12 +342,12 @@ namespace internal
          for (unsigned int i = 0;i<4;++i)
            {
              MSide &ss = sides[(*it).side[i]];
-             if (ss.Q0 == deal_II_numbers::invalid_unsigned_int)
+             if (ss.Q0 == numbers::invalid_unsigned_int)
                {
                  ss.Q0 = qctr;
                  ss.lsn0 = i;
                }
-             else if (ss.Q1 == deal_II_numbers::invalid_unsigned_int)
+             else if (ss.Q1 == numbers::invalid_unsigned_int)
                {
                  ss.Q1 = qctr;
                  ss.lsn1 = i;
@@ -509,7 +509,7 @@ namespace internal
          lsn = s.lsn0;
        }
   
-      if (opquad != deal_II_numbers::invalid_unsigned_int)
+      if (opquad != numbers::invalid_unsigned_int)
        {
          qnum = opquad;
          return true;
@@ -757,7 +757,7 @@ namespace internal
                const unsigned int n1)
                    :
                    orientation_flag (unoriented_edge),
-                   group (deal_II_numbers::invalid_unsigned_int)
+                   group (numbers::invalid_unsigned_int)
     {
       nodes[0] = n0;
       nodes[1] = n1;
@@ -769,12 +769,12 @@ namespace internal
     {
       for (unsigned int i=0; i<GeometryInfo<3>::lines_per_cell; ++i)
        {
-         edges[i] = deal_II_numbers::invalid_unsigned_int;
+         edges[i] = numbers::invalid_unsigned_int;
          local_orientation_flags[i] = forward_edge;
        }
       
       for (unsigned int i=0; i<GeometryInfo<3>::vertices_per_cell; ++i)
-       nodes[i] = deal_II_numbers::invalid_unsigned_int;
+       nodes[i] = numbers::invalid_unsigned_int;
       
       waiting_to_be_processed = false;
     }
@@ -1409,7 +1409,7 @@ namespace internal
                                           // Here the number of
                                           // incoming edges is
                                           // tallied for each node.
-         unsigned int perm_num = deal_II_numbers::invalid_unsigned_int;
+         unsigned int perm_num = numbers::invalid_unsigned_int;
          for (unsigned int node_num=0; node_num<8; ++node_num)
            {
                                               // The local edge
@@ -1444,7 +1444,7 @@ namespace internal
       
              if (total == 3) 
                {
-                 Assert (perm_num == deal_II_numbers::invalid_unsigned_int,
+                 Assert (perm_num == numbers::invalid_unsigned_int,
                          ExcGridOrientError("More than one node with 3 incoming "
                                             "edges found in curent hex.")); 
                  perm_num = node_num;
@@ -1452,7 +1452,7 @@ namespace internal
            }
                                           // We should now have a
                                           // valid permutation number
-         Assert (perm_num != deal_II_numbers::invalid_unsigned_int,
+         Assert (perm_num != numbers::invalid_unsigned_int,
                  ExcGridOrientError("No node having 3 incoming edges found in curent hex.")); 
 
                                           // So use the apropriate
index ac95292b0186fce033513dace555b87a31fe6d44..ae66929542c26f7c3997c5cc4555ae55d04e2b19 100644 (file)
@@ -329,7 +329,7 @@ GridTools::delete_unused_vertices (std::vector<Point<dim> >    &vertices,
                                   // then renumber the vertices that
                                   // are actually used in the same
                                   // order as they were beforehand
-  const unsigned int invalid_vertex = deal_II_numbers::invalid_unsigned_int;
+  const unsigned int invalid_vertex = numbers::invalid_unsigned_int;
   std::vector<unsigned int> new_vertex_numbers (vertices.size(), invalid_vertex);
   unsigned int next_free_number = 0;
   for (unsigned int i=0; i<vertices.size(); ++i)
index f4d752102282f5f71ef66198e2b7ae2ac6f552e9..d3f628854b898b30719f79a6c35a739d16dfea73 100644 (file)
@@ -1956,8 +1956,8 @@ std::pair<unsigned int, unsigned int>
 CellAccessor<1>::neighbor_of_coarser_neighbor (const unsigned int) const
 {
   Assert(false, ExcImpossibleInDim(1));
-  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);
 }
 
 
@@ -2223,7 +2223,7 @@ unsigned int CellAccessor<dim>::neighbor_of_neighbor (const unsigned int neighbo
                                       // since then we did not find
                                       // our way back...
       Assert (false, ExcInternalError());
-      return deal_II_numbers::invalid_unsigned_int;
+      return numbers::invalid_unsigned_int;
     }
 }
 
@@ -2305,8 +2305,8 @@ CellAccessor<dim>::neighbor_of_coarser_neighbor (const unsigned int neighbor) co
                                   // 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);
 }
 
 
index 78e11d413d1041f1a96edcaad3e89c271306e58f..081c9d397d9eff367226c2d381aac61e0e06c1a3 100644 (file)
@@ -2297,7 +2297,7 @@ namespace hp
                                              identities[i].second);
 
                    Assert ((new_dof_indices[higher_dof_index] ==
-                            deal_II_numbers::invalid_unsigned_int)
+                            numbers::invalid_unsigned_int)
                            ||
                            (new_dof_indices[higher_dof_index] ==
                             lower_dof_index),
@@ -2441,10 +2441,10 @@ namespace hp
                                                               // slave to
                                                               // master
                              if (new_dof_indices[master_dof_index] !=
-                                 deal_II_numbers::invalid_unsigned_int)
+                                 numbers::invalid_unsigned_int)
                                {
                                  Assert (new_dof_indices[new_dof_indices[master_dof_index]] ==
-                                         deal_II_numbers::invalid_unsigned_int,
+                                         numbers::invalid_unsigned_int,
                                          ExcInternalError());
                                
                                  new_dof_indices[slave_dof_index]
@@ -2453,7 +2453,7 @@ namespace hp
                              else
                                {
                                  Assert ((new_dof_indices[master_dof_index] ==
-                                          deal_II_numbers::invalid_unsigned_int)
+                                          numbers::invalid_unsigned_int)
                                          ||
                                          (new_dof_indices[slave_dof_index] ==
                                           master_dof_index),
@@ -2519,7 +2519,7 @@ namespace hp
                        = line->dof_index (identities[i].second, other_fe_index);
 
                      Assert ((new_dof_indices[master_dof_index] ==
-                              deal_II_numbers::invalid_unsigned_int)
+                              numbers::invalid_unsigned_int)
                              ||
                              (new_dof_indices[slave_dof_index] ==
                               master_dof_index),
@@ -2624,7 +2624,7 @@ namespace hp
                       = quad->dof_index (identities[i].second, other_fe_index);
 
                     Assert ((new_dof_indices[master_dof_index] ==
-                             deal_II_numbers::invalid_unsigned_int)
+                             numbers::invalid_unsigned_int)
                             ||
                             (new_dof_indices[slave_dof_index] ==
                              master_dof_index),
@@ -2704,7 +2704,7 @@ namespace hp
                                     // lower-dimensional objects
                                     // where elements come together
     std::vector<unsigned int>
-      constrained_indices (used_dofs, deal_II_numbers::invalid_unsigned_int);
+      constrained_indices (used_dofs, numbers::invalid_unsigned_int);
     compute_vertex_dof_identities (constrained_indices);
     compute_line_dof_identities (constrained_indices);
     compute_quad_dof_identities (constrained_indices);
@@ -2713,10 +2713,10 @@ namespace hp
                                     // new numbers to those which are
                                     // not constrained
     std::vector<unsigned int>
-      new_dof_indices (used_dofs, deal_II_numbers::invalid_unsigned_int);
+      new_dof_indices (used_dofs, numbers::invalid_unsigned_int);
     unsigned int next_free_dof = 0;
     for (unsigned int i=0; i<used_dofs; ++i)
-      if (constrained_indices[i] == deal_II_numbers::invalid_unsigned_int)
+      if (constrained_indices[i] == numbers::invalid_unsigned_int)
        {
          new_dof_indices[i] = next_free_dof;
          ++next_free_dof;
@@ -2726,10 +2726,10 @@ namespace hp
                                     // are constrained and record the
                                     // new dof number for those:
     for (unsigned int i=0; i<used_dofs; ++i)
-      if (constrained_indices[i] != deal_II_numbers::invalid_unsigned_int)
+      if (constrained_indices[i] != numbers::invalid_unsigned_int)
        {
          Assert (new_dof_indices[constrained_indices[i]] !=
-                 deal_II_numbers::invalid_unsigned_int,
+                 numbers::invalid_unsigned_int,
                  ExcInternalError());
          
          new_dof_indices[i] = new_dof_indices[constrained_indices[i]];
@@ -2737,7 +2737,7 @@ namespace hp
 
     for (unsigned int i=0; i<used_dofs; ++i)
       {
-       Assert (new_dof_indices[i] != deal_II_numbers::invalid_unsigned_int,
+       Assert (new_dof_indices[i] != numbers::invalid_unsigned_int,
                ExcInternalError());
        Assert (new_dof_indices[i] < next_free_dof,
                ExcInternalError());
@@ -4134,7 +4134,7 @@ namespace hp
                                         // line_dofs_offsets field
        faces->lines.dof_offsets
          .resize (tria->n_raw_lines(),
-                  deal_II_numbers::invalid_unsigned_int);
+                  numbers::invalid_unsigned_int);
        
        unsigned int line_slots_needed = 0;
        for (unsigned int line=0; line<tria->n_raw_lines(); ++line)
@@ -4171,7 +4171,7 @@ namespace hp
                  }
                                               // finally place the end
                                               // marker
-             faces->lines.dofs[pointer] = deal_II_numbers::invalid_unsigned_int;
+             faces->lines.dofs[pointer] = numbers::invalid_unsigned_int;
            }
       }
 
@@ -4242,7 +4242,7 @@ namespace hp
                                     // already fill the
                                     // vertex_dofs_offsets field
     vertex_dofs_offsets.resize (tria->n_vertices(),
-                               deal_II_numbers::invalid_unsigned_int);
+                               numbers::invalid_unsigned_int);
       
     unsigned int vertex_slots_needed = 0;
     for (unsigned int v=0; v<tria->n_vertices(); ++v)
@@ -4279,7 +4279,7 @@ namespace hp
              }
                                           // finally place the end
                                           // marker
-         vertex_dofs[pointer] = deal_II_numbers::invalid_unsigned_int;
+         vertex_dofs[pointer] = numbers::invalid_unsigned_int;
        }
   }    
   
index 9f47c163775bbb810752ebbe63d6928bbf9d0177..b73be928e427993d66c5d089d7f985c9b7627b96 100644 (file)
@@ -37,9 +37,9 @@ namespace internal
                     fe_values_table (fe_collection.size(),
                                      mapping_collection.size(),
                                      q_collection.size()),
-                    present_fe_values_index (deal_II_numbers::invalid_unsigned_int,
-                                             deal_II_numbers::invalid_unsigned_int,
-                                             deal_II_numbers::invalid_unsigned_int),
+                    present_fe_values_index (numbers::invalid_unsigned_int,
+                                             numbers::invalid_unsigned_int,
+                                             numbers::invalid_unsigned_int),
                     update_flags (update_flags)
     {}
 
@@ -56,9 +56,9 @@ namespace internal
                     fe_values_table (fe_collection.size(),
                                      1,
                                      q_collection.size()),
-                    present_fe_values_index (deal_II_numbers::invalid_unsigned_int,
-                                             deal_II_numbers::invalid_unsigned_int,
-                                             deal_II_numbers::invalid_unsigned_int),
+                    present_fe_values_index (numbers::invalid_unsigned_int,
+                                             numbers::invalid_unsigned_int,
+                                             numbers::invalid_unsigned_int),
                     update_flags (update_flags)
     {}
 
@@ -149,7 +149,7 @@ namespace hp
                  real_mapping_index = mapping_index,
                  real_fe_index      = fe_index;
 
-    if (real_q_index == deal_II_numbers::invalid_unsigned_int)
+    if (real_q_index == numbers::invalid_unsigned_int)
       {
        if (this->q_collection.size() > 1)
          real_q_index = cell->active_fe_index();
@@ -157,7 +157,7 @@ namespace hp
          real_q_index = 0;
       }
     
-    if (real_mapping_index == deal_II_numbers::invalid_unsigned_int)
+    if (real_mapping_index == numbers::invalid_unsigned_int)
       {
        if (this->mapping_collection->size() > 1)
          real_mapping_index = cell->active_fe_index();
@@ -165,7 +165,7 @@ namespace hp
          real_mapping_index = 0;
       }
     
-    if (real_fe_index == deal_II_numbers::invalid_unsigned_int)
+    if (real_fe_index == numbers::invalid_unsigned_int)
       real_fe_index = cell->active_fe_index();
 
                                      // some checks
@@ -199,13 +199,13 @@ namespace hp
                  real_mapping_index = mapping_index,
                  real_fe_index      = fe_index;
 
-    if (real_q_index == deal_II_numbers::invalid_unsigned_int)
+    if (real_q_index == numbers::invalid_unsigned_int)
       real_q_index = 0;
     
-    if (real_mapping_index == deal_II_numbers::invalid_unsigned_int)
+    if (real_mapping_index == numbers::invalid_unsigned_int)
       real_mapping_index = 0;
 
-    if (real_fe_index == deal_II_numbers::invalid_unsigned_int)
+    if (real_fe_index == numbers::invalid_unsigned_int)
       real_fe_index = 0;
 
                                      // some checks
@@ -239,13 +239,13 @@ namespace hp
                  real_mapping_index = mapping_index,
                  real_fe_index      = fe_index;
 
-    if (real_q_index == deal_II_numbers::invalid_unsigned_int)
+    if (real_q_index == numbers::invalid_unsigned_int)
       real_q_index = 0;
     
-    if (real_mapping_index == deal_II_numbers::invalid_unsigned_int)
+    if (real_mapping_index == numbers::invalid_unsigned_int)
       real_mapping_index = 0;
 
-    if (real_fe_index == deal_II_numbers::invalid_unsigned_int)
+    if (real_fe_index == numbers::invalid_unsigned_int)
       real_fe_index = 0;
 
                                      // some checks
@@ -279,13 +279,13 @@ namespace hp
                  real_mapping_index = mapping_index,
                  real_fe_index      = fe_index;
 
-    if (real_q_index == deal_II_numbers::invalid_unsigned_int)
+    if (real_q_index == numbers::invalid_unsigned_int)
       real_q_index = 0;
     
-    if (real_mapping_index == deal_II_numbers::invalid_unsigned_int)
+    if (real_mapping_index == numbers::invalid_unsigned_int)
       real_mapping_index = 0;
 
-    if (real_fe_index == deal_II_numbers::invalid_unsigned_int)
+    if (real_fe_index == numbers::invalid_unsigned_int)
       real_fe_index = 0;
 
                                      // some checks
@@ -346,7 +346,7 @@ namespace hp
                  real_mapping_index = mapping_index,
                  real_fe_index      = fe_index;
 
-    if (real_q_index == deal_II_numbers::invalid_unsigned_int)
+    if (real_q_index == numbers::invalid_unsigned_int)
       {
        if (this->q_collection.size() > 1)
          real_q_index = cell->active_fe_index();
@@ -354,7 +354,7 @@ namespace hp
          real_q_index = 0;
       }
     
-    if (real_mapping_index == deal_II_numbers::invalid_unsigned_int)
+    if (real_mapping_index == numbers::invalid_unsigned_int)
       {
        if (this->mapping_collection->size() > 1)
          real_mapping_index = cell->active_fe_index();
@@ -362,7 +362,7 @@ namespace hp
          real_mapping_index = 0;
       }
     
-    if (real_fe_index == deal_II_numbers::invalid_unsigned_int)
+    if (real_fe_index == numbers::invalid_unsigned_int)
       real_fe_index = cell->active_fe_index();
 
                                      // some checks
@@ -397,13 +397,13 @@ namespace hp
                  real_mapping_index = mapping_index,
                  real_fe_index      = fe_index;
 
-    if (real_q_index == deal_II_numbers::invalid_unsigned_int)
+    if (real_q_index == numbers::invalid_unsigned_int)
       real_q_index = 0;
     
-    if (real_mapping_index == deal_II_numbers::invalid_unsigned_int)
+    if (real_mapping_index == numbers::invalid_unsigned_int)
       real_mapping_index = 0;
 
-    if (real_fe_index == deal_II_numbers::invalid_unsigned_int)
+    if (real_fe_index == numbers::invalid_unsigned_int)
       real_fe_index = 0;
 
                                      // some checks
@@ -438,13 +438,13 @@ namespace hp
                  real_mapping_index = mapping_index,
                  real_fe_index      = fe_index;
 
-    if (real_q_index == deal_II_numbers::invalid_unsigned_int)
+    if (real_q_index == numbers::invalid_unsigned_int)
       real_q_index = 0;
     
-    if (real_mapping_index == deal_II_numbers::invalid_unsigned_int)
+    if (real_mapping_index == numbers::invalid_unsigned_int)
       real_mapping_index = 0;
 
-    if (real_fe_index == deal_II_numbers::invalid_unsigned_int)
+    if (real_fe_index == numbers::invalid_unsigned_int)
       real_fe_index = 0;
 
                                      // some checks
@@ -479,13 +479,13 @@ namespace hp
                  real_mapping_index = mapping_index,
                  real_fe_index      = fe_index;
 
-    if (real_q_index == deal_II_numbers::invalid_unsigned_int)
+    if (real_q_index == numbers::invalid_unsigned_int)
       real_q_index = 0;
     
-    if (real_mapping_index == deal_II_numbers::invalid_unsigned_int)
+    if (real_mapping_index == numbers::invalid_unsigned_int)
       real_mapping_index = 0;
 
-    if (real_fe_index == deal_II_numbers::invalid_unsigned_int)
+    if (real_fe_index == numbers::invalid_unsigned_int)
       real_fe_index = 0;
 
                                      // some checks
@@ -547,7 +547,7 @@ namespace hp
                  real_mapping_index = mapping_index,
                  real_fe_index      = fe_index;
 
-    if (real_q_index == deal_II_numbers::invalid_unsigned_int)
+    if (real_q_index == numbers::invalid_unsigned_int)
       {
        if (this->q_collection.size() > 1)
          real_q_index = cell->active_fe_index();
@@ -555,7 +555,7 @@ namespace hp
          real_q_index = 0;
       }
     
-    if (real_mapping_index == deal_II_numbers::invalid_unsigned_int)
+    if (real_mapping_index == numbers::invalid_unsigned_int)
       {
        if (this->mapping_collection->size() > 1)
          real_mapping_index = cell->active_fe_index();
@@ -563,7 +563,7 @@ namespace hp
          real_mapping_index = 0;
       }
     
-    if (real_fe_index == deal_II_numbers::invalid_unsigned_int)
+    if (real_fe_index == numbers::invalid_unsigned_int)
       real_fe_index = cell->active_fe_index();
 
                                      // some checks
@@ -599,13 +599,13 @@ namespace hp
                  real_mapping_index = mapping_index,
                  real_fe_index      = fe_index;
 
-    if (real_q_index == deal_II_numbers::invalid_unsigned_int)
+    if (real_q_index == numbers::invalid_unsigned_int)
       real_q_index = 0;
     
-    if (real_mapping_index == deal_II_numbers::invalid_unsigned_int)
+    if (real_mapping_index == numbers::invalid_unsigned_int)
       real_mapping_index = 0;
 
-    if (real_fe_index == deal_II_numbers::invalid_unsigned_int)
+    if (real_fe_index == numbers::invalid_unsigned_int)
       real_fe_index = 0;
 
                                      // some checks
@@ -641,13 +641,13 @@ namespace hp
                  real_mapping_index = mapping_index,
                  real_fe_index      = fe_index;
 
-    if (real_q_index == deal_II_numbers::invalid_unsigned_int)
+    if (real_q_index == numbers::invalid_unsigned_int)
       real_q_index = 0;
     
-    if (real_mapping_index == deal_II_numbers::invalid_unsigned_int)
+    if (real_mapping_index == numbers::invalid_unsigned_int)
       real_mapping_index = 0;
 
-    if (real_fe_index == deal_II_numbers::invalid_unsigned_int)
+    if (real_fe_index == numbers::invalid_unsigned_int)
       real_fe_index = 0;
 
                                      // some checks
@@ -683,13 +683,13 @@ namespace hp
                  real_mapping_index = mapping_index,
                  real_fe_index      = fe_index;
 
-    if (real_q_index == deal_II_numbers::invalid_unsigned_int)
+    if (real_q_index == numbers::invalid_unsigned_int)
       real_q_index = 0;
     
-    if (real_mapping_index == deal_II_numbers::invalid_unsigned_int)
+    if (real_mapping_index == numbers::invalid_unsigned_int)
       real_mapping_index = 0;
 
-    if (real_fe_index == deal_II_numbers::invalid_unsigned_int)
+    if (real_fe_index == numbers::invalid_unsigned_int)
       real_fe_index = 0;
 
                                      // some checks
index d56870496e9f16b8dd6d21e045b33780ad12aaf0..71c7e24afcde54c0abe8e3b75a25745d08517e6b 100644 (file)
@@ -36,8 +36,8 @@ template <int structdim, int dim>
 MGDoFAccessor<structdim, dim>::MGDoFAccessor ()
                :
                BaseClass (0,
-                          static_cast<int>(deal_II_numbers::invalid_unsigned_int),
-                          static_cast<int>(deal_II_numbers::invalid_unsigned_int),
+                          static_cast<int>(numbers::invalid_unsigned_int),
+                          static_cast<int>(numbers::invalid_unsigned_int),
                           0),
                mg_dof_handler(0)
 {
index 773c608b1d1b628ab4b9cc91ee049ed5f0719851..18aa95055ec344082ab0a1c4062eda1aca79d4d4 100644 (file)
@@ -38,7 +38,7 @@ DEAL_II_NAMESPACE_OPEN
 template <int dim>
 MGDoFHandler<dim>::MGVertexDoFs::MGVertexDoFs ()
                :
-               coarsest_level (deal_II_numbers::invalid_unsigned_int),
+               coarsest_level (numbers::invalid_unsigned_int),
                finest_level (0),
                indices (0)
 {}
index 808c6baa279565298c46f4e0a290a9ab0a150984..540b696168e1467252190b5d06ab3e892f261e13 100644 (file)
@@ -1246,7 +1246,7 @@ MGTools::make_boundary_list(
                                  :
                                  i+4*fe.dofs_per_vertex+8*fe.dofs_per_line))
                                :
-                               deal_II_numbers::invalid_unsigned_int)));
+                               numbers::invalid_unsigned_int)));
                         Assert (cell_i < fe.dofs_per_cell, ExcInternalError());
 
                                                          // make sure
index a859fb73eded38033d0c961ed8b9112dcfa2b8ed..c80bd4db3ea82d31779ad83fc6d3b1a0e8375b6f 100644 (file)
@@ -56,7 +56,7 @@ void MGTransferBlockBase::build_matrices (
     if (selected[i])
       mg_block[i] = n_mg_blocks++;
     else
-      mg_block[i] = deal_II_numbers::invalid_unsigned_int;
+      mg_block[i] = numbers::invalid_unsigned_int;
   
                                   // Compute the lengths of all blocks
   sizes.resize(n_levels);
index 0ccdee4aaa6fe0facf18ac26bb4598a235c54142..4d462fb2237d2e5cce2c73e7342d74e0e09fdd00 100644 (file)
@@ -679,7 +679,7 @@ void DataOut<dim,DH>::build_some_patches (Data &data)
                             std::distance (this->dofs->begin_active(),
                                            active_cell_iterator (cell))
                             :
-                            deal_II_numbers::invalid_unsigned_int);
+                            numbers::invalid_unsigned_int);
   
   
                                   // get first cell in this thread
index 9c0bc192bcd6dce5fadc1892352bc7eb586a1016..9d3befa0c3861bdcea3e19b6c72f1d3a8303c11a 100644 (file)
@@ -96,9 +96,9 @@ void DataOutRotation<dim,DH>::build_some_patches (Data &data)
   std::vector<Point<DH::dimension+1> > angle_directions (n_patches_per_circle+1);
   for (unsigned int i=0; i<=n_patches_per_circle; ++i)
     {
-      angle_directions[i][DH::dimension-1] = std::cos(2*deal_II_numbers::PI *
+      angle_directions[i][DH::dimension-1] = std::cos(2*numbers::PI *
                                                      i/n_patches_per_circle);
-      angle_directions[i][DH::dimension] = std::sin(2*deal_II_numbers::PI *
+      angle_directions[i][DH::dimension] = std::sin(2*numbers::PI *
                                                    i/n_patches_per_circle);
     };
   
index eb7ae49d6fc63f2a5539f36baa9f803a41c5db7b..269231d24b926bb6f721f1a60edc21fd6c9e392d 100644 (file)
@@ -341,8 +341,8 @@ C DEFINE A TEST MATRIX
        {
          const double theta = std::acos(XX) / 3.;
          EE[0] = am + R*std::cos(theta);
-         EE[1] = am + R*std::cos(theta + 2./3.*deal_II_numbers::PI);
-         EE[2] = am + R*std::cos(theta + 4./3.*deal_II_numbers::PI);
+         EE[1] = am + R*std::cos(theta + 2./3.*numbers::PI);
+         EE[2] = am + R*std::cos(theta + 4./3.*numbers::PI);
        };
     };
 
index 5dec7d989a74962591d908d1d05f450d29ec5bc3..8051a74d761747564ce8f78764f583dd9d44cdad 100644 (file)
@@ -332,11 +332,11 @@ estimate (const Mapping<1>                    &mapping,
   typename DH::active_cell_iterator cell = dof_handler.begin_active();
   for (unsigned int cell_index=0; cell != dof_handler.end();
        ++cell, ++cell_index)
-    if (((subdomain_id == deal_II_numbers::invalid_unsigned_int)
+    if (((subdomain_id == numbers::invalid_unsigned_int)
          ||
          (cell->subdomain_id() == subdomain_id))
         &&
-        ((material_id == deal_II_numbers::invalid_unsigned_int)
+        ((material_id == numbers::invalid_unsigned_int)
          ||
          (cell->material_id() == material_id)))
       {
@@ -796,11 +796,11 @@ estimate_some (const hp::MappingCollection<dim>                  &mapping,
                                            // material_id), or if one of the
                                            // neighbors behind the face is on
                                            // the subdomain we care for
-          if ( ! ( ((subdomain_id == deal_II_numbers::invalid_unsigned_int)
+          if ( ! ( ((subdomain_id == numbers::invalid_unsigned_int)
                     ||
                     (cell->subdomain_id() == subdomain_id))
                    &&
-                   ((material_id == deal_II_numbers::invalid_unsigned_int)
+                   ((material_id == numbers::invalid_unsigned_int)
                     ||
                     (cell->material_id() == material_id))) )
             {
@@ -816,11 +816,11 @@ estimate_some (const hp::MappingCollection<dim>                  &mapping,
               if (face->has_children() == false)
                 care_for_cell |= ((cell->neighbor(face_no)->subdomain_id()
                                    == subdomain_id) ||
-                                  (subdomain_id == deal_II_numbers::invalid_unsigned_int))
+                                  (subdomain_id == numbers::invalid_unsigned_int))
                                  &&
                                  ((cell->neighbor(face_no)->material_id()
                                    == material_id) ||
-                                  (material_id == deal_II_numbers::invalid_unsigned_int));
+                                  (material_id == numbers::invalid_unsigned_int));
               else
                 {
                   for (unsigned int sf=0; sf<face->n_children(); ++sf)
@@ -828,13 +828,13 @@ estimate_some (const hp::MappingCollection<dim>                  &mapping,
                           ->subdomain_id() == subdomain_id)
                          &&
                          (material_id ==
-                          deal_II_numbers::invalid_unsigned_int))
+                          numbers::invalid_unsigned_int))
                         ||
                         ((cell->neighbor_child_on_subface(face_no,sf)
                           ->material_id() == material_id)
                          &&
                          (subdomain_id ==
-                          deal_II_numbers::invalid_unsigned_int)))
+                          numbers::invalid_unsigned_int)))
                       {
                         care_for_cell = true;
                         break;
@@ -1068,11 +1068,11 @@ estimate (const Mapping<dim>                  &mapping,
   for (typename DH::active_cell_iterator cell=dof_handler.begin_active();
        cell!=dof_handler.end();
        ++cell, ++present_cell)
-    if ( ((subdomain_id == deal_II_numbers::invalid_unsigned_int)
+    if ( ((subdomain_id == numbers::invalid_unsigned_int)
           ||
           (cell->subdomain_id() == subdomain_id))
          &&
-         ((material_id == deal_II_numbers::invalid_unsigned_int)
+         ((material_id == numbers::invalid_unsigned_int)
           ||
           (cell->material_id() == material_id)))
       {
index 02a144c014c1075fca5ddca56e5aea0123b1ea11..6e6c9264ae88e3b782708075e0dbe2069a08194f 100644 (file)
@@ -1208,10 +1208,10 @@ create_boundary_mass_matrix_1 (const Mapping<dim>        &mapping,
           Threads::ThreadMutex::ScopedLock lock (mutex);
          for (unsigned int i=0; i<dofs_per_cell; ++i)
            {
-             if (dof_is_on_face[i] && dof_to_boundary_mapping[dofs[i]] != deal_II_numbers::invalid_unsigned_int)
+             if (dof_is_on_face[i] && dof_to_boundary_mapping[dofs[i]] != numbers::invalid_unsigned_int)
                {
                  for (unsigned int j=0; j<dofs_per_cell; ++j)
-                   if (dof_is_on_face[j] && dof_to_boundary_mapping[dofs[j]] != deal_II_numbers::invalid_unsigned_int)
+                   if (dof_is_on_face[j] && dof_to_boundary_mapping[dofs[j]] != numbers::invalid_unsigned_int)
                      matrix.add(dof_to_boundary_mapping[dofs[i]],
                                 dof_to_boundary_mapping[dofs[j]],
                                 cell_matrix(i,j));
index edf06a5a5d609842ca66ec1b612b047551ffcd71..61d80668fc7289a5f07b9ae2146a7a2816ce9243 100644 (file)
@@ -38,7 +38,7 @@ TimeDependent::TimeSteppingData::TimeSteppingData (const unsigned int look_ahead
 TimeDependent::TimeDependent (const TimeSteppingData &data_primal,
                              const TimeSteppingData &data_dual,
                              const TimeSteppingData &data_postprocess):
-               sweep_no (deal_II_numbers::invalid_unsigned_int),
+               sweep_no (numbers::invalid_unsigned_int),
                timestepping_data_primal (data_primal),
                timestepping_data_dual (data_dual),
                timestepping_data_postprocess (data_postprocess)
@@ -255,8 +255,8 @@ unsigned int TimeDependent::memory_consumption () const
 TimeStepBase::TimeStepBase (const double time) :
                previous_timestep(0),
                next_timestep (0),
-               sweep_no (deal_II_numbers::invalid_unsigned_int),
-               timestep_no (deal_II_numbers::invalid_unsigned_int),
+               sweep_no (numbers::invalid_unsigned_int),
+               timestep_no (numbers::invalid_unsigned_int),
                time (time)
 {}
 
index 2c7099de856975df60a2cabcb8a5ca8cdda14190..efbbc4059c26e5578a4794b5394f76726b99850e 100644 (file)
@@ -30,6 +30,14 @@ inconvenience this causes.
 </p>
 
 <ol>
+  <li> <p>Changed: The namespace deal_II_numbers has been renamed dealii::numbers.
+  The old name stemmed from a time when not everything was already in
+  namespace <code>dealii</code>. The old name is retained via a namespace
+  alias but is deprecated and will eventually be removed.
+  <br>
+  (WB 2007/11/02)
+  </p>
+
   <li> <p>Changed: When writing output files in UCD format using either the
   DataOutBase or the GridOut class, we used to write a preamble at the
   beginning of the file that included the date and time the file was created.
index 5eca1070c2d29eb648c0b483cce8854c4db3c32e..b0e5499299223e48fd7257389789205b5686910b 100644 (file)
@@ -310,7 +310,7 @@ double BoundaryValuesU<dim>::value (const Point<dim> &p,
       (p[0] < 0) &&
       (p[1] < 1./3) &&
       (p[1] > -1./3))
-    return std::sin (this->get_time() * 4 * deal_II_numbers::PI);
+    return std::sin (this->get_time() * 4 * numbers::PI);
   else
     return 0;
 }
@@ -327,8 +327,8 @@ double BoundaryValuesV<dim>::value (const Point<dim> &p,
       (p[0] < 0) &&
       (p[1] < 1./3) &&
       (p[1] > -1./3))
-    return (std::cos (this->get_time() * 4 * deal_II_numbers::PI) *
-           4 * deal_II_numbers::PI);
+    return (std::cos (this->get_time() * 4 * numbers::PI) *
+           4 * numbers::PI);
   else
     return 0;
 }
index c65c6a5c82d0953a5787059e209017c77627ed91..7c6f8597a309f05bfa4b2a64c7991fbadd0817b8 100644 (file)
@@ -252,9 +252,9 @@ TATForwardProblem<dim>::TATForwardProblem ()
   const double detector_step_angle = 2.25;
   const double detector_radius = 0.5;
   
-  for (double detector_angle = 2*deal_II_numbers::PI;
+  for (double detector_angle = 2*numbers::PI;
        detector_angle >= 0;
-       detector_angle -= detector_step_angle/360*2*deal_II_numbers::PI)
+       detector_angle -= detector_step_angle/360*2*numbers::PI)
     detector_locations.push_back (Point<dim> (std::cos(detector_angle),
                                              std::sin(detector_angle)) *
                                  detector_radius);
index fc6dbe019a872b4222857d9eb615d500a7058786..221b8442f928a619e0fbff5abb1a00088280c388 100644 (file)
@@ -211,7 +211,7 @@ double ExactSolution<dim>::value (const Point<dim> &p,
 
       case 2:
       {
-       const double theta  = deal_II_numbers::PI/4.;
+       const double theta  = numbers::PI/4.;
        const double lambda  = 1.;
        const double a0  = 1.;
        const double s   = 1.;
@@ -224,8 +224,8 @@ double ExactSolution<dim>::value (const Point<dim> &p,
 
       case 3:
       {
-       double theta  = deal_II_numbers::PI/4;
-       double phi = deal_II_numbers::PI/4;
+       double theta  = numbers::PI/4;
+       double phi = numbers::PI/4;
        double tau = 1.;
        double c0  = 1.;
        double s   = 1.;
index 40737884bfd21e45614fddf55289856834ae3def..e5603b57654d3e3c2eedd5f2843f352ab8fc0726 100644 (file)
@@ -807,8 +807,8 @@ estimate_smoothness (Vector<float> &smoothness_indicators) const
                &&
                (i*i + j*j < N*N))
              {
-               k_vectors.push_back (Point<dim>(deal_II_numbers::PI * i,
-                                               deal_II_numbers::PI * j));
+               k_vectors.push_back (Point<dim>(numbers::PI * i,
+                                               numbers::PI * j));
                k_vectors_magnitude.push_back (i*i+j*j);
              }
        
@@ -824,9 +824,9 @@ estimate_smoothness (Vector<float> &smoothness_indicators) const
                  &&
                  (i*i + j*j + k*k < N*N))
                {
-                 k_vectors.push_back (Point<dim>(deal_II_numbers::PI * i,
-                                                 deal_II_numbers::PI * j,
-                                                 deal_II_numbers::PI * k));
+                 k_vectors.push_back (Point<dim>(numbers::PI * i,
+                                                 numbers::PI * j,
+                                                 numbers::PI * k));
                  k_vectors_magnitude.push_back (i*i+j*j+k*k);
              }
        
@@ -912,7 +912,7 @@ estimate_smoothness (Vector<float> &smoothness_indicators) const
                       quadrature.weight(q);
              }
            fourier_transform_matrices[fe](k,j)
-             = sum / std::pow(2*deal_II_numbers::PI, 1.*dim/2);
+             = sum / std::pow(2*numbers::PI, 1.*dim/2);
          }
     }
 
index d32f1ae4db84cdc19c16bbcb9020d43df6344e62..9b2c4fe8ce6e4623f39154742c589b6e1b940273 100644 (file)
@@ -331,7 +331,7 @@ AdvectionField<dim>::value (const Point<dim> &p) const
   Point<dim> value;
   value[0] = 2;
   for (unsigned int i=1; i<dim; ++i)
-    value[i] = 1+0.8*std::sin(8*deal_II_numbers::PI*p[0]);
+    value[i] = 1+0.8*std::sin(8*numbers::PI*p[0]);
 
   return value;
 }
@@ -478,7 +478,7 @@ BoundaryValues<dim>::value (const Point<dim>   &p,
 {
   Assert (component == 0, ExcIndexRange (component, 0, 1));
 
-  const double sine_term = std::sin(16*deal_II_numbers::PI*std::sqrt(p.square()));
+  const double sine_term = std::sin(16*numbers::PI*std::sqrt(p.square()));
   const double weight    = std::exp(-5*p.square()) / std::exp(-5.);
   return sine_term * weight;
 }
index 34f11e932c9bb8e964edb17026f33b803827a3ba..11f81f5494101e67646a2991e7d184fab3a8532d 100644 (file)
@@ -1010,7 +1010,7 @@ namespace BlockMatrixIterators
   unsigned int
   AccessorBase<BlockMatrix>::block_row() const
   {
-    Assert (row_block != deal_II_numbers::invalid_unsigned_int,
+    Assert (row_block != numbers::invalid_unsigned_int,
            ExcIteratorPastEnd());
     
     return row_block;
@@ -1022,7 +1022,7 @@ namespace BlockMatrixIterators
   unsigned int
   AccessorBase<BlockMatrix>::block_column() const
   {
-    Assert (col_block != deal_II_numbers::invalid_unsigned_int,
+    Assert (col_block != numbers::invalid_unsigned_int,
            ExcIteratorPastEnd());
     
     return col_block;
@@ -1075,8 +1075,8 @@ namespace BlockMatrixIterators
       {
                                         // we were asked to create the end
                                         // iterator for this matrix
-       this->row_block = deal_II_numbers::invalid_unsigned_int;
-       this->col_block = deal_II_numbers::invalid_unsigned_int;
+       this->row_block = numbers::invalid_unsigned_int;
+       this->col_block = numbers::invalid_unsigned_int;
       }
   }
   
@@ -1110,7 +1110,7 @@ namespace BlockMatrixIterators
   unsigned int
   Accessor<BlockMatrix, true>::row() const
   {
-    Assert (this->row_block != deal_II_numbers::invalid_unsigned_int,
+    Assert (this->row_block != numbers::invalid_unsigned_int,
            ExcIteratorPastEnd());
     
     return (matrix->row_block_indices.local_to_global(this->row_block, 0) +
@@ -1123,7 +1123,7 @@ namespace BlockMatrixIterators
   unsigned int
   Accessor<BlockMatrix, true>::column() const
   {
-    Assert (this->col_block != deal_II_numbers::invalid_unsigned_int,
+    Assert (this->col_block != numbers::invalid_unsigned_int,
            ExcIteratorPastEnd());
     
     return (matrix->column_block_indices.local_to_global(this->col_block,0) +
@@ -1136,9 +1136,9 @@ namespace BlockMatrixIterators
   typename Accessor<BlockMatrix, true>::value_type
   Accessor<BlockMatrix, true>::value () const
   {
-    Assert (this->row_block != deal_II_numbers::invalid_unsigned_int,
+    Assert (this->row_block != numbers::invalid_unsigned_int,
            ExcIteratorPastEnd());
-    Assert (this->col_block != deal_II_numbers::invalid_unsigned_int,
+    Assert (this->col_block != numbers::invalid_unsigned_int,
            ExcIteratorPastEnd());
     
     return base_iterator->value();
@@ -1151,9 +1151,9 @@ namespace BlockMatrixIterators
   void
   Accessor<BlockMatrix, true>::advance ()
   {      
-    Assert (this->row_block != deal_II_numbers::invalid_unsigned_int,
+    Assert (this->row_block != numbers::invalid_unsigned_int,
            ExcIteratorPastEnd());
-    Assert (this->col_block != deal_II_numbers::invalid_unsigned_int,
+    Assert (this->col_block != numbers::invalid_unsigned_int,
            ExcIteratorPastEnd());
     
                                     // Remember current row inside block
@@ -1199,8 +1199,8 @@ namespace BlockMatrixIterators
                ++this->row_block;
                if (this->row_block == matrix->n_block_rows())
                  {
-                   this->row_block = deal_II_numbers::invalid_unsigned_int;
-                   this->col_block = deal_II_numbers::invalid_unsigned_int;
+                   this->row_block = numbers::invalid_unsigned_int;
+                   this->col_block = numbers::invalid_unsigned_int;
                    return;
                  }
              }
@@ -1226,9 +1226,9 @@ namespace BlockMatrixIterators
                                       // have to have the same
                                       // base_iterator representation, but
                                       // valid iterators have to
-      return (((this->row_block == deal_II_numbers::invalid_unsigned_int)
+      return (((this->row_block == numbers::invalid_unsigned_int)
               &&
-              (this->col_block == deal_II_numbers::invalid_unsigned_int))
+              (this->col_block == numbers::invalid_unsigned_int))
              ||
              (base_iterator == a.base_iterator));
 
@@ -1283,8 +1283,8 @@ namespace BlockMatrixIterators
       {
                                         // we were asked to create the end
                                         // iterator for this matrix
-       this->row_block = deal_II_numbers::invalid_unsigned_int;
-       this->col_block = deal_II_numbers::invalid_unsigned_int;
+       this->row_block = numbers::invalid_unsigned_int;
+       this->col_block = numbers::invalid_unsigned_int;
       }
   }
   
@@ -1294,7 +1294,7 @@ namespace BlockMatrixIterators
   unsigned int
   Accessor<BlockMatrix, false>::row() const
   {
-    Assert (this->row_block != deal_II_numbers::invalid_unsigned_int,
+    Assert (this->row_block != numbers::invalid_unsigned_int,
            ExcIteratorPastEnd());
     
     return (matrix->row_block_indices.local_to_global(this->row_block, 0) +
@@ -1307,7 +1307,7 @@ namespace BlockMatrixIterators
   unsigned int
   Accessor<BlockMatrix, false>::column() const
   {
-    Assert (this->col_block != deal_II_numbers::invalid_unsigned_int,
+    Assert (this->col_block != numbers::invalid_unsigned_int,
            ExcIteratorPastEnd());
     
     return (matrix->column_block_indices.local_to_global(this->col_block,0) +
@@ -1320,9 +1320,9 @@ namespace BlockMatrixIterators
   typename Accessor<BlockMatrix, false>::value_type
   Accessor<BlockMatrix, false>::value () const
   {
-    Assert (this->row_block != deal_II_numbers::invalid_unsigned_int,
+    Assert (this->row_block != numbers::invalid_unsigned_int,
            ExcIteratorPastEnd());
-    Assert (this->col_block != deal_II_numbers::invalid_unsigned_int,
+    Assert (this->col_block != numbers::invalid_unsigned_int,
            ExcIteratorPastEnd());
     
     return base_iterator->value();
@@ -1335,9 +1335,9 @@ namespace BlockMatrixIterators
   void
   Accessor<BlockMatrix, false>::set_value (typename Accessor<BlockMatrix, false>::value_type newval) const
   {
-    Assert (this->row_block != deal_II_numbers::invalid_unsigned_int,
+    Assert (this->row_block != numbers::invalid_unsigned_int,
            ExcIteratorPastEnd());
-    Assert (this->col_block != deal_II_numbers::invalid_unsigned_int,
+    Assert (this->col_block != numbers::invalid_unsigned_int,
            ExcIteratorPastEnd());
     
     base_iterator->value() = newval;
@@ -1350,9 +1350,9 @@ namespace BlockMatrixIterators
   void
   Accessor<BlockMatrix, false>::advance ()
   {      
-    Assert (this->row_block != deal_II_numbers::invalid_unsigned_int,
+    Assert (this->row_block != numbers::invalid_unsigned_int,
            ExcIteratorPastEnd());
-    Assert (this->col_block != deal_II_numbers::invalid_unsigned_int,
+    Assert (this->col_block != numbers::invalid_unsigned_int,
            ExcIteratorPastEnd());
     
                                     // Remember current row inside block
@@ -1398,8 +1398,8 @@ namespace BlockMatrixIterators
                ++this->row_block;
                if (this->row_block == matrix->n_block_rows())
                  {
-                   this->row_block = deal_II_numbers::invalid_unsigned_int;
-                   this->col_block = deal_II_numbers::invalid_unsigned_int;
+                   this->row_block = numbers::invalid_unsigned_int;
+                   this->col_block = numbers::invalid_unsigned_int;
                    return;
                  }
              }
@@ -1426,9 +1426,9 @@ namespace BlockMatrixIterators
                                       // have to have the same
                                       // base_iterator representation, but
                                       // valid iterators have to
-      return (((this->row_block == deal_II_numbers::invalid_unsigned_int)
+      return (((this->row_block == numbers::invalid_unsigned_int)
               &&
-              (this->col_block == deal_II_numbers::invalid_unsigned_int))
+              (this->col_block == numbers::invalid_unsigned_int))
              ||
              (base_iterator == a.base_iterator));
 
@@ -1558,7 +1558,7 @@ BlockMatrixBase<MatrixType>::set (const unsigned int i,
                                   const value_type value)
 {
 
-  Assert (deal_II_numbers::is_finite(value), 
+  Assert (numbers::is_finite(value), 
           ExcMessage("The given value is not finite but either infinite or Not A Number (NaN)"));
 
   const std::pair<unsigned int,unsigned int>
@@ -1579,7 +1579,7 @@ BlockMatrixBase<MatrixType>::add (const unsigned int i,
                                   const value_type value)
 {
 
-  Assert (deal_II_numbers::is_finite(value), 
+  Assert (numbers::is_finite(value), 
           ExcMessage("The given value is not finite but either infinite or Not A Number (NaN)"));
 
                                    // save some cycles for zero additions, but
index 9e3d1c2999f9de84691cab644dcbf4731569f6df..06817ba4746426974966d652f70d8c117fa5b184 100644 (file)
@@ -420,7 +420,7 @@ BlockSparseMatrixEZ<Number>::set (const unsigned int i,
                                  const Number value)
 {
 
-  Assert (deal_II_numbers::is_finite(value), 
+  Assert (numbers::is_finite(value), 
           ExcMessage("The given value is not finite but either infinite or Not A Number (NaN)"));
 
   const std::pair<unsigned int,unsigned int>
@@ -441,7 +441,7 @@ BlockSparseMatrixEZ<Number>::add (const unsigned int i,
                                  const Number value)
 {
 
-  Assert (deal_II_numbers::is_finite(value), 
+  Assert (numbers::is_finite(value), 
           ExcMessage("The given value is not finite but either infinite or Not A Number (NaN)"));
 
   const std::pair<unsigned int,unsigned int>
index ff2faef5d033fd1a4ce2d67b02679ff9ab2043d1..0ff8b713b72469b82ea5f06d707f54efb0eda534 100644 (file)
@@ -431,7 +431,7 @@ BlockVector<Number> &
 BlockVector<Number>::operator = (const value_type s)
 {
 
-  Assert (deal_II_numbers::is_finite(s), 
+  Assert (numbers::is_finite(s), 
           ExcMessage("The given value is not finite but either infinite or Not A Number (NaN)"));
  
   BaseClass::operator = (s);
@@ -477,7 +477,7 @@ template <typename Number>
 void BlockVector<Number>::scale (const value_type factor)
 {
 
-  Assert (deal_II_numbers::is_finite(factor), 
+  Assert (numbers::is_finite(factor), 
           ExcMessage("The given value is not finite but either infinite or Not A Number (NaN)"));
 
   for (unsigned int i=0; i<this->n_blocks();++i)
index a22727108d9593cf29d9ba54f05b3ce32be7e4b8..094191ae66923c7c145baba92103cbde841310b7 100644 (file)
@@ -1504,7 +1504,7 @@ namespace internal
           current_block       = parent.n_blocks();
           index_within_block  = 0;
           next_break_backward = global_index;
-          next_break_forward  = deal_II_numbers::invalid_unsigned_int;
+          next_break_forward  = numbers::invalid_unsigned_int;
         };
     }
 
@@ -1536,7 +1536,7 @@ namespace internal
                                              // then move the next
                                              // boundary arbitrarily far
                                              // away
-            next_break_forward = deal_II_numbers::invalid_unsigned_int;
+            next_break_forward = numbers::invalid_unsigned_int;
         };
   
       ++global_index;
@@ -1571,7 +1571,7 @@ namespace internal
                                            // get into unspecified terrain
           {
             --current_block;
-            index_within_block = deal_II_numbers::invalid_unsigned_int;
+            index_within_block = numbers::invalid_unsigned_int;
             next_break_forward = 0;
             next_break_backward = 0;
           };
@@ -1845,7 +1845,7 @@ template <class VectorType>
 void BlockVectorBase<VectorType>::add (const value_type a)
 {
 
-  Assert (deal_II_numbers::is_finite(a), 
+  Assert (numbers::is_finite(a), 
           ExcMessage("The given value is not finite but either infinite or Not A Number (NaN)"));
 
   for (unsigned int i=0;i<n_blocks();++i)
@@ -1875,7 +1875,7 @@ void BlockVectorBase<VectorType>::add (const value_type a,
                                        const BlockVectorBase<VectorType>& v)
 {
 
-  Assert (deal_II_numbers::is_finite(a), 
+  Assert (numbers::is_finite(a), 
           ExcMessage("The given value is not finite but either infinite or Not A Number (NaN)"));
 
   Assert (n_blocks() == v.n_blocks(),
@@ -1896,9 +1896,9 @@ void BlockVectorBase<VectorType>::add (const value_type a,
                                        const BlockVectorBase<VectorType>& w)
 {
 
-  Assert (deal_II_numbers::is_finite(a), 
+  Assert (numbers::is_finite(a), 
           ExcMessage("The given value is not finite but either infinite or Not A Number (NaN)"));
-  Assert (deal_II_numbers::is_finite(b), 
+  Assert (numbers::is_finite(b), 
           ExcMessage("The given value is not finite but either infinite or Not A Number (NaN)"));
 
   Assert (n_blocks() == v.n_blocks(),
@@ -1920,7 +1920,7 @@ void BlockVectorBase<VectorType>::sadd (const value_type x,
                                         const BlockVectorBase<VectorType>& v)
 {
 
-  Assert (deal_II_numbers::is_finite(x), 
+  Assert (numbers::is_finite(x), 
           ExcMessage("The given value is not finite but either infinite or Not A Number (NaN)"));
 
   Assert (n_blocks() == v.n_blocks(),
@@ -1939,9 +1939,9 @@ void BlockVectorBase<VectorType>::sadd (const value_type x, const value_type a,
                                         const BlockVectorBase<VectorType>& v)
 {
 
-  Assert (deal_II_numbers::is_finite(x), 
+  Assert (numbers::is_finite(x), 
           ExcMessage("The given value is not finite but either infinite or Not A Number (NaN)"));
-  Assert (deal_II_numbers::is_finite(a), 
+  Assert (numbers::is_finite(a), 
           ExcMessage("The given value is not finite but either infinite or Not A Number (NaN)"));
 
   Assert (n_blocks() == v.n_blocks(),
@@ -1962,11 +1962,11 @@ void BlockVectorBase<VectorType>::sadd (const value_type x, const value_type a,
                                         const BlockVectorBase<VectorType>& w)
 {
 
-  Assert (deal_II_numbers::is_finite(x), 
+  Assert (numbers::is_finite(x), 
           ExcMessage("The given value is not finite but either infinite or Not A Number (NaN)"));
-  Assert (deal_II_numbers::is_finite(a), 
+  Assert (numbers::is_finite(a), 
           ExcMessage("The given value is not finite but either infinite or Not A Number (NaN)"));
-  Assert (deal_II_numbers::is_finite(b), 
+  Assert (numbers::is_finite(b), 
           ExcMessage("The given value is not finite but either infinite or Not A Number (NaN)"));
 
   Assert (n_blocks() == v.n_blocks(),
@@ -1991,13 +1991,13 @@ void BlockVectorBase<VectorType>::sadd (const value_type x, const value_type a,
                                         const BlockVectorBase<VectorType>& y)
 {
 
-  Assert (deal_II_numbers::is_finite(x), 
+  Assert (numbers::is_finite(x), 
           ExcMessage("The given value is not finite but either infinite or Not A Number (NaN)"));
-  Assert (deal_II_numbers::is_finite(a), 
+  Assert (numbers::is_finite(a), 
           ExcMessage("The given value is not finite but either infinite or Not A Number (NaN)"));
-  Assert (deal_II_numbers::is_finite(b), 
+  Assert (numbers::is_finite(b), 
           ExcMessage("The given value is not finite but either infinite or Not A Number (NaN)"));
-  Assert (deal_II_numbers::is_finite(c), 
+  Assert (numbers::is_finite(c), 
           ExcMessage("The given value is not finite but either infinite or Not A Number (NaN)"));
 
   Assert (n_blocks() == v.n_blocks(),
@@ -2035,9 +2035,9 @@ void BlockVectorBase<VectorType>::equ (const value_type a,
                                        const BlockVectorBase<VectorType>& w)
 {
 
-  Assert (deal_II_numbers::is_finite(a), 
+  Assert (numbers::is_finite(a), 
           ExcMessage("The given value is not finite but either infinite or Not A Number (NaN)"));
-  Assert (deal_II_numbers::is_finite(b), 
+  Assert (numbers::is_finite(b), 
           ExcMessage("The given value is not finite but either infinite or Not A Number (NaN)"));
 
   Assert (n_blocks() == v.n_blocks(),
@@ -2058,7 +2058,7 @@ void BlockVectorBase<VectorType>::equ (const value_type    a,
                                        const BlockVector2 &v)
 {
 
-  Assert (deal_II_numbers::is_finite(a), 
+  Assert (numbers::is_finite(a), 
           ExcMessage("The given value is not finite but either infinite or Not A Number (NaN)"));
 
   Assert (n_blocks() == v.n_blocks(),
@@ -2075,7 +2075,7 @@ BlockVectorBase<VectorType>&
 BlockVectorBase<VectorType>::operator = (const value_type s)
 {
 
-  Assert (deal_II_numbers::is_finite(s), 
+  Assert (numbers::is_finite(s), 
           ExcMessage("The given value is not finite but either infinite or Not A Number (NaN)"));
 
   for (unsigned int i=0;i<n_blocks();++i)
@@ -2157,7 +2157,7 @@ BlockVectorBase<VectorType> &
 BlockVectorBase<VectorType>::operator *= (const value_type factor)
 {
 
-  Assert (deal_II_numbers::is_finite(factor), 
+  Assert (numbers::is_finite(factor), 
           ExcMessage("The given value is not finite but either infinite or Not A Number (NaN)"));
 
   for (unsigned int i=0;i<n_blocks();++i)
@@ -2174,7 +2174,7 @@ BlockVectorBase<VectorType> &
 BlockVectorBase<VectorType>::operator /= (const value_type factor)
 {
 
-  Assert (deal_II_numbers::is_finite(factor), 
+  Assert (numbers::is_finite(factor), 
           ExcMessage("The given value is not finite but either infinite or Not A Number (NaN)"));
   Assert (factor > 0., ExcZero() );
 
index 0848a37e6c332281d4873f578b71231cb268abfb..68af9cdd83a426438d74690af6c72ab8a2b81a3d 100644 (file)
@@ -1238,7 +1238,7 @@ inline
 number
 FullMatrix<number>::Accessor::value() const
 {
-  Assert (deal_II_numbers::is_finite( matrix->el(a_row, a_col) ), 
+  Assert (numbers::is_finite( matrix->el(a_row, a_col) ), 
           ExcMessage("The given value is not finite but either infinite or Not A Number (NaN)"));
   return matrix->el(a_row, a_col);
 }
index abaead2eca162d4d911a4175b1183c7877e6586e..40ecf0624a4e7f3f95c32fc3ffeea0a387b040ea 100644 (file)
@@ -127,7 +127,7 @@ FullMatrix<number> &
 FullMatrix<number>::operator *= (const double factor)
 {
 
-  Assert (deal_II_numbers::is_finite(factor), 
+  Assert (numbers::is_finite(factor), 
           ExcMessage("The given value is not finite but either infinite or Not A Number (NaN)"));
 
   number       *p = &this->el(0,0);
@@ -145,7 +145,7 @@ FullMatrix<number> &
 FullMatrix<number>::operator /= (const double factor)
 {
 
-  Assert (deal_II_numbers::is_finite(factor), 
+  Assert (numbers::is_finite(factor), 
           ExcMessage("The given value is not finite but either infinite or Not A Number (NaN)"));
 
   number       *p = &this->el(0,0);
@@ -153,7 +153,7 @@ FullMatrix<number>::operator /= (const double factor)
 
   const number factor_inv = 1./factor;
 
-  Assert (deal_II_numbers::is_finite(factor_inv), 
+  Assert (numbers::is_finite(factor_inv), 
           ExcMessage("The given value is not finite but either infinite or Not A Number (NaN)"));
  
   while (p != e)
index 9fa2e4bac0d99ba29222eadc1169fd60a3c302e2..7a86ad5f548a809e067ec4baa4a35ea73e2862db 100644 (file)
@@ -331,7 +331,7 @@ class MeanValueFilter : public Subscriptor
                                      * Constructor, optionally
                                      * selecting a component.
                                      */
-    MeanValueFilter(unsigned int component = deal_II_numbers::invalid_unsigned_int);
+    MeanValueFilter(unsigned int component = numbers::invalid_unsigned_int);
 
                                     /**
                                      * Subtract mean value from @p v.
index 5eecf2bdd418ffe290bd7452ab88a469b6f03c91..8ed570fc6c48f2ce31f8ad74771ffadd1279938e 100644 (file)
@@ -67,7 +67,7 @@ template <typename number>
 void
 MeanValueFilter::filter(BlockVector<number>& v) const
 {
-  Assert (component != deal_II_numbers::invalid_unsigned_int,
+  Assert (component != numbers::invalid_unsigned_int,
          ExcNotInitialized());
   
   for (unsigned int i=0;i<v.n_blocks();++i)
@@ -84,7 +84,7 @@ void
 MeanValueFilter::vmult(BlockVector<number>& dst,
                           const BlockVector<number>& src) const
 {
-  Assert (component != deal_II_numbers::invalid_unsigned_int,
+  Assert (component != numbers::invalid_unsigned_int,
          ExcNotInitialized());
   
   Assert (dst.n_blocks() == src.n_blocks(),
@@ -104,7 +104,7 @@ void
 MeanValueFilter::vmult_add(BlockVector<number>& dst,
                           const BlockVector<number>& src) const
 {
-  Assert (component != deal_II_numbers::invalid_unsigned_int,
+  Assert (component != numbers::invalid_unsigned_int,
          ExcNotInitialized());
   
   Assert (dst.n_blocks() == src.n_blocks(),
index 35d58d141ff0a60158655d3233f113ff9372cf65..da0a9c31475dd23d65a94c0441deb6425b72c43f 100644 (file)
@@ -1819,7 +1819,7 @@ void SparseMatrix<number>::set (const unsigned int i,
                                const number value)
 {
 
-  Assert (deal_II_numbers::is_finite(value), 
+  Assert (numbers::is_finite(value), 
           ExcMessage("The given value is not finite but either infinite or Not A Number (NaN)"));
 
   Assert (cols != 0, ExcNotInitialized());
@@ -1845,7 +1845,7 @@ void SparseMatrix<number>::add (const unsigned int i,
                                const number value)
 {
 
-  Assert (deal_II_numbers::is_finite(value), 
+  Assert (numbers::is_finite(value), 
           ExcMessage("The given value is not finite but either infinite or Not A Number (NaN)"));
 
   Assert (cols != 0, ExcNotInitialized());
index 5ca5b709947ddafe317f6666b39510b8b8359730..1eb56f75933fd37fee30e9af241b1a805ab40fe3 100644 (file)
@@ -130,7 +130,7 @@ class SparseMatrixEZ : public Subscriptor
                                         /**
                                          * Non-existent column number.
                                          */
-       static const unsigned int invalid = deal_II_numbers::invalid_unsigned_int;
+       static const unsigned int invalid = numbers::invalid_unsigned_int;
     };
 
                                     /**
@@ -1297,7 +1297,7 @@ void SparseMatrixEZ<number>::set (const unsigned int i,
                                  const number value)
 {
 
-  Assert (deal_II_numbers::is_finite(value), 
+  Assert (numbers::is_finite(value), 
           ExcMessage("The given value is not finite but either infinite or Not A Number (NaN)"));
 
   Assert (i<m(), ExcIndexRange(i,0,m()));
@@ -1325,7 +1325,7 @@ void SparseMatrixEZ<number>::add (const unsigned int i,
                                  const number value)
 {
 
-  Assert (deal_II_numbers::is_finite(value), 
+  Assert (numbers::is_finite(value), 
           ExcMessage("The given value is not finite but either infinite or Not A Number (NaN)"));
 
   Assert (i<m(), ExcIndexRange(i,0,m()));
index 363d7dac590de53fbe89cf6639fab0deffba8a47..1378a3a3d0c2a8ae2011aad3f55788554fa29f8c 100644 (file)
@@ -434,7 +434,7 @@ class SparsityPattern : public Subscriptor
                                      * but the actual value of the
                                      * variable may change over time.
                                      */
-    static const unsigned int invalid_entry = deal_II_numbers::invalid_unsigned_int;
+    static const unsigned int invalid_entry = numbers::invalid_unsigned_int;
     
                                     /**
                                      * Initialize the matrix empty,
index 628c0a32914da3bf59c3166df104e20a0906d011..fe2eeb0e574ff8d5f0448ad1ec453caf6a7ca1d8 100644 (file)
@@ -854,7 +854,7 @@ template <typename Number>
 inline
 Vector<Number> & Vector<Number>::operator = (const Number s)
 {
-  Assert (deal_II_numbers::is_finite(s), 
+  Assert (numbers::is_finite(s), 
           ExcMessage("The given value is not finite but either infinite or Not A Number (NaN)"));
   
   if (s != Number())
@@ -940,7 +940,7 @@ inline
 Vector<Number> & Vector<Number>::operator *= (const Number factor)
 {
 
-  Assert (deal_II_numbers::is_finite(factor), 
+  Assert (numbers::is_finite(factor), 
           ExcMessage("The given value is not finite but either infinite or Not A Number (NaN)"));
 
   scale (factor);
@@ -954,7 +954,7 @@ inline
 Vector<Number> &
 Vector<Number>::operator /= (const Number factor)
 {
-  Assert (deal_II_numbers::is_finite(factor), 
+  Assert (numbers::is_finite(factor), 
           ExcMessage("The given value is not finite but either infinite or Not A Number (NaN)"));
   Assert (factor > 0., ExcZero() );
 
@@ -969,7 +969,7 @@ inline
 void
 Vector<Number>::scale (const Number factor)
 {
-  Assert (deal_II_numbers::is_finite(factor), 
+  Assert (numbers::is_finite(factor), 
           ExcMessage("The given value is not finite but either infinite or Not A Number (NaN)"));
 
   Assert (vec_size!=0, ExcEmptyObject());
@@ -988,7 +988,7 @@ void
 Vector<Number>::add (const Number a,
                     const Vector<Number>& v)
 {
-  Assert (deal_II_numbers::is_finite(a), 
+  Assert (numbers::is_finite(a), 
           ExcMessage("The given value is not finite but either infinite or Not A Number (NaN)"));
 
   Assert (vec_size!=0, ExcEmptyObject());
@@ -1010,9 +1010,9 @@ Vector<Number>::sadd (const Number x,
                      const Number a,
                      const Vector<Number>& v)
 {
-  Assert (deal_II_numbers::is_finite(x), 
+  Assert (numbers::is_finite(x), 
           ExcMessage("The given value is not finite but either infinite or Not A Number (NaN)"));
-  Assert (deal_II_numbers::is_finite(a), 
+  Assert (numbers::is_finite(a), 
           ExcMessage("The given value is not finite but either infinite or Not A Number (NaN)"));
 
   Assert (vec_size!=0, ExcEmptyObject());
index a39e2209f13b4f1e24e4a626c5b11ac48fef11ea..70c396ede122d01078a42c1149b33f3fc18b8802 100644 (file)
@@ -46,7 +46,7 @@ namespace internal
     template <typename Number>
     inline Number sqr (const Number x)
     {
-      Assert (deal_II_numbers::is_finite(x), 
+      Assert (numbers::is_finite(x), 
              ExcMessage("The given value is not finite but either infinite or Not A Number (NaN)"));
       return x*x;
     }
@@ -443,9 +443,9 @@ template <typename Number>
 void Vector<Number>::add (const Number a, const Vector<Number>& v,
                          const Number b, const Vector<Number>& w)
 {
-  Assert (deal_II_numbers::is_finite(a), 
+  Assert (numbers::is_finite(a), 
           ExcMessage("The given value is not finite but either infinite or Not A Number (NaN)"));
-  Assert (deal_II_numbers::is_finite(b), 
+  Assert (numbers::is_finite(b), 
           ExcMessage("The given value is not finite but either infinite or Not A Number (NaN)"));
 
   Assert (vec_size!=0, ExcEmptyObject());
@@ -463,7 +463,7 @@ void Vector<Number>::add (const Number a, const Vector<Number>& v,
 template <typename Number>
 void Vector<Number>::sadd (const Number x, const Vector<Number>& v)
 {
-  Assert (deal_II_numbers::is_finite(x), 
+  Assert (numbers::is_finite(x), 
           ExcMessage("The given value is not finite but either infinite or Not A Number (NaN)"));
 
   Assert (vec_size!=0, ExcEmptyObject());
@@ -482,11 +482,11 @@ void Vector<Number>::sadd (const Number x, const Number a,
                           const Vector<Number>& v, const Number b,
                            const Vector<Number>& w)
 {
-  Assert (deal_II_numbers::is_finite(x), 
+  Assert (numbers::is_finite(x), 
           ExcMessage("The given value is not finite but either infinite or Not A Number (NaN)"));
-  Assert (deal_II_numbers::is_finite(a), 
+  Assert (numbers::is_finite(a), 
           ExcMessage("The given value is not finite but either infinite or Not A Number (NaN)"));
-  Assert (deal_II_numbers::is_finite(b), 
+  Assert (numbers::is_finite(b), 
           ExcMessage("The given value is not finite but either infinite or Not A Number (NaN)"));
 
   Assert (vec_size!=0, ExcEmptyObject());
@@ -507,13 +507,13 @@ void Vector<Number>::sadd (const Number x, const Number a,
                           const Vector<Number>& w, const Number c,
                            const Vector<Number>& y)
 {
-  Assert (deal_II_numbers::is_finite(x), 
+  Assert (numbers::is_finite(x), 
           ExcMessage("The given value is not finite but either infinite or Not A Number (NaN)"));
-  Assert (deal_II_numbers::is_finite(a), 
+  Assert (numbers::is_finite(a), 
           ExcMessage("The given value is not finite but either infinite or Not A Number (NaN)"));
-  Assert (deal_II_numbers::is_finite(b), 
+  Assert (numbers::is_finite(b), 
           ExcMessage("The given value is not finite but either infinite or Not A Number (NaN)"));
-  Assert (deal_II_numbers::is_finite(c), 
+  Assert (numbers::is_finite(c), 
           ExcMessage("The given value is not finite but either infinite or Not A Number (NaN)"));
 
   Assert (vec_size!=0, ExcEmptyObject());
@@ -551,7 +551,7 @@ template <typename Number>
 template <typename Number2>
 void Vector<Number>::equ (const Number a, const Vector<Number2>& u)
 {
-  Assert (deal_II_numbers::is_finite(a), 
+  Assert (numbers::is_finite(a), 
          ExcMessage("The given value is not finite but either infinite or Not A Number (NaN)"));
 
   Assert (vec_size!=0, ExcEmptyObject());
@@ -568,9 +568,9 @@ template <typename Number>
 void Vector<Number>::equ (const Number a, const Vector<Number>& u,
                          const Number b, const Vector<Number>& v)
 {
-  Assert (deal_II_numbers::is_finite(a), 
+  Assert (numbers::is_finite(a), 
           ExcMessage("The given value is not finite but either infinite or Not A Number (NaN)"));
-  Assert (deal_II_numbers::is_finite(b), 
+  Assert (numbers::is_finite(b), 
           ExcMessage("The given value is not finite but either infinite or Not A Number (NaN)"));
 
   Assert (vec_size!=0, ExcEmptyObject());
index a46961479ce704ad95a33006eb7197093e66d18c..18f74081288b60c2ac749eeeb00477b7529d232b 100644 (file)
@@ -138,7 +138,7 @@ namespace PETScWrappers
                    const PetscScalar value)
   {
 
-    Assert (deal_II_numbers::is_finite(value),
+    Assert (numbers::is_finite(value),
            ExcMessage("The given value is not finite but either infinite or Not A Number (NaN)"));
 
     if (last_action != LastAction::insert)
@@ -170,7 +170,7 @@ namespace PETScWrappers
                    const PetscScalar value)
   {
 
-    Assert (deal_II_numbers::is_finite(value), 
+    Assert (numbers::is_finite(value), 
            ExcMessage("The given value is not finite but either infinite or Not A Number (NaN)"));
     
     if (last_action != LastAction::add)
index 2878a49d27dcdf742998b8afab55053023e5db76..b8e9b4dd90ea8858dcc03f2e2d99a5291530df96 100644 (file)
@@ -123,7 +123,7 @@ namespace PETScWrappers
   VectorBase::operator = (const PetscScalar s)
   {
 
-    Assert (deal_II_numbers::is_finite(s), 
+    Assert (numbers::is_finite(s), 
            ExcMessage("The given value is not finite but either infinite or Not A Number (NaN)"));
 
                                      // flush previously cached elements. this
@@ -467,7 +467,7 @@ namespace PETScWrappers
   VectorBase::operator *= (const PetscScalar a)
   {
 
-    Assert (deal_II_numbers::is_finite(a), 
+    Assert (numbers::is_finite(a), 
            ExcMessage("The given value is not finite but either infinite or Not A Number (NaN)"));
 
 #if (PETSC_VERSION_MAJOR <= 2) && (PETSC_VERSION_MINOR < 3)
@@ -487,12 +487,12 @@ namespace PETScWrappers
   VectorBase::operator /= (const PetscScalar a)
   {
 
-    Assert (deal_II_numbers::is_finite(a), 
+    Assert (numbers::is_finite(a), 
            ExcMessage("The given value is not finite but either infinite or Not A Number (NaN)"));
 
     const PetscScalar factor = 1./a;
     
-    Assert (deal_II_numbers::is_finite(factor), 
+    Assert (numbers::is_finite(factor), 
            ExcMessage("The given value is not finite but either infinite or Not A Number (NaN)"));
 
 #if (PETSC_VERSION_MAJOR <= 2) && (PETSC_VERSION_MINOR < 3)
@@ -546,7 +546,7 @@ namespace PETScWrappers
   VectorBase::add (const PetscScalar s)
   {
 
-    Assert (deal_II_numbers::is_finite(s), 
+    Assert (numbers::is_finite(s), 
            ExcMessage("The given value is not finite but either infinite or Not A Number (NaN)"));
 
 #if (PETSC_VERSION_MAJOR <= 2) && (PETSC_VERSION_MINOR < 3)
@@ -573,7 +573,7 @@ namespace PETScWrappers
                    const VectorBase     &v)
   {
 
-    Assert (deal_II_numbers::is_finite(a), 
+    Assert (numbers::is_finite(a), 
            ExcMessage("The given value is not finite but either infinite or Not A Number (NaN)"));
 
 #if (PETSC_VERSION_MAJOR <= 2) && (PETSC_VERSION_MINOR < 3)
@@ -594,9 +594,9 @@ namespace PETScWrappers
                    const VectorBase &w)
   {
 
-    Assert (deal_II_numbers::is_finite(a), 
+    Assert (numbers::is_finite(a), 
            ExcMessage("The given value is not finite but either infinite or Not A Number (NaN)"));
-    Assert (deal_II_numbers::is_finite(b), 
+    Assert (numbers::is_finite(b), 
            ExcMessage("The given value is not finite but either infinite or Not A Number (NaN)"));
 
     const PetscScalar weights[2] = {a,b};
@@ -618,7 +618,7 @@ namespace PETScWrappers
                     const VectorBase &v)
   {
 
-    Assert (deal_II_numbers::is_finite(s), 
+    Assert (numbers::is_finite(s), 
            ExcMessage("The given value is not finite but either infinite or Not A Number (NaN)"));
 
 #if (PETSC_VERSION_MAJOR <= 2) && (PETSC_VERSION_MINOR < 3)
@@ -638,9 +638,9 @@ namespace PETScWrappers
                     const VectorBase     &v)
   {
 
-    Assert (deal_II_numbers::is_finite(s), 
+    Assert (numbers::is_finite(s), 
            ExcMessage("The given value is not finite but either infinite or Not A Number (NaN)"));
-    Assert (deal_II_numbers::is_finite(a), 
+    Assert (numbers::is_finite(a), 
            ExcMessage("The given value is not finite but either infinite or Not A Number (NaN)"));
 
                                      // there is nothing like a AXPAY
@@ -660,11 +660,11 @@ namespace PETScWrappers
                     const VectorBase     &w)
   {
  
-    Assert (deal_II_numbers::is_finite(s), 
+    Assert (numbers::is_finite(s), 
            ExcMessage("The given value is not finite but either infinite or Not A Number (NaN)"));
-    Assert (deal_II_numbers::is_finite(a), 
+    Assert (numbers::is_finite(a), 
            ExcMessage("The given value is not finite but either infinite or Not A Number (NaN)"));
-    Assert (deal_II_numbers::is_finite(b), 
+    Assert (numbers::is_finite(b), 
            ExcMessage("The given value is not finite but either infinite or Not A Number (NaN)"));
 
                                      // there is no operation like MAXPAY, so
@@ -695,13 +695,13 @@ namespace PETScWrappers
                     const VectorBase     &x)
   {
  
-    Assert (deal_II_numbers::is_finite(s), 
+    Assert (numbers::is_finite(s), 
            ExcMessage("The given value is not finite but either infinite or Not A Number (NaN)"));
-    Assert (deal_II_numbers::is_finite(a), 
+    Assert (numbers::is_finite(a), 
            ExcMessage("The given value is not finite but either infinite or Not A Number (NaN)"));
-    Assert (deal_II_numbers::is_finite(b), 
+    Assert (numbers::is_finite(b), 
            ExcMessage("The given value is not finite but either infinite or Not A Number (NaN)"));
-    Assert (deal_II_numbers::is_finite(c), 
+    Assert (numbers::is_finite(c), 
            ExcMessage("The given value is not finite but either infinite or Not A Number (NaN)"));
 
                                      // there is no operation like MAXPAY, so
@@ -737,7 +737,7 @@ namespace PETScWrappers
                    const VectorBase &v)
   {
 
-    Assert (deal_II_numbers::is_finite(a), 
+    Assert (numbers::is_finite(a), 
            ExcMessage("The given value is not finite but either infinite or Not A Number (NaN)"));
 
     Assert (size() == v.size(),
@@ -761,9 +761,9 @@ namespace PETScWrappers
                    const VectorBase &w)
   {
 
-    Assert (deal_II_numbers::is_finite(a), 
+    Assert (numbers::is_finite(a), 
            ExcMessage("The given value is not finite but either infinite or Not A Number (NaN)"));
-    Assert (deal_II_numbers::is_finite(b), 
+    Assert (numbers::is_finite(b), 
            ExcMessage("The given value is not finite but either infinite or Not A Number (NaN)"));
 
     Assert (size() == v.size(),
index c66e23b62e796b86e303cbe1d0ae34722674be80..8bd778907524b9e871d527ce3e9376dc1a3bf826 100644 (file)
@@ -74,7 +74,7 @@ check_function(const Functions::FlowFunction<dim>& f,
          ++vertex_number;
        }
   for (unsigned int i=0;i<GeometryInfo<dim>::faces_per_cell;++i)
-    patches[0].neighbors[i] = deal_II_numbers::invalid_unsigned_int;
+    patches[0].neighbors[i] = numbers::invalid_unsigned_int;
   patches[0].patch_index = 0;
   patches[0].n_subdivisions = sub;
   patches[0].points_are_available = false;
index 3edf9817300dd79c6b428ab63fd40261bfca28fe..8edb246f160089c49a45c54406edd0c973981a08 100644 (file)
@@ -11,7 +11,7 @@
 //
 //----------------------------  is_finite.cc  ---------------------------
 
-// check deal_II_numbers::is_finite
+// check numbers::is_finite
 
 #include "../tests.h"
 #include <base/logstream.h>
@@ -23,7 +23,7 @@
 template <typename T>
 void check ()
 {
-  using namespace deal_II_numbers;
+  using namespace numbers;
   
   deallog << std::numeric_limits<T>::quiet_NaN() << "   -->   ";
   deallog << is_finite(std::numeric_limits<T>::quiet_NaN()) << std::endl;
index f3d91cf0ef617af1652017d5b1fdea9f4e853a57..7fd7eb31bd562b2cbb5e6348923c12dcc0dd9729 100644 (file)
@@ -32,7 +32,7 @@
 #include <fstream>
 
 
-const double xy_angle = deal_II_numbers::PI/6;
+const double xy_angle = numbers::PI/6;
 
 template <int dim>
 Point<dim> rotate_to_y (const Point<dim> &p)
index aa3403d2860557512b05b8c01ffed452e80deb37..c8b33d3ea73fc762a7b11f7af56124d212d5cae2 100644 (file)
@@ -164,7 +164,7 @@ check ()
                                           v, this_error,
                                           std::vector<bool>(), 0,
                                           multithread_info.n_default_threads,
-                                          deal_II_numbers::invalid_unsigned_int,
+                                          numbers::invalid_unsigned_int,
                                           material);
       this_error *= scaling_factor;
 
index 3326f908bdd86a67e0e55780c6af21602fcbd818..bd6dc8510dc25ffaf1e577fdfbc82e1561848eb4 100644 (file)
@@ -41,8 +41,8 @@ void create_star_structured_cylinder (Triangulation<3> &coarse_grid,
   points[1] = Point<3>(1,0,0);
   for (unsigned int i=0; i<2*n_cells-1; ++i)
     {
-      points[2+i]=Point<3>(std::cos(deal_II_numbers::PI/n_cells*(i+1)),
-                          std::sin(deal_II_numbers::PI/n_cells*(i+1)),
+      points[2+i]=Point<3>(std::cos(numbers::PI/n_cells*(i+1)),
+                          std::sin(numbers::PI/n_cells*(i+1)),
                           0);
     }
   
index 399248f7c6d5cc8bb4506fd6b70ae5dd0c96f1c4..94be855210e5c218957afa2ec90e9b3fd24cfc82 100644 (file)
@@ -315,8 +315,8 @@ estimate_smoothness (Vector<float> &smoothness_indicators) const
                &&
                (i*i + j*j < N*N))
              {
-               k_vectors.push_back (Point<dim>(deal_II_numbers::PI * i,
-                                               deal_II_numbers::PI * j));
+               k_vectors.push_back (Point<dim>(numbers::PI * i,
+                                               numbers::PI * j));
                k_vectors_magnitude.push_back (i*i+j*j);
              }
        
@@ -332,9 +332,9 @@ estimate_smoothness (Vector<float> &smoothness_indicators) const
                  &&
                  (i*i + j*j + k*k < N*N))
                {
-                 k_vectors.push_back (Point<dim>(deal_II_numbers::PI * i,
-                                                 deal_II_numbers::PI * j,
-                                                 deal_II_numbers::PI * k));
+                 k_vectors.push_back (Point<dim>(numbers::PI * i,
+                                                 numbers::PI * j,
+                                                 numbers::PI * k));
                  k_vectors_magnitude.push_back (i*i+j*j+k*k);
              }
        
@@ -380,7 +380,7 @@ estimate_smoothness (Vector<float> &smoothness_indicators) const
                       quadrature.weight(q);
              }
            fourier_transform_matrices[fe](k,i)
-             = sum / std::pow(2*deal_II_numbers::PI, 1.*dim/2);
+             = sum / std::pow(2*numbers::PI, 1.*dim/2);
          }
     }
 
@@ -654,46 +654,46 @@ void LaplaceProblem<3>::create_coarse_grid ()
     {
                                           // points on the lower surface
          Point<dim>(0,  0, -4),
-         Point<dim>(std::cos(0*deal_II_numbers::PI/6),
-                    std::sin(0*deal_II_numbers::PI/6),
+         Point<dim>(std::cos(0*numbers::PI/6),
+                    std::sin(0*numbers::PI/6),
                     -4),
-         Point<dim>(std::cos(2*deal_II_numbers::PI/6),
-                    std::sin(2*deal_II_numbers::PI/6),
+         Point<dim>(std::cos(2*numbers::PI/6),
+                    std::sin(2*numbers::PI/6),
                     -4),
-         Point<dim>(std::cos(4*deal_II_numbers::PI/6),
-                    std::sin(4*deal_II_numbers::PI/6),
+         Point<dim>(std::cos(4*numbers::PI/6),
+                    std::sin(4*numbers::PI/6),
                     -4),
-         Point<dim>(std::cos(6*deal_II_numbers::PI/6),
-                    std::sin(6*deal_II_numbers::PI/6),
+         Point<dim>(std::cos(6*numbers::PI/6),
+                    std::sin(6*numbers::PI/6),
                     -4),
-         Point<dim>(std::cos(8*deal_II_numbers::PI/6),
-                    std::sin(8*deal_II_numbers::PI/6),
+         Point<dim>(std::cos(8*numbers::PI/6),
+                    std::sin(8*numbers::PI/6),
                     -4),
-         Point<dim>(std::cos(10*deal_II_numbers::PI/6),
-                    std::sin(10*deal_II_numbers::PI/6),
+         Point<dim>(std::cos(10*numbers::PI/6),
+                    std::sin(10*numbers::PI/6),
                     -4),
 
                                           // same points on the top
                                           // of the stem, with
                                           // indentation in the middle
          Point<dim>(0,  0, 4-std::sqrt(2.)/2),
-         Point<dim>(std::cos(0*deal_II_numbers::PI/6),
-                    std::sin(0*deal_II_numbers::PI/6),
+         Point<dim>(std::cos(0*numbers::PI/6),
+                    std::sin(0*numbers::PI/6),
                     4),
-         Point<dim>(std::cos(2*deal_II_numbers::PI/6),
-                    std::sin(2*deal_II_numbers::PI/6),
+         Point<dim>(std::cos(2*numbers::PI/6),
+                    std::sin(2*numbers::PI/6),
                     4),
-         Point<dim>(std::cos(4*deal_II_numbers::PI/6),
-                    std::sin(4*deal_II_numbers::PI/6),
+         Point<dim>(std::cos(4*numbers::PI/6),
+                    std::sin(4*numbers::PI/6),
                     4),
-         Point<dim>(std::cos(6*deal_II_numbers::PI/6),
-                    std::sin(6*deal_II_numbers::PI/6),
+         Point<dim>(std::cos(6*numbers::PI/6),
+                    std::sin(6*numbers::PI/6),
                     4),
-         Point<dim>(std::cos(8*deal_II_numbers::PI/6),
-                    std::sin(8*deal_II_numbers::PI/6),
+         Point<dim>(std::cos(8*numbers::PI/6),
+                    std::sin(8*numbers::PI/6),
                     4),
-         Point<dim>(std::cos(10*deal_II_numbers::PI/6),
-                    std::sin(10*deal_II_numbers::PI/6),
+         Point<dim>(std::cos(10*numbers::PI/6),
+                    std::sin(10*numbers::PI/6),
                     4),
 
                                           // point at top of chevron
@@ -702,67 +702,67 @@ void LaplaceProblem<3>::create_coarse_grid ()
                                           // points at the top of the
                                           // first extension
                                           // points 15-18
-         Point<dim>(0,  0, 7) + Point<dim> (std::cos(2*deal_II_numbers::PI/6),
-                                            std::sin(2*deal_II_numbers::PI/6),
+         Point<dim>(0,  0, 7) + Point<dim> (std::cos(2*numbers::PI/6),
+                                            std::sin(2*numbers::PI/6),
                                             0) * 4,
-         Point<dim>(std::cos(0*deal_II_numbers::PI/6),
-                    std::sin(0*deal_II_numbers::PI/6),
-                    7) + Point<dim> (std::cos(2*deal_II_numbers::PI/6),
-                                     std::sin(2*deal_II_numbers::PI/6),
+         Point<dim>(std::cos(0*numbers::PI/6),
+                    std::sin(0*numbers::PI/6),
+                    7) + Point<dim> (std::cos(2*numbers::PI/6),
+                                     std::sin(2*numbers::PI/6),
                                      0) * 4,
-         Point<dim>(std::cos(2*deal_II_numbers::PI/6),
-                    std::sin(2*deal_II_numbers::PI/6),
-                    7) + Point<dim> (std::cos(2*deal_II_numbers::PI/6),
-                                     std::sin(2*deal_II_numbers::PI/6),
+         Point<dim>(std::cos(2*numbers::PI/6),
+                    std::sin(2*numbers::PI/6),
+                    7) + Point<dim> (std::cos(2*numbers::PI/6),
+                                     std::sin(2*numbers::PI/6),
                                      0) * 4,
-         Point<dim>(std::cos(4*deal_II_numbers::PI/6),
-                    std::sin(4*deal_II_numbers::PI/6),
-                    7) + Point<dim> (std::cos(2*deal_II_numbers::PI/6),
-                                     std::sin(2*deal_II_numbers::PI/6),
+         Point<dim>(std::cos(4*numbers::PI/6),
+                    std::sin(4*numbers::PI/6),
+                    7) + Point<dim> (std::cos(2*numbers::PI/6),
+                                     std::sin(2*numbers::PI/6),
                                      0) * 4,
 
                                           // points at the top of the
                                           // second extension
                                           // points 19-22
-         Point<dim>(0,  0, 7) + Point<dim> (std::cos(6*deal_II_numbers::PI/6),
-                                            std::sin(6*deal_II_numbers::PI/6),
+         Point<dim>(0,  0, 7) + Point<dim> (std::cos(6*numbers::PI/6),
+                                            std::sin(6*numbers::PI/6),
                                             0) * 4,
-         Point<dim>(std::cos(4*deal_II_numbers::PI/6),
-                    std::sin(4*deal_II_numbers::PI/6),
-                    7) + Point<dim> (std::cos(6*deal_II_numbers::PI/6),
-                                     std::sin(6*deal_II_numbers::PI/6),
+         Point<dim>(std::cos(4*numbers::PI/6),
+                    std::sin(4*numbers::PI/6),
+                    7) + Point<dim> (std::cos(6*numbers::PI/6),
+                                     std::sin(6*numbers::PI/6),
                                      0) * 4,
-         Point<dim>(std::cos(6*deal_II_numbers::PI/6),
-                    std::sin(6*deal_II_numbers::PI/6),
-                    7) + Point<dim> (std::cos(6*deal_II_numbers::PI/6),
-                                     std::sin(6*deal_II_numbers::PI/6),
+         Point<dim>(std::cos(6*numbers::PI/6),
+                    std::sin(6*numbers::PI/6),
+                    7) + Point<dim> (std::cos(6*numbers::PI/6),
+                                     std::sin(6*numbers::PI/6),
                                      0) * 4,
-         Point<dim>(std::cos(8*deal_II_numbers::PI/6),
-                    std::sin(8*deal_II_numbers::PI/6),
-                    7) + Point<dim> (std::cos(6*deal_II_numbers::PI/6),
-                                     std::sin(6*deal_II_numbers::PI/6),
+         Point<dim>(std::cos(8*numbers::PI/6),
+                    std::sin(8*numbers::PI/6),
+                    7) + Point<dim> (std::cos(6*numbers::PI/6),
+                                     std::sin(6*numbers::PI/6),
                                      0) * 4,
 
                                           // points at the top of the
                                           // third extension
                                           // points 23-26
-         Point<dim>(0,  0, 7) + Point<dim> (std::cos(10*deal_II_numbers::PI/6),
-                                            std::sin(10*deal_II_numbers::PI/6),
+         Point<dim>(0,  0, 7) + Point<dim> (std::cos(10*numbers::PI/6),
+                                            std::sin(10*numbers::PI/6),
                                             0) * 4,
-         Point<dim>(std::cos(8*deal_II_numbers::PI/6),
-                    std::sin(8*deal_II_numbers::PI/6),
-                    7) + Point<dim> (std::cos(10*deal_II_numbers::PI/6),
-                                     std::sin(10*deal_II_numbers::PI/6),
+         Point<dim>(std::cos(8*numbers::PI/6),
+                    std::sin(8*numbers::PI/6),
+                    7) + Point<dim> (std::cos(10*numbers::PI/6),
+                                     std::sin(10*numbers::PI/6),
                                      0) * 4,
-         Point<dim>(std::cos(10*deal_II_numbers::PI/6),
-                    std::sin(10*deal_II_numbers::PI/6),
-                    7) + Point<dim> (std::cos(10*deal_II_numbers::PI/6),
-                                     std::sin(10*deal_II_numbers::PI/6),
+         Point<dim>(std::cos(10*numbers::PI/6),
+                    std::sin(10*numbers::PI/6),
+                    7) + Point<dim> (std::cos(10*numbers::PI/6),
+                                     std::sin(10*numbers::PI/6),
                                      0) * 4,
-         Point<dim>(std::cos(0*deal_II_numbers::PI/6),
-                    std::sin(0*deal_II_numbers::PI/6),
-                    7) + Point<dim> (std::cos(10*deal_II_numbers::PI/6),
-                                     std::sin(10*deal_II_numbers::PI/6),
+         Point<dim>(std::cos(0*numbers::PI/6),
+                    std::sin(0*numbers::PI/6),
+                    7) + Point<dim> (std::cos(10*numbers::PI/6),
+                                     std::sin(10*numbers::PI/6),
                                      0) * 4,
          
     };
index 293e7a147d876def60fd3165e36e786ef284f14c..eadc242b4cdfba7165bd7890b2bc9e48412f87e7 100644 (file)
@@ -315,8 +315,8 @@ estimate_smoothness (Vector<float> &smoothness_indicators) const
                &&
                (i*i + j*j < N*N))
              {
-               k_vectors.push_back (Point<dim>(deal_II_numbers::PI * i,
-                                               deal_II_numbers::PI * j));
+               k_vectors.push_back (Point<dim>(numbers::PI * i,
+                                               numbers::PI * j));
                k_vectors_magnitude.push_back (i*i+j*j);
              }
        
@@ -332,9 +332,9 @@ estimate_smoothness (Vector<float> &smoothness_indicators) const
                  &&
                  (i*i + j*j + k*k < N*N))
                {
-                 k_vectors.push_back (Point<dim>(deal_II_numbers::PI * i,
-                                                 deal_II_numbers::PI * j,
-                                                 deal_II_numbers::PI * k));
+                 k_vectors.push_back (Point<dim>(numbers::PI * i,
+                                                 numbers::PI * j,
+                                                 numbers::PI * k));
                  k_vectors_magnitude.push_back (i*i+j*j+k*k);
              }
        
@@ -380,7 +380,7 @@ estimate_smoothness (Vector<float> &smoothness_indicators) const
                       quadrature.weight(q);
              }
            fourier_transform_matrices[fe](k,i)
-             = sum / std::pow(2*deal_II_numbers::PI, 1.*dim/2);
+             = sum / std::pow(2*numbers::PI, 1.*dim/2);
          }
     }
 
index ca5871890b7f178379ddfaedd5ae196a17091023..df0c6212e0efec3a8404d45b74bcfdfce1b18d44 100644 (file)
@@ -317,8 +317,8 @@ estimate_smoothness (Vector<float> &smoothness_indicators) const
                &&
                (i*i + j*j < N*N))
              {
-               k_vectors.push_back (Point<dim>(deal_II_numbers::PI * i,
-                                               deal_II_numbers::PI * j));
+               k_vectors.push_back (Point<dim>(numbers::PI * i,
+                                               numbers::PI * j));
                k_vectors_magnitude.push_back (i*i+j*j);
              }
        
@@ -334,9 +334,9 @@ estimate_smoothness (Vector<float> &smoothness_indicators) const
                  &&
                  (i*i + j*j + k*k < N*N))
                {
-                 k_vectors.push_back (Point<dim>(deal_II_numbers::PI * i,
-                                                 deal_II_numbers::PI * j,
-                                                 deal_II_numbers::PI * k));
+                 k_vectors.push_back (Point<dim>(numbers::PI * i,
+                                                 numbers::PI * j,
+                                                 numbers::PI * k));
                  k_vectors_magnitude.push_back (i*i+j*j+k*k);
              }
        
@@ -382,7 +382,7 @@ estimate_smoothness (Vector<float> &smoothness_indicators) const
                       quadrature.weight(q);
              }
            fourier_transform_matrices[fe](k,i)
-             = sum / std::pow(2*deal_II_numbers::PI, 1.*dim/2);
+             = sum / std::pow(2*numbers::PI, 1.*dim/2);
          }
     }
 
index 7dc7d3666a530b009d113ce219af889731b665da..ae96488105a0aa7672f817e18367848fd402d015 100644 (file)
@@ -320,8 +320,8 @@ estimate_smoothness (Vector<float> &smoothness_indicators) const
                &&
                (i*i + j*j < N*N))
              {
-               k_vectors.push_back (Point<dim>(deal_II_numbers::PI * i,
-                                               deal_II_numbers::PI * j));
+               k_vectors.push_back (Point<dim>(numbers::PI * i,
+                                               numbers::PI * j));
                k_vectors_magnitude.push_back (i*i+j*j);
              }
        
@@ -337,9 +337,9 @@ estimate_smoothness (Vector<float> &smoothness_indicators) const
                  &&
                  (i*i + j*j + k*k < N*N))
                {
-                 k_vectors.push_back (Point<dim>(deal_II_numbers::PI * i,
-                                                 deal_II_numbers::PI * j,
-                                                 deal_II_numbers::PI * k));
+                 k_vectors.push_back (Point<dim>(numbers::PI * i,
+                                                 numbers::PI * j,
+                                                 numbers::PI * k));
                  k_vectors_magnitude.push_back (i*i+j*j+k*k);
              }
        
@@ -385,7 +385,7 @@ estimate_smoothness (Vector<float> &smoothness_indicators) const
                       quadrature.weight(q);
              }
            fourier_transform_matrices[fe](k,i)
-             = sum / std::pow(2*deal_II_numbers::PI, 1.*dim/2);
+             = sum / std::pow(2*numbers::PI, 1.*dim/2);
          }
     }
 
index 96aac4a717c0637aef5f0888ae122736c8c4d17a..7a98acf41899778846463a97be55341bec4dc21a 100644 (file)
@@ -323,8 +323,8 @@ estimate_smoothness (Vector<float> &smoothness_indicators) const
                &&
                (i*i + j*j < N*N))
              {
-               k_vectors.push_back (Point<dim>(deal_II_numbers::PI * i,
-                                               deal_II_numbers::PI * j));
+               k_vectors.push_back (Point<dim>(numbers::PI * i,
+                                               numbers::PI * j));
                k_vectors_magnitude.push_back (i*i+j*j);
              }
        
@@ -340,9 +340,9 @@ estimate_smoothness (Vector<float> &smoothness_indicators) const
                  &&
                  (i*i + j*j + k*k < N*N))
                {
-                 k_vectors.push_back (Point<dim>(deal_II_numbers::PI * i,
-                                                 deal_II_numbers::PI * j,
-                                                 deal_II_numbers::PI * k));
+                 k_vectors.push_back (Point<dim>(numbers::PI * i,
+                                                 numbers::PI * j,
+                                                 numbers::PI * k));
                  k_vectors_magnitude.push_back (i*i+j*j+k*k);
              }
        
@@ -388,7 +388,7 @@ estimate_smoothness (Vector<float> &smoothness_indicators) const
                       quadrature.weight(q);
              }
            fourier_transform_matrices[fe](k,i)
-             = sum / std::pow(2*deal_II_numbers::PI, 1.*dim/2);
+             = sum / std::pow(2*numbers::PI, 1.*dim/2);
          }
     }
 
index a1217cae111945a9a5dbd76b6a29422e8a1da44e..1e73e6b0c84b4a01646a89d748e8076c0647f8d5 100644 (file)
@@ -49,8 +49,8 @@ int main()
                                    * Satz 4.1.1)
                                    */
   const double h = 1./size;
-  const double s = std::sin(deal_II_numbers::PI*h/2.);
-  const double c = std::cos(deal_II_numbers::PI*h/2.);
+  const double s = std::sin(numbers::PI*h/2.);
+  const double c = std::cos(numbers::PI*h/2.);
   const double lambda_max = 8.*c*c;
   const double lambda_min = 8.*s*s;
   

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.