From: Wolfgang Bangerth Date: Sat, 3 Nov 2007 03:08:43 +0000 (+0000) Subject: Rename namespace dealii::deal_II_numbers into namespace dealii::numbers. X-Git-Tag: v8.0.0~9665 X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=44f44b9c6220812261992768e0e407c334a427c0;p=dealii.git Rename namespace dealii::deal_II_numbers into namespace dealii::numbers. git-svn-id: https://svn.dealii.org/trunk@15432 0785d39b-7218-0410-832d-ea1e28bc413d --- diff --git a/deal.II/base/include/base/data_out_base.h b/deal.II/base/include/base/data_out_base.h index 42b847f453..3337780ce5 100644 --- a/deal.II/base/include/base/data_out_base.h +++ b/deal.II/base/include/base/data_out_base.h @@ -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 * @{ */ diff --git a/deal.II/base/include/base/function_lib.h b/deal.II/base/include/base/function_lib.h index 135a0f58f4..61a404d47a 100644 --- a/deal.II/base/include/base/function_lib.h +++ b/deal.II/base/include/base/function_lib.h @@ -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 diff --git a/deal.II/base/include/base/function_parser.h b/deal.II/base/include/base/function_parser.h index 10eb0158be..4afcf944e3 100644 --- a/deal.II/base/include/base/function_parser.h +++ b/deal.II/base/include/base/function_parser.h @@ -54,7 +54,7 @@ template class Vector; * @verbatim // Define some constants that will be used by the function parser std::map 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"; diff --git a/deal.II/base/include/base/numbers.h b/deal.II/base/include/base/numbers.h index 94af74c1e6..2268f147bd 100644 --- a/deal.II/base/include/base/numbers.h +++ b/deal.II/base/include/base/numbers.h @@ -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 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 diff --git a/deal.II/base/include/base/table_indices.h b/deal.II/base/include/base/table_indices.h index 08ea523d21..4670bdd6bc 100644 --- a/deal.II/base/include/base/table_indices.h +++ b/deal.II/base/include/base/table_indices.h @@ -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); }; diff --git a/deal.II/base/include/base/utilities.h b/deal.II/base/include/base/utilities.h index af5ac3472a..08472cb133 100644 --- a/deal.II/base/include/base/utilities.h +++ b/deal.II/base/include/base/utilities.h @@ -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 get_integer_at_position (const std::string &name, diff --git a/deal.II/base/source/config.cc b/deal.II/base/source/config.cc index 46092dc9e1..4153b2a9eb 100644 --- a/deal.II/base/source/config.cc +++ b/deal.II/base/source/config.cc @@ -19,7 +19,7 @@ DEAL_II_NAMESPACE_OPEN -namespace deal_II_numbers +namespace numbers { bool is_finite (const double x) { diff --git a/deal.II/base/source/data_out_base.cc b/deal.II/base/source/data_out_base.cc index f141e53e44..8799676162 100644 --- a/deal.II/base/source/data_out_base.cc +++ b/deal.II/base/source/data_out_base.cc @@ -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& 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& 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 > &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 > &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) { diff --git a/deal.II/base/source/flow_function.cc b/deal.II/base/source/flow_function.cc index 74412a12b0..629e98f90d 100644 --- a/deal.II/base/source/flow_function.cc +++ b/deal.II/base/source/flow_function.cc @@ -294,8 +294,8 @@ namespace Functions for (unsigned int k=0;k& 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& 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& 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& p = points[k]; diff --git a/deal.II/base/source/function_lib_cutoff.cc b/deal.II/base/source/function_lib_cutoff.cc index 06fa53fd18..480a282a13 100644 --- a/deal.II/base/source/function_lib_cutoff.cc +++ b/deal.II/base/source/function_lib_cutoff.cc @@ -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::no_component) diff --git a/deal.II/base/source/geometry_info.cc b/deal.II/base/source/geometry_info.cc index af85a5ee8d..0e006ca5c4 100644 --- a/deal.II/base/source/geometry_info.cc +++ b/deal.II/base/source/geometry_info.cc @@ -29,7 +29,7 @@ template const unsigned int GeometryInfo::quads_per_cell; template const unsigned int GeometryInfo::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 diff --git a/deal.II/base/source/parameter_handler.cc b/deal.II/base/source/parameter_handler.cc index 2b8ded2088..a31ee4f02b 100644 --- a/deal.II/base/source/parameter_handler.cc +++ b/deal.II/base/source/parameter_handler.cc @@ -269,7 +269,7 @@ namespace Patterns #ifdef HAVE_STD_NUMERIC_LIMITS std::numeric_limits::max(); #else - deal_II_numbers::invalid_unsigned_int; + numbers::invalid_unsigned_int; #endif diff --git a/deal.II/base/source/parsed_function.cc b/deal.II/base/source/parsed_function.cc index 3ff828199c..7619ae79d8 100644 --- a/deal.II/base/source/parsed_function.cc +++ b/deal.II/base/source/parsed_function.cc @@ -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) diff --git a/deal.II/base/source/quadrature.cc b/deal.II/base/source/quadrature.cc index 0978b12a1d..af50860b19 100644 --- a/deal.II/base/source/quadrature.cc +++ b/deal.II/base/source/quadrature.cc @@ -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 QProjector::DataSetDescriptor:: DataSetDescriptor () : - dataset_offset (deal_II_numbers::invalid_unsigned_int) + dataset_offset (numbers::invalid_unsigned_int) {} diff --git a/deal.II/base/source/quadrature_lib.cc b/deal.II/base/source/quadrature_lib.cc index 7e91805cea..e2406c5a37 100644 --- a/deal.II/base/source/quadrature_lib.cc +++ b/deal.II/base/source/quadrature_lib.cc @@ -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; diff --git a/deal.II/base/source/utilities.cc b/deal.II/base/source/utilities.cc index 57fbc12847..be1ae32579 100644 --- a/deal.II/base/source/utilities.cc +++ b/deal.II/base/source/utilities.cc @@ -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); } diff --git a/deal.II/deal.II/include/dofs/dof_accessor.templates.h b/deal.II/deal.II/include/dofs/dof_accessor.templates.h index 393ba04d52..b78b44a424 100644 --- a/deal.II/deal.II/include/dofs/dof_accessor.templates.h +++ b/deal.II/deal.II/include/dofs/dof_accessor.templates.h @@ -34,8 +34,8 @@ template DoFAccessor::DoFAccessor () : DoFObjectAccessor_Inheritance::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()); diff --git a/deal.II/deal.II/include/dofs/dof_constraints.templates.h b/deal.II/deal.II/include/dofs/dof_constraints.templates.h index 6a88ad2b79..c264bbc178 100644 --- a/deal.II/deal.II/include/dofs/dof_constraints.templates.h +++ b/deal.II/deal.II/include/dofs/dof_constraints.templates.h @@ -175,7 +175,7 @@ ConstraintMatrix::condense (SparseMatrix &uncondensed) const // which line in the constraint matrix // handles this index std::vector distribute (sparsity.n_rows(), - deal_II_numbers::invalid_unsigned_int); + numbers::invalid_unsigned_int); for (unsigned int c=0; c &uncondensed) const const unsigned int n_rows = sparsity.n_rows(); for (unsigned int row=0; row::iterator @@ -200,7 +200,7 @@ ConstraintMatrix::condense (SparseMatrix &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 &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 &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 distribute (sparsity.n_rows(), - deal_II_numbers::invalid_unsigned_int); + numbers::invalid_unsigned_int); for (unsigned int c=0; c &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 &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 &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 diff --git a/deal.II/deal.II/include/dofs/dof_handler.h b/deal.II/deal.II/include/dofs/dof_handler.h index 6cf0ba08e9..1f9ec0668f 100644 --- a/deal.II/deal.II/include/dofs/dof_handler.h +++ b/deal.II/deal.II/include/dofs/dof_handler.h @@ -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 diff --git a/deal.II/deal.II/include/fe/fe.h b/deal.II/deal.II/include/fe/fe.h index 195fc95c63..4c8006bdf3 100644 --- a/deal.II/deal.II/include/fe/fe.h +++ b/deal.II/deal.II/include/fe/fe.h @@ -2610,8 +2610,8 @@ FiniteElement::block_to_base_index (const unsigned int index) const if (first_block_of_base_table[i] <= index) return std::pair(static_cast (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); } diff --git a/deal.II/deal.II/include/fe/fe_base.h b/deal.II/deal.II/include/fe/fe_base.h index 6c64200820..bec4e3cc44 100644 --- a/deal.II/deal.II/include/fe/fe_base.h +++ b/deal.II/deal.II/include/fe/fe_base.h @@ -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::n_dofs_per_object () const default: Assert (false, ExcInternalError()); } - return deal_II_numbers::invalid_unsigned_int; + return numbers::invalid_unsigned_int; } diff --git a/deal.II/deal.II/include/fe/fe_system.h b/deal.II/deal.II/include/fe/fe_system.h index bd42e9fb33..a8abf92fd7 100644 --- a/deal.II/deal.II/include/fe/fe_system.h +++ b/deal.II/deal.II/include/fe/fe_system.h @@ -689,7 +689,7 @@ class FESystem : public FiniteElement * 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 diff --git a/deal.II/deal.II/include/fe/mapping_cartesian.h b/deal.II/deal.II/include/fe/mapping_cartesian.h index bdc3ff0a54..5a4282c1b4 100644 --- a/deal.II/deal.II/include/fe/mapping_cartesian.h +++ b/deal.II/deal.II/include/fe/mapping_cartesian.h @@ -218,7 +218,7 @@ class MappingCartesian : public Mapping * 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; }; /*@}*/ diff --git a/deal.II/deal.II/include/grid/grid_reordering_internal.h b/deal.II/deal.II/include/grid/grid_reordering_internal.h index 54f40cad68..8e9d4cac44 100644 --- a/deal.II/deal.II/include/grid/grid_reordering_internal.h +++ b/deal.II/deal.II/include/grid/grid_reordering_internal.h @@ -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 diff --git a/deal.II/deal.II/include/grid/tria_accessor.templates.h b/deal.II/deal.II/include/grid/tria_accessor.templates.h index 4a7183ff58..f7a251b7bd 100644 --- a/deal.II/deal.II/include/grid/tria_accessor.templates.h +++ b/deal.II/deal.II/include/grid/tria_accessor.templates.h @@ -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; } diff --git a/deal.II/deal.II/include/hp/dof_handler.h b/deal.II/deal.II/include/hp/dof_handler.h index 82014169e4..b2a495dae5 100644 --- a/deal.II/deal.II/include/hp/dof_handler.h +++ b/deal.II/deal.II/include/hp/dof_handler.h @@ -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) diff --git a/deal.II/deal.II/include/hp/dof_objects.h b/deal.II/deal.II/include/hp/dof_objects.h index 745fafd82b..a393750e2a 100644 --- a/deal.II/deal.II/include/hp/dof_objects.h +++ b/deal.II/deal.II/include/hp/dof_objects.h @@ -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 diff --git a/deal.II/deal.II/include/hp/fe_values.h b/deal.II/deal.II/include/hp/fe_values.h index 11298a1414..ba36a94d52 100644 --- a/deal.II/deal.II/include/hp/fe_values.h +++ b/deal.II/deal.II/include/hp/fe_values.h @@ -390,9 +390,9 @@ namespace hp */ void reinit (const typename hp::DoFHandler::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::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::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::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::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::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::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::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::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::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::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::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); }; } diff --git a/deal.II/deal.II/include/multigrid/mg_transfer_component.h b/deal.II/deal.II/include/multigrid/mg_transfer_component.h index a4b66e5e6a..23ac1643a3 100644 --- a/deal.II/deal.II/include/multigrid/mg_transfer_component.h +++ b/deal.II/deal.II/include/multigrid/mg_transfer_component.h @@ -249,7 +249,7 @@ class MGTransferSelect : public MGTransferBase >, * 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 &dst, @@ -395,7 +395,7 @@ MGTransferSelect::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; } diff --git a/deal.II/deal.II/include/numerics/error_estimator.h b/deal.II/deal.II/include/numerics/error_estimator.h index 0c450fd7ef..f2f342ff57 100644 --- a/deal.II/deal.II/include/numerics/error_estimator.h +++ b/deal.II/deal.II/include/numerics/error_estimator.h @@ -274,7 +274,7 @@ class KellyErrorEstimator * indicates whether we shall compute * indicators for all cells (in case its * value is the default, - * deal_II_numbers::invalid_unsigned_int), + * numbers::invalid_unsigned_int), * 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 &component_mask = std::vector(), const Function *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 &component_mask = std::vector(), const Function *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 &component_mask = std::vector(), const Function *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 &component_mask = std::vector(), const Function *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 &component_mask = std::vector(), const Function *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 &component_mask = std::vector(), const Function *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 &component_mask = std::vector(), const Function *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 &component_mask = std::vector(), const Function *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 &component_mask = std::vector(), 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 &component_mask = std::vector(), 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 &component_mask = std::vector(), 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 &component_mask = std::vector(), 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 &component_mask = std::vector(), 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 &component_mask = std::vector(), 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 &component_mask = std::vector(), 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 &component_mask = std::vector(), 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 diff --git a/deal.II/deal.II/include/numerics/vectors.templates.h b/deal.II/deal.II/include/numerics/vectors.templates.h index 5ac81c1030..c5aade3845 100644 --- a/deal.II/deal.II/include/numerics/vectors.templates.h +++ b/deal.II/deal.II/include/numerics/vectors.templates.h @@ -1514,7 +1514,7 @@ interpolate_boundary_values (const Mapping &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; } } diff --git a/deal.II/deal.II/source/dofs/dof_constraints.cc b/deal.II/deal.II/source/dofs/dof_constraints.cc index f89b02c54b..7f0bbaca52 100644 --- a/deal.II/deal.II/source/dofs/dof_constraints.cc +++ b/deal.II/deal.II/source/dofs/dof_constraints.cc @@ -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 distribute(sparsity.n_rows(), - deal_II_numbers::invalid_unsigned_int); + numbers::invalid_unsigned_int); for (unsigned int c=0; ccolumn(); - 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 distribute(sparsity.n_rows(), - deal_II_numbers::invalid_unsigned_int); + numbers::invalid_unsigned_int); for (unsigned int c=0; c distribute(sparsity.n_rows(), - deal_II_numbers::invalid_unsigned_int); + numbers::invalid_unsigned_int); for (unsigned int c=0; c distribute (sparsity.n_rows(), - deal_II_numbers::invalid_unsigned_int); + numbers::invalid_unsigned_int); for (unsigned int c=0; ccolumn()); - 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 distribute (sparsity.n_rows(), - deal_II_numbers::invalid_unsigned_int); + numbers::invalid_unsigned_int); for (unsigned int c=0; c(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 distribute (sparsity.n_rows(), - deal_II_numbers::invalid_unsigned_int); + numbers::invalid_unsigned_int); for (unsigned int c=0; c(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. diff --git a/deal.II/deal.II/source/dofs/dof_renumbering.cc b/deal.II/deal.II/source/dofs/dof_renumbering.cc index 886d0cbb4e..f7b73d35f2 100644 --- a/deal.II/deal.II/source/dofs/dof_renumbering.cc +++ b/deal.II/deal.II/source/dofs/dof_renumbering.cc @@ -1496,13 +1496,13 @@ compute_subdomain_wise (std::vector &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 &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()); } diff --git a/deal.II/deal.II/source/dofs/dof_tools.cc b/deal.II/deal.II/source/dofs/dof_tools.cc index 4d0b6fe710..55ae34f1e2 100644 --- a/deal.II/deal.II/source/dofs/dof_tools.cc +++ b/deal.II/deal.II/source/dofs/dof_tools.cc @@ -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 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::invalid_dof_index, diff --git a/deal.II/deal.II/source/fe/fe.cc b/deal.II/deal.II/source/fe/fe.cc index 91abd88683..6b521a831a 100644 --- a/deal.II/deal.II/source/fe/fe.cc +++ b/deal.II/deal.II/source/fe/fe.cc @@ -496,8 +496,8 @@ FiniteElement::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); } diff --git a/deal.II/deal.II/source/fe/fe_data.cc b/deal.II/deal.II/source/fe/fe_data.cc index 2457fdaaa1..7b7588d9e9 100644 --- a/deal.II/deal.II/source/fe/fe_data.cc +++ b/deal.II/deal.II/source/fe/fe_data.cc @@ -76,7 +76,7 @@ FiniteElementData (const std::vector &dofs_per_object, GeometryInfo::quads_per_cell * dofs_per_quad + GeometryInfo::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) diff --git a/deal.II/deal.II/source/fe/fe_dgq.cc b/deal.II/deal.II/source/fe/fe_dgq.cc index 7ffdc58085..3b492aa9a0 100644 --- a/deal.II/deal.II/source/fe/fe_dgq.cc +++ b/deal.II/deal.II/source/fe/fe_dgq.cc @@ -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; } diff --git a/deal.II/deal.II/source/fe/fe_q.cc b/deal.II/deal.II/source/fe/fe_q.cc index 0d49d97f1b..52ad254040 100644 --- a/deal.II/deal.II/source/fe/fe_q.cc +++ b/deal.II/deal.II/source/fe/fe_q.cc @@ -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; } diff --git a/deal.II/deal.II/source/fe/fe_system.cc b/deal.II/deal.II/source/fe/fe_system.cc index 4c01c2037d..3e21d7dc18 100644 --- a/deal.II/deal.II/source/fe/fe_system.cc +++ b/deal.II/deal.II/source/fe/fe_system.cc @@ -1019,8 +1019,8 @@ FESystem::build_cell_tables() // non-primitive shape functions, // have a special invalid index. const std::pair - 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::build_face_tables() // functions, have a special // invalid index const std::pair - 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; diff --git a/deal.II/deal.II/source/fe/fe_tools.cc b/deal.II/deal.II/source/fe/fe_tools.cc index f3f21ea26d..f56f75ca49 100644 --- a/deal.II/deal.II/source/fe/fe_tools.cc +++ b/deal.II/deal.II/source/fe/fe_tools.cc @@ -480,7 +480,7 @@ void FETools::get_projection_matrix (const FiniteElement &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 quadrature(degree+1); diff --git a/deal.II/deal.II/source/grid/grid_generator.cc b/deal.II/deal.II/source/grid/grid_generator.cc index 70adfd55c7..bca963cf98 100644 --- a/deal.II/deal.II/source/grid/grid_generator.cc +++ b/deal.II/deal.II/source/grid/grid_generator.cc @@ -203,15 +203,15 @@ GridGenerator::moebius ( std::vector > 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 &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 &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 &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 diff --git a/deal.II/deal.II/source/grid/grid_in.cc b/deal.II/deal.II/source/grid/grid_in.cc index cfd26afc27..6d7f20009c 100644 --- a/deal.II/deal.II/source/grid/grid_in.cc +++ b/deal.II/deal.II/source/grid/grid_in.cc @@ -129,7 +129,7 @@ void GridIn::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::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::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::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::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::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; }; } diff --git a/deal.II/deal.II/source/grid/grid_out.cc b/deal.II/deal.II/source/grid/grid_out.cc index a2f04de333..9d2457ccbc 100644 --- a/deal.II/deal.II/source/grid/grid_out.cc +++ b/deal.II/deal.II/source/grid/grid_out.cc @@ -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 view_direction(-std::sin(z_angle * 2.*pi / 360.) * std::sin(turn_angle * 2.*pi / 360.), diff --git a/deal.II/deal.II/source/grid/grid_reordering.cc b/deal.II/deal.II/source/grid/grid_reordering.cc index 5a5be56fab..4595e6ec0a 100644 --- a/deal.II/deal.II/source/grid/grid_reordering.cc +++ b/deal.II/deal.II/source/grid/grid_reordering.cc @@ -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::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::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 diff --git a/deal.II/deal.II/source/grid/grid_tools.cc b/deal.II/deal.II/source/grid/grid_tools.cc index ac95292b01..ae66929542 100644 --- a/deal.II/deal.II/source/grid/grid_tools.cc +++ b/deal.II/deal.II/source/grid/grid_tools.cc @@ -329,7 +329,7 @@ GridTools::delete_unused_vertices (std::vector > &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 new_vertex_numbers (vertices.size(), invalid_vertex); unsigned int next_free_number = 0; for (unsigned int i=0; i 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::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::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); } diff --git a/deal.II/deal.II/source/hp/dof_handler.cc b/deal.II/deal.II/source/hp/dof_handler.cc index 78e11d413d..081c9d397d 100644 --- a/deal.II/deal.II/source/hp/dof_handler.cc +++ b/deal.II/deal.II/source/hp/dof_handler.cc @@ -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 - 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 - 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; ilines.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; linen_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; vn_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; } } diff --git a/deal.II/deal.II/source/hp/fe_values.cc b/deal.II/deal.II/source/hp/fe_values.cc index 9f47c16377..b73be928e4 100644 --- a/deal.II/deal.II/source/hp/fe_values.cc +++ b/deal.II/deal.II/source/hp/fe_values.cc @@ -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 diff --git a/deal.II/deal.II/source/multigrid/mg_dof_accessor.cc b/deal.II/deal.II/source/multigrid/mg_dof_accessor.cc index d56870496e..71c7e24afc 100644 --- a/deal.II/deal.II/source/multigrid/mg_dof_accessor.cc +++ b/deal.II/deal.II/source/multigrid/mg_dof_accessor.cc @@ -36,8 +36,8 @@ template MGDoFAccessor::MGDoFAccessor () : BaseClass (0, - static_cast(deal_II_numbers::invalid_unsigned_int), - static_cast(deal_II_numbers::invalid_unsigned_int), + static_cast(numbers::invalid_unsigned_int), + static_cast(numbers::invalid_unsigned_int), 0), mg_dof_handler(0) { diff --git a/deal.II/deal.II/source/multigrid/mg_dof_handler.cc b/deal.II/deal.II/source/multigrid/mg_dof_handler.cc index 773c608b1d..18aa95055e 100644 --- a/deal.II/deal.II/source/multigrid/mg_dof_handler.cc +++ b/deal.II/deal.II/source/multigrid/mg_dof_handler.cc @@ -38,7 +38,7 @@ DEAL_II_NAMESPACE_OPEN template MGDoFHandler::MGVertexDoFs::MGVertexDoFs () : - coarsest_level (deal_II_numbers::invalid_unsigned_int), + coarsest_level (numbers::invalid_unsigned_int), finest_level (0), indices (0) {} diff --git a/deal.II/deal.II/source/multigrid/mg_dof_tools.cc b/deal.II/deal.II/source/multigrid/mg_dof_tools.cc index 808c6baa27..540b696168 100644 --- a/deal.II/deal.II/source/multigrid/mg_dof_tools.cc +++ b/deal.II/deal.II/source/multigrid/mg_dof_tools.cc @@ -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 diff --git a/deal.II/deal.II/source/multigrid/mg_transfer_block.cc b/deal.II/deal.II/source/multigrid/mg_transfer_block.cc index a859fb73ed..c80bd4db3e 100644 --- a/deal.II/deal.II/source/multigrid/mg_transfer_block.cc +++ b/deal.II/deal.II/source/multigrid/mg_transfer_block.cc @@ -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); diff --git a/deal.II/deal.II/source/numerics/data_out.cc b/deal.II/deal.II/source/numerics/data_out.cc index 0ccdee4aaa..4d462fb223 100644 --- a/deal.II/deal.II/source/numerics/data_out.cc +++ b/deal.II/deal.II/source/numerics/data_out.cc @@ -679,7 +679,7 @@ void DataOut::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 diff --git a/deal.II/deal.II/source/numerics/data_out_rotation.cc b/deal.II/deal.II/source/numerics/data_out_rotation.cc index 9c0bc192bc..9d3befa0c3 100644 --- a/deal.II/deal.II/source/numerics/data_out_rotation.cc +++ b/deal.II/deal.II/source/numerics/data_out_rotation.cc @@ -96,9 +96,9 @@ void DataOutRotation::build_some_patches (Data &data) std::vector > 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); }; diff --git a/deal.II/deal.II/source/numerics/derivative_approximation.cc b/deal.II/deal.II/source/numerics/derivative_approximation.cc index eb7ae49d6f..269231d24b 100644 --- a/deal.II/deal.II/source/numerics/derivative_approximation.cc +++ b/deal.II/deal.II/source/numerics/derivative_approximation.cc @@ -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); }; }; diff --git a/deal.II/deal.II/source/numerics/error_estimator.cc b/deal.II/deal.II/source/numerics/error_estimator.cc index 5dec7d989a..8051a74d76 100644 --- a/deal.II/deal.II/source/numerics/error_estimator.cc +++ b/deal.II/deal.II/source/numerics/error_estimator.cc @@ -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 &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 &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; sfn_children(); ++sf) @@ -828,13 +828,13 @@ estimate_some (const hp::MappingCollection &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 &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))) { diff --git a/deal.II/deal.II/source/numerics/matrices.cc b/deal.II/deal.II/source/numerics/matrices.cc index 02a144c014..6e6c9264ae 100644 --- a/deal.II/deal.II/source/numerics/matrices.cc +++ b/deal.II/deal.II/source/numerics/matrices.cc @@ -1208,10 +1208,10 @@ create_boundary_mass_matrix_1 (const Mapping &mapping, Threads::ThreadMutex::ScopedLock lock (mutex); for (unsigned int i=0; i
    +
  1. 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 dealii. The old name is retained via a namespace + alias but is deprecated and will eventually be removed. +
    + (WB 2007/11/02) +

    +
  2. 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. diff --git a/deal.II/examples/step-23/step-23.cc b/deal.II/examples/step-23/step-23.cc index 5eca1070c2..b0e5499299 100644 --- a/deal.II/examples/step-23/step-23.cc +++ b/deal.II/examples/step-23/step-23.cc @@ -310,7 +310,7 @@ double BoundaryValuesU::value (const Point &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::value (const Point &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; } diff --git a/deal.II/examples/step-24/step-24.cc b/deal.II/examples/step-24/step-24.cc index c65c6a5c82..7c6f8597a3 100644 --- a/deal.II/examples/step-24/step-24.cc +++ b/deal.II/examples/step-24/step-24.cc @@ -252,9 +252,9 @@ TATForwardProblem::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 (std::cos(detector_angle), std::sin(detector_angle)) * detector_radius); diff --git a/deal.II/examples/step-25/step-25.cc b/deal.II/examples/step-25/step-25.cc index fc6dbe019a..221b8442f9 100644 --- a/deal.II/examples/step-25/step-25.cc +++ b/deal.II/examples/step-25/step-25.cc @@ -211,7 +211,7 @@ double ExactSolution::value (const Point &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::value (const Point &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.; diff --git a/deal.II/examples/step-27/step-27.cc b/deal.II/examples/step-27/step-27.cc index 40737884bf..e5603b5765 100644 --- a/deal.II/examples/step-27/step-27.cc +++ b/deal.II/examples/step-27/step-27.cc @@ -807,8 +807,8 @@ estimate_smoothness (Vector &smoothness_indicators) const && (i*i + j*j < N*N)) { - k_vectors.push_back (Point(deal_II_numbers::PI * i, - deal_II_numbers::PI * j)); + k_vectors.push_back (Point(numbers::PI * i, + numbers::PI * j)); k_vectors_magnitude.push_back (i*i+j*j); } @@ -824,9 +824,9 @@ estimate_smoothness (Vector &smoothness_indicators) const && (i*i + j*j + k*k < N*N)) { - k_vectors.push_back (Point(deal_II_numbers::PI * i, - deal_II_numbers::PI * j, - deal_II_numbers::PI * k)); + k_vectors.push_back (Point(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 &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); } } diff --git a/deal.II/examples/step-9/step-9.cc b/deal.II/examples/step-9/step-9.cc index d32f1ae4db..9b2c4fe8ce 100644 --- a/deal.II/examples/step-9/step-9.cc +++ b/deal.II/examples/step-9/step-9.cc @@ -331,7 +331,7 @@ AdvectionField::value (const Point &p) const Point value; value[0] = 2; for (unsigned int i=1; i::value (const Point &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; } diff --git a/deal.II/lac/include/lac/block_matrix_base.h b/deal.II/lac/include/lac/block_matrix_base.h index 34f11e932c..11f81f5494 100644 --- a/deal.II/lac/include/lac/block_matrix_base.h +++ b/deal.II/lac/include/lac/block_matrix_base.h @@ -1010,7 +1010,7 @@ namespace BlockMatrixIterators unsigned int AccessorBase::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::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::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::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::value_type Accessor::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::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::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::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::value_type Accessor::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::set_value (typename Accessor::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::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::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 @@ -1579,7 +1579,7 @@ BlockMatrixBase::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 diff --git a/deal.II/lac/include/lac/block_sparse_matrix_ez.h b/deal.II/lac/include/lac/block_sparse_matrix_ez.h index 9e3d1c2999..06817ba474 100644 --- a/deal.II/lac/include/lac/block_sparse_matrix_ez.h +++ b/deal.II/lac/include/lac/block_sparse_matrix_ez.h @@ -420,7 +420,7 @@ BlockSparseMatrixEZ::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 @@ -441,7 +441,7 @@ BlockSparseMatrixEZ::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 diff --git a/deal.II/lac/include/lac/block_vector.h b/deal.II/lac/include/lac/block_vector.h index ff2faef5d0..0ff8b713b7 100644 --- a/deal.II/lac/include/lac/block_vector.h +++ b/deal.II/lac/include/lac/block_vector.h @@ -431,7 +431,7 @@ BlockVector & BlockVector::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 void BlockVector::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; in_blocks();++i) diff --git a/deal.II/lac/include/lac/block_vector_base.h b/deal.II/lac/include/lac/block_vector_base.h index a22727108d..094191ae66 100644 --- a/deal.II/lac/include/lac/block_vector_base.h +++ b/deal.II/lac/include/lac/block_vector_base.h @@ -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 void BlockVectorBase::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::add (const value_type a, const BlockVectorBase& 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::add (const value_type a, const BlockVectorBase& 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::sadd (const value_type x, const BlockVectorBase& 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::sadd (const value_type x, const value_type a, const BlockVectorBase& 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::sadd (const value_type x, const value_type a, const BlockVectorBase& 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::sadd (const value_type x, const value_type a, const BlockVectorBase& 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::equ (const value_type a, const BlockVectorBase& 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::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& BlockVectorBase::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 & BlockVectorBase::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 & BlockVectorBase::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() ); diff --git a/deal.II/lac/include/lac/full_matrix.h b/deal.II/lac/include/lac/full_matrix.h index 0848a37e6c..68af9cdd83 100644 --- a/deal.II/lac/include/lac/full_matrix.h +++ b/deal.II/lac/include/lac/full_matrix.h @@ -1238,7 +1238,7 @@ inline number FullMatrix::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); } diff --git a/deal.II/lac/include/lac/full_matrix.templates.h b/deal.II/lac/include/lac/full_matrix.templates.h index abaead2eca..40ecf0624a 100644 --- a/deal.II/lac/include/lac/full_matrix.templates.h +++ b/deal.II/lac/include/lac/full_matrix.templates.h @@ -127,7 +127,7 @@ FullMatrix & FullMatrix::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 & FullMatrix::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::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) diff --git a/deal.II/lac/include/lac/matrix_lib.h b/deal.II/lac/include/lac/matrix_lib.h index 9fa2e4bac0..7a86ad5f54 100644 --- a/deal.II/lac/include/lac/matrix_lib.h +++ b/deal.II/lac/include/lac/matrix_lib.h @@ -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. diff --git a/deal.II/lac/include/lac/matrix_lib.templates.h b/deal.II/lac/include/lac/matrix_lib.templates.h index 5eecf2bdd4..8ed570fc6c 100644 --- a/deal.II/lac/include/lac/matrix_lib.templates.h +++ b/deal.II/lac/include/lac/matrix_lib.templates.h @@ -67,7 +67,7 @@ template void MeanValueFilter::filter(BlockVector& v) const { - Assert (component != deal_II_numbers::invalid_unsigned_int, + Assert (component != numbers::invalid_unsigned_int, ExcNotInitialized()); for (unsigned int i=0;i& dst, const BlockVector& 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& dst, const BlockVector& src) const { - Assert (component != deal_II_numbers::invalid_unsigned_int, + Assert (component != numbers::invalid_unsigned_int, ExcNotInitialized()); Assert (dst.n_blocks() == src.n_blocks(), diff --git a/deal.II/lac/include/lac/sparse_matrix.h b/deal.II/lac/include/lac/sparse_matrix.h index 35d58d141f..da0a9c3147 100644 --- a/deal.II/lac/include/lac/sparse_matrix.h +++ b/deal.II/lac/include/lac/sparse_matrix.h @@ -1819,7 +1819,7 @@ void SparseMatrix::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::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()); diff --git a/deal.II/lac/include/lac/sparse_matrix_ez.h b/deal.II/lac/include/lac/sparse_matrix_ez.h index 5ca5b70994..1eb56f7593 100644 --- a/deal.II/lac/include/lac/sparse_matrix_ez.h +++ b/deal.II/lac/include/lac/sparse_matrix_ez.h @@ -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::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::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 inline Vector & Vector::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 & Vector::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 & Vector::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::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::add (const Number a, const Vector& 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::sadd (const Number x, const Number a, const Vector& 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()); diff --git a/deal.II/lac/include/lac/vector.templates.h b/deal.II/lac/include/lac/vector.templates.h index a39e2209f1..70c396ede1 100644 --- a/deal.II/lac/include/lac/vector.templates.h +++ b/deal.II/lac/include/lac/vector.templates.h @@ -46,7 +46,7 @@ namespace internal template 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 void Vector::add (const Number a, const Vector& v, const Number b, const Vector& 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::add (const Number a, const Vector& v, template void Vector::sadd (const Number x, const Vector& 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::sadd (const Number x, const Number a, const Vector& v, const Number b, const Vector& 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::sadd (const Number x, const Number a, const Vector& w, const Number c, const Vector& 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 template void Vector::equ (const Number a, const Vector& 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 void Vector::equ (const Number a, const Vector& u, const Number b, const Vector& 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()); diff --git a/deal.II/lac/source/petsc_matrix_base.cc b/deal.II/lac/source/petsc_matrix_base.cc index a46961479c..18f7408128 100644 --- a/deal.II/lac/source/petsc_matrix_base.cc +++ b/deal.II/lac/source/petsc_matrix_base.cc @@ -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) diff --git a/deal.II/lac/source/petsc_vector_base.cc b/deal.II/lac/source/petsc_vector_base.cc index 2878a49d27..b8e9b4dd90 100644 --- a/deal.II/lac/source/petsc_vector_base.cc +++ b/deal.II/lac/source/petsc_vector_base.cc @@ -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(), diff --git a/tests/base/functions_01.cc b/tests/base/functions_01.cc index c66e23b62e..8bd7789075 100644 --- a/tests/base/functions_01.cc +++ b/tests/base/functions_01.cc @@ -74,7 +74,7 @@ check_function(const Functions::FlowFunction& f, ++vertex_number; } for (unsigned int i=0;i::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; diff --git a/tests/base/is_finite.cc b/tests/base/is_finite.cc index 3edf981730..8edb246f16 100644 --- a/tests/base/is_finite.cc +++ b/tests/base/is_finite.cc @@ -11,7 +11,7 @@ // //---------------------------- is_finite.cc --------------------------- -// check deal_II_numbers::is_finite +// check numbers::is_finite #include "../tests.h" #include @@ -23,7 +23,7 @@ template void check () { - using namespace deal_II_numbers; + using namespace numbers; deallog << std::numeric_limits::quiet_NaN() << " --> "; deallog << is_finite(std::numeric_limits::quiet_NaN()) << std::endl; diff --git a/tests/bits/cylinder_04.cc b/tests/bits/cylinder_04.cc index f3d91cf0ef..7fd7eb31bd 100644 --- a/tests/bits/cylinder_04.cc +++ b/tests/bits/cylinder_04.cc @@ -32,7 +32,7 @@ #include -const double xy_angle = deal_II_numbers::PI/6; +const double xy_angle = numbers::PI/6; template Point rotate_to_y (const Point &p) diff --git a/tests/bits/error_estimator_02.cc b/tests/bits/error_estimator_02.cc index aa3403d286..c8b33d3ea7 100644 --- a/tests/bits/error_estimator_02.cc +++ b/tests/bits/error_estimator_02.cc @@ -164,7 +164,7 @@ check () v, this_error, std::vector(), 0, multithread_info.n_default_threads, - deal_II_numbers::invalid_unsigned_int, + numbers::invalid_unsigned_int, material); this_error *= scaling_factor; diff --git a/tests/deal.II/line_coarsening_3d.cc b/tests/deal.II/line_coarsening_3d.cc index 3326f908bd..bd6dc8510d 100644 --- a/tests/deal.II/line_coarsening_3d.cc +++ b/tests/deal.II/line_coarsening_3d.cc @@ -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); } diff --git a/tests/fail/kelly_crash_01.cc b/tests/fail/kelly_crash_01.cc index 399248f7c6..94be855210 100644 --- a/tests/fail/kelly_crash_01.cc +++ b/tests/fail/kelly_crash_01.cc @@ -315,8 +315,8 @@ estimate_smoothness (Vector &smoothness_indicators) const && (i*i + j*j < N*N)) { - k_vectors.push_back (Point(deal_II_numbers::PI * i, - deal_II_numbers::PI * j)); + k_vectors.push_back (Point(numbers::PI * i, + numbers::PI * j)); k_vectors_magnitude.push_back (i*i+j*j); } @@ -332,9 +332,9 @@ estimate_smoothness (Vector &smoothness_indicators) const && (i*i + j*j + k*k < N*N)) { - k_vectors.push_back (Point(deal_II_numbers::PI * i, - deal_II_numbers::PI * j, - deal_II_numbers::PI * k)); + k_vectors.push_back (Point(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 &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(0, 0, -4), - Point(std::cos(0*deal_II_numbers::PI/6), - std::sin(0*deal_II_numbers::PI/6), + Point(std::cos(0*numbers::PI/6), + std::sin(0*numbers::PI/6), -4), - Point(std::cos(2*deal_II_numbers::PI/6), - std::sin(2*deal_II_numbers::PI/6), + Point(std::cos(2*numbers::PI/6), + std::sin(2*numbers::PI/6), -4), - Point(std::cos(4*deal_II_numbers::PI/6), - std::sin(4*deal_II_numbers::PI/6), + Point(std::cos(4*numbers::PI/6), + std::sin(4*numbers::PI/6), -4), - Point(std::cos(6*deal_II_numbers::PI/6), - std::sin(6*deal_II_numbers::PI/6), + Point(std::cos(6*numbers::PI/6), + std::sin(6*numbers::PI/6), -4), - Point(std::cos(8*deal_II_numbers::PI/6), - std::sin(8*deal_II_numbers::PI/6), + Point(std::cos(8*numbers::PI/6), + std::sin(8*numbers::PI/6), -4), - Point(std::cos(10*deal_II_numbers::PI/6), - std::sin(10*deal_II_numbers::PI/6), + Point(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(0, 0, 4-std::sqrt(2.)/2), - Point(std::cos(0*deal_II_numbers::PI/6), - std::sin(0*deal_II_numbers::PI/6), + Point(std::cos(0*numbers::PI/6), + std::sin(0*numbers::PI/6), 4), - Point(std::cos(2*deal_II_numbers::PI/6), - std::sin(2*deal_II_numbers::PI/6), + Point(std::cos(2*numbers::PI/6), + std::sin(2*numbers::PI/6), 4), - Point(std::cos(4*deal_II_numbers::PI/6), - std::sin(4*deal_II_numbers::PI/6), + Point(std::cos(4*numbers::PI/6), + std::sin(4*numbers::PI/6), 4), - Point(std::cos(6*deal_II_numbers::PI/6), - std::sin(6*deal_II_numbers::PI/6), + Point(std::cos(6*numbers::PI/6), + std::sin(6*numbers::PI/6), 4), - Point(std::cos(8*deal_II_numbers::PI/6), - std::sin(8*deal_II_numbers::PI/6), + Point(std::cos(8*numbers::PI/6), + std::sin(8*numbers::PI/6), 4), - Point(std::cos(10*deal_II_numbers::PI/6), - std::sin(10*deal_II_numbers::PI/6), + Point(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(0, 0, 7) + Point (std::cos(2*deal_II_numbers::PI/6), - std::sin(2*deal_II_numbers::PI/6), + Point(0, 0, 7) + Point (std::cos(2*numbers::PI/6), + std::sin(2*numbers::PI/6), 0) * 4, - Point(std::cos(0*deal_II_numbers::PI/6), - std::sin(0*deal_II_numbers::PI/6), - 7) + Point (std::cos(2*deal_II_numbers::PI/6), - std::sin(2*deal_II_numbers::PI/6), + Point(std::cos(0*numbers::PI/6), + std::sin(0*numbers::PI/6), + 7) + Point (std::cos(2*numbers::PI/6), + std::sin(2*numbers::PI/6), 0) * 4, - Point(std::cos(2*deal_II_numbers::PI/6), - std::sin(2*deal_II_numbers::PI/6), - 7) + Point (std::cos(2*deal_II_numbers::PI/6), - std::sin(2*deal_II_numbers::PI/6), + Point(std::cos(2*numbers::PI/6), + std::sin(2*numbers::PI/6), + 7) + Point (std::cos(2*numbers::PI/6), + std::sin(2*numbers::PI/6), 0) * 4, - Point(std::cos(4*deal_II_numbers::PI/6), - std::sin(4*deal_II_numbers::PI/6), - 7) + Point (std::cos(2*deal_II_numbers::PI/6), - std::sin(2*deal_II_numbers::PI/6), + Point(std::cos(4*numbers::PI/6), + std::sin(4*numbers::PI/6), + 7) + Point (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(0, 0, 7) + Point (std::cos(6*deal_II_numbers::PI/6), - std::sin(6*deal_II_numbers::PI/6), + Point(0, 0, 7) + Point (std::cos(6*numbers::PI/6), + std::sin(6*numbers::PI/6), 0) * 4, - Point(std::cos(4*deal_II_numbers::PI/6), - std::sin(4*deal_II_numbers::PI/6), - 7) + Point (std::cos(6*deal_II_numbers::PI/6), - std::sin(6*deal_II_numbers::PI/6), + Point(std::cos(4*numbers::PI/6), + std::sin(4*numbers::PI/6), + 7) + Point (std::cos(6*numbers::PI/6), + std::sin(6*numbers::PI/6), 0) * 4, - Point(std::cos(6*deal_II_numbers::PI/6), - std::sin(6*deal_II_numbers::PI/6), - 7) + Point (std::cos(6*deal_II_numbers::PI/6), - std::sin(6*deal_II_numbers::PI/6), + Point(std::cos(6*numbers::PI/6), + std::sin(6*numbers::PI/6), + 7) + Point (std::cos(6*numbers::PI/6), + std::sin(6*numbers::PI/6), 0) * 4, - Point(std::cos(8*deal_II_numbers::PI/6), - std::sin(8*deal_II_numbers::PI/6), - 7) + Point (std::cos(6*deal_II_numbers::PI/6), - std::sin(6*deal_II_numbers::PI/6), + Point(std::cos(8*numbers::PI/6), + std::sin(8*numbers::PI/6), + 7) + Point (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(0, 0, 7) + Point (std::cos(10*deal_II_numbers::PI/6), - std::sin(10*deal_II_numbers::PI/6), + Point(0, 0, 7) + Point (std::cos(10*numbers::PI/6), + std::sin(10*numbers::PI/6), 0) * 4, - Point(std::cos(8*deal_II_numbers::PI/6), - std::sin(8*deal_II_numbers::PI/6), - 7) + Point (std::cos(10*deal_II_numbers::PI/6), - std::sin(10*deal_II_numbers::PI/6), + Point(std::cos(8*numbers::PI/6), + std::sin(8*numbers::PI/6), + 7) + Point (std::cos(10*numbers::PI/6), + std::sin(10*numbers::PI/6), 0) * 4, - Point(std::cos(10*deal_II_numbers::PI/6), - std::sin(10*deal_II_numbers::PI/6), - 7) + Point (std::cos(10*deal_II_numbers::PI/6), - std::sin(10*deal_II_numbers::PI/6), + Point(std::cos(10*numbers::PI/6), + std::sin(10*numbers::PI/6), + 7) + Point (std::cos(10*numbers::PI/6), + std::sin(10*numbers::PI/6), 0) * 4, - Point(std::cos(0*deal_II_numbers::PI/6), - std::sin(0*deal_II_numbers::PI/6), - 7) + Point (std::cos(10*deal_II_numbers::PI/6), - std::sin(10*deal_II_numbers::PI/6), + Point(std::cos(0*numbers::PI/6), + std::sin(0*numbers::PI/6), + 7) + Point (std::cos(10*numbers::PI/6), + std::sin(10*numbers::PI/6), 0) * 4, }; diff --git a/tests/hp/crash_17.cc b/tests/hp/crash_17.cc index 293e7a147d..eadc242b4c 100644 --- a/tests/hp/crash_17.cc +++ b/tests/hp/crash_17.cc @@ -315,8 +315,8 @@ estimate_smoothness (Vector &smoothness_indicators) const && (i*i + j*j < N*N)) { - k_vectors.push_back (Point(deal_II_numbers::PI * i, - deal_II_numbers::PI * j)); + k_vectors.push_back (Point(numbers::PI * i, + numbers::PI * j)); k_vectors_magnitude.push_back (i*i+j*j); } @@ -332,9 +332,9 @@ estimate_smoothness (Vector &smoothness_indicators) const && (i*i + j*j + k*k < N*N)) { - k_vectors.push_back (Point(deal_II_numbers::PI * i, - deal_II_numbers::PI * j, - deal_II_numbers::PI * k)); + k_vectors.push_back (Point(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 &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); } } diff --git a/tests/hp/crash_17_compressed_set_sparsity.cc b/tests/hp/crash_17_compressed_set_sparsity.cc index ca5871890b..df0c6212e0 100644 --- a/tests/hp/crash_17_compressed_set_sparsity.cc +++ b/tests/hp/crash_17_compressed_set_sparsity.cc @@ -317,8 +317,8 @@ estimate_smoothness (Vector &smoothness_indicators) const && (i*i + j*j < N*N)) { - k_vectors.push_back (Point(deal_II_numbers::PI * i, - deal_II_numbers::PI * j)); + k_vectors.push_back (Point(numbers::PI * i, + numbers::PI * j)); k_vectors_magnitude.push_back (i*i+j*j); } @@ -334,9 +334,9 @@ estimate_smoothness (Vector &smoothness_indicators) const && (i*i + j*j + k*k < N*N)) { - k_vectors.push_back (Point(deal_II_numbers::PI * i, - deal_II_numbers::PI * j, - deal_II_numbers::PI * k)); + k_vectors.push_back (Point(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 &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); } } diff --git a/tests/hp/crash_18.cc b/tests/hp/crash_18.cc index 7dc7d3666a..ae96488105 100644 --- a/tests/hp/crash_18.cc +++ b/tests/hp/crash_18.cc @@ -320,8 +320,8 @@ estimate_smoothness (Vector &smoothness_indicators) const && (i*i + j*j < N*N)) { - k_vectors.push_back (Point(deal_II_numbers::PI * i, - deal_II_numbers::PI * j)); + k_vectors.push_back (Point(numbers::PI * i, + numbers::PI * j)); k_vectors_magnitude.push_back (i*i+j*j); } @@ -337,9 +337,9 @@ estimate_smoothness (Vector &smoothness_indicators) const && (i*i + j*j + k*k < N*N)) { - k_vectors.push_back (Point(deal_II_numbers::PI * i, - deal_II_numbers::PI * j, - deal_II_numbers::PI * k)); + k_vectors.push_back (Point(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 &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); } } diff --git a/tests/hp/crash_18_compressed_set_sparsity.cc b/tests/hp/crash_18_compressed_set_sparsity.cc index 96aac4a717..7a98acf418 100644 --- a/tests/hp/crash_18_compressed_set_sparsity.cc +++ b/tests/hp/crash_18_compressed_set_sparsity.cc @@ -323,8 +323,8 @@ estimate_smoothness (Vector &smoothness_indicators) const && (i*i + j*j < N*N)) { - k_vectors.push_back (Point(deal_II_numbers::PI * i, - deal_II_numbers::PI * j)); + k_vectors.push_back (Point(numbers::PI * i, + numbers::PI * j)); k_vectors_magnitude.push_back (i*i+j*j); } @@ -340,9 +340,9 @@ estimate_smoothness (Vector &smoothness_indicators) const && (i*i + j*j + k*k < N*N)) { - k_vectors.push_back (Point(deal_II_numbers::PI * i, - deal_II_numbers::PI * j, - deal_II_numbers::PI * k)); + k_vectors.push_back (Point(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 &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); } } diff --git a/tests/lac/eigen.cc b/tests/lac/eigen.cc index a1217cae11..1e73e6b0c8 100644 --- a/tests/lac/eigen.cc +++ b/tests/lac/eigen.cc @@ -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;