From edef15f7f4e170e62a6ecd8a9dace61dd328060b Mon Sep 17 00:00:00 2001 From: Wolfgang Bangerth Date: Sun, 4 Jan 2015 15:34:29 -0600 Subject: [PATCH] Remove namespace deal_II_numbers and various outdated in namespace types. --- doc/news/changes.h | 3 +- include/deal.II/base/index_set.h | 4 +-- include/deal.II/base/named_data.h | 2 +- include/deal.II/base/numbers.h | 11 ------ include/deal.II/base/types.h | 35 ++----------------- include/deal.II/lac/matrix_block.h | 4 +-- .../deal.II/matrix_free/dof_info.templates.h | 2 +- include/deal.II/meshworker/dof_info.h | 10 +++--- include/deal.II/meshworker/functional.h | 2 +- include/deal.II/meshworker/integration_info.h | 4 +-- source/base/quadrature.cc | 6 ++-- source/fe/mapping_q.cc | 2 +- source/fe/mapping_q1.cc | 4 +-- source/grid/tria_accessor.cc | 6 ++-- tests/base/named_data.cc | 2 +- tests/deal.II/assemble_matrix_parallel_01.cc | 2 +- tests/deal.II/assemble_matrix_parallel_02.cc | 2 +- tests/deal.II/assemble_matrix_parallel_03.cc | 2 +- tests/deal.II/assemble_matrix_parallel_04.cc | 2 +- tests/deal.II/inhomogeneous_constraints.cc | 2 +- tests/trilinos/assemble_matrix_parallel_01.cc | 2 +- tests/trilinos/assemble_matrix_parallel_02.cc | 2 +- tests/trilinos/assemble_matrix_parallel_03.cc | 2 +- tests/trilinos/assemble_matrix_parallel_04.cc | 2 +- tests/trilinos/assemble_matrix_parallel_05.cc | 2 +- tests/trilinos/assemble_matrix_parallel_06.cc | 2 +- tests/trilinos/assemble_matrix_parallel_07.cc | 2 +- 27 files changed, 40 insertions(+), 81 deletions(-) diff --git a/doc/news/changes.h b/doc/news/changes.h index fd393c79c7..3574913212 100644 --- a/doc/news/changes.h +++ b/doc/news/changes.h @@ -98,7 +98,8 @@ inconvenience this causes. class. - The deprecated constructor of MPI_InitFinalize - The MPI support functions in namespace Utilities and Utilities::System. - +- Deprecated members of namespace types +- Namespace deal_II_numbers. diff --git a/include/deal.II/base/index_set.h b/include/deal.II/base/index_set.h index 4061ecd74d..f251756129 100644 --- a/include/deal.II/base/index_set.h +++ b/include/deal.II/base/index_set.h @@ -499,7 +499,7 @@ IndexSet::IndexSet () : is_compressed (true), index_space_size (0), - largest_range (deal_II_numbers::invalid_unsigned_int) + largest_range (numbers::invalid_unsigned_int) {} @@ -509,7 +509,7 @@ IndexSet::IndexSet (const types::global_dof_index size) : is_compressed (true), index_space_size (size), - largest_range (deal_II_numbers::invalid_unsigned_int) + largest_range (numbers::invalid_unsigned_int) {} diff --git a/include/deal.II/base/named_data.h b/include/deal.II/base/named_data.h index a516a965a7..dae3357b38 100644 --- a/include/deal.II/base/named_data.h +++ b/include/deal.II/base/named_data.h @@ -372,7 +372,7 @@ NamedData::find (const std::string &name) const const std::vector::const_iterator i = std::find(names.begin(), names.end(), name); if (i == names.end()) - return deal_II_numbers::invalid_unsigned_int; + return numbers::invalid_unsigned_int; return i - names.begin(); } diff --git a/include/deal.II/base/numbers.h b/include/deal.II/base/numbers.h index fca7d0ab0c..4c7da9dc07 100644 --- a/include/deal.II/base/numbers.h +++ b/include/deal.II/base/numbers.h @@ -225,17 +225,6 @@ namespace numbers } -//TODO[WB]: eventually remove this namespace alias -/* - * Namespace alias with the old name for the numbers namespace. The namespace - * was originally called numbers, but has since been renamed to - * dealii::numbers when everything was moved into namespace dealii. - * - * @deprecated - */ -namespace deal_II_numbers = numbers; - - // --------------- inline and template functions ---------------- // namespace numbers diff --git a/include/deal.II/base/types.h b/include/deal.II/base/types.h index 61b4654dba..a9ced11de1 100644 --- a/include/deal.II/base/types.h +++ b/include/deal.II/base/types.h @@ -19,6 +19,8 @@ #include #include + + DEAL_II_NAMESPACE_OPEN /** @@ -39,21 +41,6 @@ namespace types */ typedef unsigned int subdomain_id; - /** - * @deprecated Old name for the typedef above. - */ - typedef subdomain_id subdomain_id_t DEAL_II_DEPRECATED; - - /** - * @deprecated Use numbers::invalid_subdomain_id - */ - const unsigned int invalid_subdomain_id DEAL_II_DEPRECATED = static_cast(-1); - - /** - * @deprecated Use numbers::artificial_subdomain_id - */ - const unsigned int artificial_subdomain_id DEAL_II_DEPRECATED = static_cast(-2); - #ifdef DEAL_II_WITH_64BIT_INDICES /** * The type used for global indices of degrees of freedom. While in @@ -96,12 +83,6 @@ namespace types # define DEAL_II_DOF_INDEX_MPI_TYPE MPI_UNSIGNED #endif - - /** - * @deprecated Use numbers::invalid_dof_index - */ - const global_dof_index invalid_dof_index DEAL_II_DEPRECATED = static_cast(-1); - /** * The type used to denote boundary indicators associated with every piece * of the boundary and, in the case of meshes that describe manifolds in @@ -129,12 +110,6 @@ namespace types */ typedef unsigned int manifold_id; - - /** - * @deprecated Old name for the typedef above. - */ - typedef boundary_id boundary_id_t DEAL_II_DEPRECATED; - /** * The type used to denote material indicators associated with every cell. * @@ -142,12 +117,6 @@ namespace types * indicate an invalid value of this type. */ typedef unsigned char material_id; - - /** - * @deprecated Old name for the typedef above. - */ - typedef material_id material_id_t DEAL_II_DEPRECATED; - } namespace TrilinosWrappers diff --git a/include/deal.II/lac/matrix_block.h b/include/deal.II/lac/matrix_block.h index 5a390981ed..f1267fc10f 100644 --- a/include/deal.II/lac/matrix_block.h +++ b/include/deal.II/lac/matrix_block.h @@ -582,8 +582,8 @@ template inline MatrixBlock::MatrixBlock() : - row(deal_II_numbers::invalid_size_type), - column(deal_II_numbers::invalid_size_type) + row(numbers::invalid_size_type), + column(numbers::invalid_size_type) {} diff --git a/include/deal.II/matrix_free/dof_info.templates.h b/include/deal.II/matrix_free/dof_info.templates.h index b2f89394ea..561dc08ed1 100644 --- a/include/deal.II/matrix_free/dof_info.templates.h +++ b/include/deal.II/matrix_free/dof_info.templates.h @@ -104,7 +104,7 @@ namespace internal FPArrayComparator >::iterator, bool> it = constraints.insert(next_constraint); - types::global_dof_index insert_position = deal_II_numbers::invalid_dof_index; + types::global_dof_index insert_position = numbers::invalid_dof_index; if (it.second == false) insert_position = it.first->second; else diff --git a/include/deal.II/meshworker/dof_info.h b/include/deal.II/meshworker/dof_info.h index 6c5e31490a..6bc11b4378 100644 --- a/include/deal.II/meshworker/dof_info.h +++ b/include/deal.II/meshworker/dof_info.h @@ -77,7 +77,7 @@ namespace MeshWorker /** * The number of the current face on the current cell. * - * This number is deal_II_numbers::invalid_unsigned_int if the info object + * This number is numbers::invalid_unsigned_int if the info object * was initialized with a cell. */ unsigned int face_number; @@ -85,7 +85,7 @@ namespace MeshWorker /** * The number of the current subface on the current face * - * This number is deal_II_numbers::invalid_unsigned_int if the info object + * This number is numbers::invalid_unsigned_int if the info object * was not initialized with a subface. */ unsigned int sub_number; @@ -308,8 +308,8 @@ namespace MeshWorker level_cell = c->is_level_cell(); cell = typename Triangulation::cell_iterator(*c); - face_number = deal_II_numbers::invalid_unsigned_int; - sub_number = deal_II_numbers::invalid_unsigned_int; + face_number = numbers::invalid_unsigned_int; + sub_number = numbers::invalid_unsigned_int; if (block_info) LocalResults::reinit(block_info->local()); else @@ -326,7 +326,7 @@ namespace MeshWorker { face = static_cast::face_iterator> (f); face_number = face_no; - sub_number = deal_II_numbers::invalid_unsigned_int; + sub_number = numbers::invalid_unsigned_int; } diff --git a/include/deal.II/meshworker/functional.h b/include/deal.II/meshworker/functional.h index 6bb519c10a..865b881e23 100644 --- a/include/deal.II/meshworker/functional.h +++ b/include/deal.II/meshworker/functional.h @@ -252,7 +252,7 @@ namespace MeshWorker { BlockVector *v; if (separate_faces && - info.face_number != deal_II_numbers::invalid_unsigned_int) + info.face_number != numbers::invalid_unsigned_int) v = results.entry*>(1); else v = results.entry*>(0); diff --git a/include/deal.II/meshworker/integration_info.h b/include/deal.II/meshworker/integration_info.h index bb3a5bc68a..7269dac50f 100644 --- a/include/deal.II/meshworker/integration_info.h +++ b/include/deal.II/meshworker/integration_info.h @@ -665,13 +665,13 @@ namespace MeshWorker for (unsigned int i=0; i &febase = *fevalv[i]; - if (info.sub_number != deal_II_numbers::invalid_unsigned_int) + if (info.sub_number != numbers::invalid_unsigned_int) { // This is a subface FESubfaceValues &fe = dynamic_cast&> (febase); fe.reinit(info.cell, info.face_number, info.sub_number); } - else if (info.face_number != deal_II_numbers::invalid_unsigned_int) + else if (info.face_number != numbers::invalid_unsigned_int) { // This is a face FEFaceValues &fe = dynamic_cast&> (febase); diff --git a/source/base/quadrature.cc b/source/base/quadrature.cc index a68215f47e..a61d37ff7b 100644 --- a/source/base/quadrature.cc +++ b/source/base/quadrature.cc @@ -628,8 +628,8 @@ QProjector<3>::project_to_subface (const Quadrature<2> &quadrature, // indices tell, which global coordinate // (0->x, 1->y, 2->z) corresponds to which // local one - unsigned int xi_index = deal_II_numbers::invalid_unsigned_int, - eta_index = deal_II_numbers::invalid_unsigned_int, + unsigned int xi_index = numbers::invalid_unsigned_int, + eta_index = numbers::invalid_unsigned_int, const_index = face_no/2; // the xi and eta values have to be scaled // (by factor 0.5 or factor 1.0) depending on @@ -1302,7 +1302,7 @@ subface (const unsigned int face_no, // ones. // first, define an invalid number - static const unsigned int e = deal_II_numbers::invalid_unsigned_int; + static const unsigned int e = numbers::invalid_unsigned_int; static const RefinementCase equivalent_refine_case[internal::SubfaceCase::case_isotropic+1][GeometryInfo<3>::max_children_per_face] diff --git a/source/fe/mapping_q.cc b/source/fe/mapping_q.cc index 7e55c522a1..e297db0e21 100644 --- a/source/fe/mapping_q.cc +++ b/source/fe/mapping_q.cc @@ -380,7 +380,7 @@ MappingQ::fill_fe_face_values ( p_data=&data; const unsigned int n_q_points=q.size(); - this->compute_fill_face (cell, face_no, deal_II_numbers::invalid_unsigned_int, + this->compute_fill_face (cell, face_no, numbers::invalid_unsigned_int, n_q_points, QProjector::DataSetDescriptor:: face (face_no, diff --git a/source/fe/mapping_q1.cc b/source/fe/mapping_q1.cc index 9ef3db43c1..35295725e1 100644 --- a/source/fe/mapping_q1.cc +++ b/source/fe/mapping_q1.cc @@ -1028,7 +1028,7 @@ namespace internal { JxW_values[i] = boundary_forms[i].norm() * weights[i]; - if (subface_no!=deal_II_numbers::invalid_unsigned_int) + if (subface_no!=numbers::invalid_unsigned_int) { const double area_ratio=GeometryInfo::subface_ratio( cell->subface_case(face_no), subface_no); @@ -1091,7 +1091,7 @@ fill_fe_face_values (const typename Triangulation::cell_iterator & const unsigned int n_q_points = q.size(); - compute_fill_face (cell, face_no, deal_II_numbers::invalid_unsigned_int, + compute_fill_face (cell, face_no, numbers::invalid_unsigned_int, n_q_points, DataSetDescriptor::face (face_no, cell->face_orientation(face_no), diff --git a/source/grid/tria_accessor.cc b/source/grid/tria_accessor.cc index 7c9d633e09..d6d13e3efd 100644 --- a/source/grid/tria_accessor.cc +++ b/source/grid/tria_accessor.cc @@ -96,7 +96,7 @@ namespace const bool first_child_has_children=face->child(0)->has_children(); - static const unsigned int e = deal_II_numbers::invalid_unsigned_int; + static const unsigned int e = numbers::invalid_unsigned_int; // array containing the translation of the // numbers, @@ -1754,8 +1754,8 @@ CellAccessor::neighbor_of_coarser_neighbor (const unsigned int ne // since then we did not find // our way back... Assert (false, ExcInternalError()); - return std::make_pair (deal_II_numbers::invalid_unsigned_int, - deal_II_numbers::invalid_unsigned_int); + return std::make_pair (numbers::invalid_unsigned_int, + numbers::invalid_unsigned_int); } case 3: diff --git a/tests/base/named_data.cc b/tests/base/named_data.cc index f7e2ad631a..f726c09f75 100644 --- a/tests/base/named_data.cc +++ b/tests/base/named_data.cc @@ -47,7 +47,7 @@ test_selector(const NamedData &data) for (unsigned int i=0; i::value (const Point &p, { double sum = 0; for (unsigned int d=0; d::value (const Point &p, { double sum = 0; for (unsigned int d=0; d::value (const Point &p, { double sum = 0; for (unsigned int d=0; d::value (const Point &p, { double sum = 0; for (unsigned int d=0; d::value (const Point &p, { double sum = 0; for (unsigned int d=0; d::value (const Point &p, { double sum = 0; for (unsigned int d=0; d::value (const Point &p, { double sum = 0; for (unsigned int d=0; d::value (const Point &p, { double sum = 0; for (unsigned int d=0; d::value (const Point &p, { double sum = 0; for (unsigned int d=0; d::value (const Point &p, { double sum = 0; for (unsigned int d=0; d::value (const Point &p, { double sum = 0; for (unsigned int d=0; d::value (const Point &p, { double sum = 0; for (unsigned int d=0; d