From b30f84b6d416d9a4b4e20513a7a871ffcc268e25 Mon Sep 17 00:00:00 2001 From: Daniel Arndt Date: Sat, 3 Mar 2018 06:51:35 +0100 Subject: [PATCH] Avoid clashes of class names and namespace names --- include/deal.II/base/parallel.h | 6 +- .../base/polynomials_rannacher_turek.h | 4 +- include/deal.II/base/symmetric_tensor.h | 44 +- .../deal.II/base/symmetric_tensor.templates.h | 2 +- include/deal.II/base/table.h | 4 +- include/deal.II/distributed/tria.h | 4 +- include/deal.II/dofs/dof_accessor.h | 40 +- include/deal.II/dofs/dof_accessor.templates.h | 114 ++--- include/deal.II/dofs/dof_faces.h | 8 +- include/deal.II/dofs/dof_handler.h | 38 +- include/deal.II/dofs/dof_handler_policy.h | 2 +- include/deal.II/dofs/dof_iterator_selector.h | 8 +- include/deal.II/dofs/dof_levels.h | 2 +- include/deal.II/dofs/dof_objects.h | 2 +- include/deal.II/dofs/number_cache.h | 2 +- include/deal.II/fe/fe.h | 22 +- include/deal.II/fe/fe_dgp_nonparametric.h | 14 +- include/deal.II/fe/fe_enriched.h | 24 +- include/deal.II/fe/fe_face.h | 18 +- include/deal.II/fe/fe_nothing.h | 14 +- include/deal.II/fe/fe_p1nc.h | 18 +- include/deal.II/fe/fe_poly.h | 18 +- include/deal.II/fe/fe_poly.templates.h | 16 +- include/deal.II/fe/fe_poly_face.h | 18 +- include/deal.II/fe/fe_poly_face.templates.h | 12 +- include/deal.II/fe/fe_poly_tensor.h | 14 +- include/deal.II/fe/fe_system.h | 26 +- include/deal.II/fe/fe_update_flags.h | 2 +- include/deal.II/fe/fe_values.h | 4 +- include/deal.II/fe/mapping.h | 6 +- include/deal.II/fe/mapping_cartesian.h | 6 +- include/deal.II/fe/mapping_fe_field.h | 6 +- include/deal.II/fe/mapping_manifold.h | 6 +- include/deal.II/fe/mapping_q.h | 6 +- include/deal.II/fe/mapping_q1_eulerian.h | 2 +- include/deal.II/fe/mapping_q_eulerian.h | 2 +- include/deal.II/fe/mapping_q_generic.h | 6 +- include/deal.II/grid/filtered_iterator.h | 4 +- .../deal.II/grid/tensor_product_manifold.h | 14 +- include/deal.II/grid/tria.h | 26 +- include/deal.II/grid/tria_accessor.h | 32 +- .../deal.II/grid/tria_accessor.templates.h | 104 ++--- include/deal.II/grid/tria_faces.h | 2 +- include/deal.II/grid/tria_iterator_selector.h | 2 +- include/deal.II/grid/tria_levels.h | 2 +- include/deal.II/grid/tria_object.h | 2 +- include/deal.II/grid/tria_objects.h | 2 +- include/deal.II/hp/dof_faces.h | 4 +- include/deal.II/hp/dof_handler.h | 28 +- include/deal.II/hp/dof_level.h | 8 +- include/deal.II/lac/block_linear_operator.h | 28 +- include/deal.II/lac/block_vector.h | 2 +- .../lac/chunk_sparse_matrix.templates.h | 20 +- .../deal.II/lac/constraint_matrix.templates.h | 4 +- include/deal.II/lac/la_parallel_vector.h | 2 +- include/deal.II/lac/linear_operator.h | 20 +- include/deal.II/lac/matrix_out.h | 10 +- .../deal.II/lac/petsc_parallel_block_vector.h | 2 +- include/deal.II/lac/petsc_parallel_vector.h | 2 +- include/deal.II/lac/precondition.h | 30 +- .../deal.II/lac/read_write_vector.templates.h | 2 +- include/deal.II/lac/solver_gmres.h | 22 +- include/deal.II/lac/sparse_matrix.templates.h | 34 +- .../lac/trilinos_block_sparse_matrix.h | 4 +- .../deal.II/lac/trilinos_linear_operator.h | 40 +- .../lac/trilinos_parallel_block_vector.h | 2 +- include/deal.II/lac/trilinos_sparse_matrix.h | 6 +- include/deal.II/lac/trilinos_vector.h | 2 +- include/deal.II/lac/vector.templates.h | 4 +- include/deal.II/lac/vector_memory.h | 2 +- .../deal.II/lac/vector_operations_internal.h | 8 +- include/deal.II/matrix_free/matrix_free.h | 14 +- include/deal.II/multigrid/multigrid.h | 10 +- include/deal.II/numerics/data_out.h | 4 +- include/deal.II/numerics/data_out_dof_data.h | 22 +- .../numerics/data_out_dof_data.templates.h | 66 +-- include/deal.II/numerics/data_out_faces.h | 6 +- include/deal.II/numerics/data_out_rotation.h | 6 +- .../deal.II/numerics/point_value_history.h | 4 +- source/base/parallel.cc | 4 +- source/base/polynomial.cc | 4 +- source/base/quadrature.cc | 6 +- source/base/symmetric_tensor.inst.in | 6 +- source/base/timer.cc | 32 +- source/distributed/tria_base.cc | 4 +- source/dofs/dof_accessor.cc | 4 +- source/dofs/dof_faces.cc | 2 +- source/dofs/dof_handler.cc | 104 ++--- source/dofs/dof_handler.inst.in | 4 +- source/dofs/dof_handler_policy.cc | 20 +- source/dofs/dof_handler_policy.inst.in | 2 +- source/dofs/dof_objects.cc | 4 +- source/dofs/number_cache.cc | 2 +- source/fe/fe.cc | 4 +- source/fe/fe_dgp_nonparametric.cc | 14 +- source/fe/fe_enriched.cc | 26 +- source/fe/fe_face.cc | 18 +- source/fe/fe_nothing.cc | 14 +- source/fe/fe_p1nc.cc | 18 +- source/fe/fe_poly.cc | 16 +- source/fe/fe_poly_tensor.cc | 12 +- source/fe/fe_system.cc | 38 +- source/fe/fe_values.cc | 2 +- source/fe/fe_values.inst.in | 2 +- source/fe/mapping_cartesian.cc | 6 +- source/fe/mapping_fe_field.cc | 38 +- source/fe/mapping_manifold.cc | 32 +- source/fe/mapping_q.cc | 6 +- source/fe/mapping_q1_eulerian.cc | 2 +- source/fe/mapping_q_eulerian.cc | 2 +- source/fe/mapping_q_generic.cc | 72 ++-- source/grid/tria.cc | 402 +++++++++--------- source/grid/tria_accessor.cc | 2 +- source/grid/tria_faces.cc | 2 +- source/grid/tria_levels.cc | 6 +- source/grid/tria_objects.cc | 2 +- source/hp/dof_handler.cc | 14 +- source/lac/trilinos_sparse_matrix.cc | 8 +- source/lac/vector_memory.cc | 2 +- source/numerics/data_out.cc | 34 +- source/numerics/data_out.inst.in | 2 +- source/numerics/data_out_dof_data.inst.in | 4 +- .../numerics/data_out_dof_data_codim.inst.in | 4 +- source/numerics/data_out_faces.cc | 32 +- source/numerics/data_out_rotation.cc | 32 +- source/numerics/data_out_stack.cc | 18 +- source/numerics/point_value_history.cc | 22 +- tests/data_out/data_out_11.debug.output | 4 +- tests/lac/gmres_eigenvalues.cc | 2 +- tests/lac/linear_operator_01.cc | 2 +- tests/lac/linear_operator_01a.cc | 2 +- tests/lac/linear_operator_10.cc | 10 +- tests/lac/linear_operator_10a.cc | 8 +- tests/lac/linear_operator_13.cc | 2 +- tests/lac/linear_operator_14.cc | 2 +- tests/lac/solver_signals.cc | 2 +- tests/tests.h | 8 +- 137 files changed, 1148 insertions(+), 1148 deletions(-) diff --git a/include/deal.II/base/parallel.h b/include/deal.II/base/parallel.h index b3db498933..8881f8a717 100644 --- a/include/deal.II/base/parallel.h +++ b/include/deal.II/base/parallel.h @@ -753,7 +753,7 @@ namespace parallel namespace internal { - namespace Vector + namespace VectorImplementation { /** * If we do computations on vectors in parallel (say, we add two vectors @@ -773,10 +773,10 @@ namespace internal } - namespace SparseMatrix + namespace SparseMatrixImplementation { /** - * Like internal::Vector::minimum_parallel_grain_size, but now denoting + * Like internal::VectorImplementation::minimum_parallel_grain_size, but now denoting * the number of rows of a matrix that should be worked on as a minimum. */ extern unsigned int minimum_parallel_grain_size; diff --git a/include/deal.II/base/polynomials_rannacher_turek.h b/include/deal.II/base/polynomials_rannacher_turek.h index 3c17d497bb..7a48800e20 100644 --- a/include/deal.II/base/polynomials_rannacher_turek.h +++ b/include/deal.II/base/polynomials_rannacher_turek.h @@ -94,7 +94,7 @@ public: namespace internal { - namespace PolynomialsRannacherTurek + namespace PolynomialsRannacherTurekImplementation { template inline @@ -199,7 +199,7 @@ Tensor PolynomialsRannacherTurek::compute_derivative (const unsigned int i, const Point &p) const { - return internal::PolynomialsRannacherTurek::compute_derivative (i, p); + return internal::PolynomialsRannacherTurekImplementation::compute_derivative (i, p); } diff --git a/include/deal.II/base/symmetric_tensor.h b/include/deal.II/base/symmetric_tensor.h index 5a45694145..0d37c1a05a 100644 --- a/include/deal.II/base/symmetric_tensor.h +++ b/include/deal.II/base/symmetric_tensor.h @@ -62,7 +62,7 @@ namespace internal * A namespace for functions and classes that are internal to how the * SymmetricTensor class (and its associate functions) works. */ - namespace SymmetricTensor + namespace SymmetricTensorImplementation { /** * Compute the inverse of a symmetric tensor of a @@ -896,9 +896,9 @@ private: /** * Make a few helper classes friends as well. */ - friend struct internal::SymmetricTensor::Inverse<2,dim,Number>; + friend struct internal::SymmetricTensorImplementation::Inverse<2,dim,Number>; - friend struct internal::SymmetricTensor::Inverse<4,dim,Number>; + friend struct internal::SymmetricTensorImplementation::Inverse<4,dim,Number>; }; @@ -1084,7 +1084,7 @@ SymmetricTensor::operator = (const Number &d) namespace internal { - namespace SymmetricTensor + namespace SymmetricTensorImplementation { template dealii::Tensor<2,dim,Number> @@ -1403,7 +1403,7 @@ inline SymmetricTensor:: operator Tensor () const { - return internal::SymmetricTensor::convert_to_tensor (*this); + return internal::SymmetricTensorImplementation::convert_to_tensor (*this); } @@ -1996,7 +1996,7 @@ SymmetricTensor::operator () namespace internal { - namespace SymmetricTensor + namespace SymmetricTensorImplementation { template TableIndices @@ -2031,7 +2031,7 @@ SymmetricTensor::operator [] (const unsigned int row) const return internal::SymmetricTensorAccessors:: Accessor (*this, - internal::SymmetricTensor::get_partially_filled_indices (row, + internal::SymmetricTensorImplementation::get_partially_filled_indices (row, std::integral_constant())); } @@ -2044,7 +2044,7 @@ SymmetricTensor::operator [] (const unsigned int row) return internal::SymmetricTensorAccessors:: Accessor (*this, - internal::SymmetricTensor::get_partially_filled_indices (row, + internal::SymmetricTensorImplementation::get_partially_filled_indices (row, std::integral_constant())); } @@ -2112,7 +2112,7 @@ SymmetricTensor::end_raw() const namespace internal { - namespace SymmetricTensor + namespace SymmetricTensorImplementation { template unsigned int @@ -2144,7 +2144,7 @@ const Number & SymmetricTensor::access_raw_entry (const unsigned int index) const { AssertIndexRange (index, n_independent_components); - return data[internal::SymmetricTensor::entry_to_indices(*this, index)]; + return data[internal::SymmetricTensorImplementation::entry_to_indices(*this, index)]; } @@ -2155,7 +2155,7 @@ Number & SymmetricTensor::access_raw_entry (const unsigned int index) { AssertIndexRange (index, n_independent_components); - return data[internal::SymmetricTensor::entry_to_indices(*this, index)]; + return data[internal::SymmetricTensorImplementation::entry_to_indices(*this, index)]; } @@ -2253,7 +2253,7 @@ SymmetricTensor::norm () const namespace internal { - namespace SymmetricTensor + namespace SymmetricTensorImplementation { namespace { @@ -2353,14 +2353,14 @@ unsigned int SymmetricTensor::component_to_unrolled_index (const TableIndices &indices) { - return internal::SymmetricTensor::component_to_unrolled_index (indices); + return internal::SymmetricTensorImplementation::component_to_unrolled_index (indices); } namespace internal { - namespace SymmetricTensor + namespace SymmetricTensorImplementation { namespace { @@ -2460,7 +2460,7 @@ SymmetricTensor::unrolled_to_component_indices (const unsigned int i) { return - internal::SymmetricTensor::unrolled_to_component_indices (i, + internal::SymmetricTensorImplementation::unrolled_to_component_indices (i, std::integral_constant()); } @@ -2830,7 +2830,7 @@ eigenvalues (const SymmetricTensor<2,3,Number> &T); namespace internal { - namespace SymmetricTensor + namespace SymmetricTensorImplementation { /** * Tridiagonalize a rank-2 symmetric tensor using the Householder method. @@ -3164,13 +3164,13 @@ eigenvectors (const SymmetricTensor<2,dim,Number> &T, switch (method) { case SymmetricTensorEigenvectorMethod::hybrid: - eig_vals_vecs = internal::SymmetricTensor::hybrid(T); + eig_vals_vecs = internal::SymmetricTensorImplementation::hybrid(T); break; case SymmetricTensorEigenvectorMethod::ql_implicit_shifts: - eig_vals_vecs = internal::SymmetricTensor::ql_implicit_shifts(T); + eig_vals_vecs = internal::SymmetricTensorImplementation::ql_implicit_shifts(T); break; case SymmetricTensorEigenvectorMethod::jacobi: - eig_vals_vecs = internal::SymmetricTensor::jacobi(T); + eig_vals_vecs = internal::SymmetricTensorImplementation::jacobi(T); break; default: AssertThrow(false, ExcNotImplemented()); @@ -3178,7 +3178,7 @@ eigenvectors (const SymmetricTensor<2,dim,Number> &T, // Sort in descending order before output. std::sort(eig_vals_vecs.begin(), eig_vals_vecs.end(), - internal::SymmetricTensor::SortEigenValuesVectors()); + internal::SymmetricTensorImplementation::SortEigenValuesVectors()); return eig_vals_vecs; } @@ -3441,7 +3441,7 @@ inline SymmetricTensor<2,dim,Number> invert (const SymmetricTensor<2,dim,Number> &t) { - return internal::SymmetricTensor::Inverse<2,dim,Number>::value(t); + return internal::SymmetricTensorImplementation::Inverse<2,dim,Number>::value(t); } @@ -3462,7 +3462,7 @@ inline SymmetricTensor<4,dim,Number> invert (const SymmetricTensor<4,dim,Number> &t) { - return internal::SymmetricTensor::Inverse<4,dim,Number>::value(t); + return internal::SymmetricTensorImplementation::Inverse<4,dim,Number>::value(t); } diff --git a/include/deal.II/base/symmetric_tensor.templates.h b/include/deal.II/base/symmetric_tensor.templates.h index 86950f56f8..e8f80e8798 100644 --- a/include/deal.II/base/symmetric_tensor.templates.h +++ b/include/deal.II/base/symmetric_tensor.templates.h @@ -141,7 +141,7 @@ eigenvalues (const SymmetricTensor<2,3,Number> &T) namespace internal { - namespace SymmetricTensor + namespace SymmetricTensorImplementation { template void diff --git a/include/deal.II/base/table.h b/include/deal.II/base/table.h index d568d0b9cb..dc2bdcc58d 100644 --- a/include/deal.II/base/table.h +++ b/include/deal.II/base/table.h @@ -1966,7 +1966,7 @@ TableBase::empty () const namespace internal { - namespace Table + namespace TableImplementation { template void fill_Fortran_style (InputIterator entries, @@ -2026,7 +2026,7 @@ TableBase::fill (InputIterator entries, p != values.end(); ++p) *p = *entries++; else - internal::Table::fill_Fortran_style (entries, *this); + internal::TableImplementation::fill_Fortran_style (entries, *this); } diff --git a/include/deal.II/distributed/tria.h b/include/deal.II/distributed/tria.h index 0682dbe48a..b8259e1d74 100644 --- a/include/deal.II/distributed/tria.h +++ b/include/deal.II/distributed/tria.h @@ -54,7 +54,7 @@ DEAL_II_NAMESPACE_OPEN namespace internal { - namespace DoFHandler + namespace DoFHandlerImplementation { namespace Policy { @@ -863,7 +863,7 @@ namespace parallel std::vector mark_locally_active_vertices_on_level(const int level) const; - template friend class dealii::internal::DoFHandler::Policy::ParallelDistributed; + template friend class dealii::internal::DoFHandlerImplementation::Policy::ParallelDistributed; template friend class dealii::FETools::internal::ExtrapolateImplementation; }; diff --git a/include/deal.II/dofs/dof_accessor.h b/include/deal.II/dofs/dof_accessor.h index 3714ccd579..d65c5c9d04 100644 --- a/include/deal.II/dofs/dof_accessor.h +++ b/include/deal.II/dofs/dof_accessor.h @@ -37,12 +37,12 @@ template class FiniteElement; namespace internal { - namespace DoFCellAccessor + namespace DoFCellAccessorImplementation { struct Implementation; } - namespace DoFHandler + namespace DoFHandlerImplementation { struct Implementation; namespace Policy @@ -53,7 +53,7 @@ namespace internal namespace hp { - namespace DoFHandler + namespace DoFHandlerImplementation { struct Implementation; } @@ -68,7 +68,7 @@ namespace internal namespace internal { - namespace DoFAccessor + namespace DoFAccessorImplementation { /** * This is a switch class which only declares a @p typedef. It is meant to @@ -198,7 +198,7 @@ namespace internal * 2012, 2013 */ template -class DoFAccessor : public dealii::internal::DoFAccessor::Inheritance::BaseClass +class DoFAccessor : public dealii::internal::DoFAccessorImplementation::Inheritance::BaseClass { public: @@ -219,7 +219,7 @@ public: * exception classes simpler. */ typedef - typename dealii::internal::DoFAccessor::Inheritance::BaseClass + typename dealii::internal::DoFAccessorImplementation::Inheritance::BaseClass BaseClass; /** @@ -345,7 +345,7 @@ public: * a line itself, then the only valid index is @p i equals to zero, and the * function returns an iterator to itself. */ - typename dealii::internal::DoFHandler::Iterators::line_iterator + typename dealii::internal::DoFHandlerImplementation::Iterators::line_iterator line (const unsigned int i) const; /** @@ -353,7 +353,7 @@ public: * a quad itself, then the only valid index is @p i equals to zero, and the * function returns an iterator to itself. */ - typename dealii::internal::DoFHandler::Iterators::quad_iterator + typename dealii::internal::DoFHandlerImplementation::Iterators::quad_iterator quad (const unsigned int i) const; /** @@ -690,11 +690,11 @@ private: template friend class DoFHandler; template friend class hp::DoFHandler; - friend struct dealii::internal::DoFHandler::Policy::Implementation; - friend struct dealii::internal::DoFHandler::Implementation; - friend struct dealii::internal::hp::DoFHandler::Implementation; - friend struct dealii::internal::DoFCellAccessor::Implementation; - friend struct dealii::internal::DoFAccessor::Implementation; + friend struct dealii::internal::DoFHandlerImplementation::Policy::Implementation; + friend struct dealii::internal::DoFHandlerImplementation::Implementation; + friend struct dealii::internal::hp::DoFHandlerImplementation::Implementation; + friend struct dealii::internal::DoFCellAccessorImplementation::Implementation; + friend struct dealii::internal::DoFAccessorImplementation::Implementation; }; @@ -855,7 +855,7 @@ public: * Since meshes with dimension 1 do not have quads this method just throws * an exception. */ - typename dealii::internal::DoFHandler::Iterators, level_dof_access>::line_iterator + typename dealii::internal::DoFHandlerImplementation::Iterators, level_dof_access>::line_iterator line (const unsigned int i) const; /** @@ -864,7 +864,7 @@ public: * Since meshes with dimension 1 do not have quads this method just throws * an exception. */ - typename dealii::internal::DoFHandler::Iterators, level_dof_access>::quad_iterator + typename dealii::internal::DoFHandlerImplementation::Iterators, level_dof_access>::quad_iterator quad (const unsigned int i) const; /** @@ -1135,10 +1135,10 @@ protected: template friend class DoFHandler; template friend class hp::DoFHandler; - friend struct dealii::internal::DoFHandler::Policy::Implementation; - friend struct dealii::internal::DoFHandler::Implementation; - friend struct dealii::internal::hp::DoFHandler::Implementation; - friend struct dealii::internal::DoFCellAccessor::Implementation; + friend struct dealii::internal::DoFHandlerImplementation::Policy::Implementation; + friend struct dealii::internal::DoFHandlerImplementation::Implementation; + friend struct dealii::internal::hp::DoFHandlerImplementation::Implementation; + friend struct dealii::internal::DoFCellAccessorImplementation::Implementation; }; @@ -1835,7 +1835,7 @@ private: * update_cell_dof_indices_cache() function */ template friend class DoFHandler; - friend struct dealii::internal::DoFCellAccessor::Implementation; + friend struct dealii::internal::DoFCellAccessorImplementation::Implementation; }; diff --git a/include/deal.II/dofs/dof_accessor.templates.h b/include/deal.II/dofs/dof_accessor.templates.h index d22c7330f2..b460a1f793 100644 --- a/include/deal.II/dofs/dof_accessor.templates.h +++ b/include/deal.II/dofs/dof_accessor.templates.h @@ -55,7 +55,7 @@ DoFAccessor (const Triangulation::BaseClass (tria, level, index), @@ -201,7 +201,7 @@ DoFAccessor::child (const unsigned in namespace internal { - namespace DoFAccessor + namespace DoFAccessorImplementation { /** * A class like the one with same name in tria.cc. See there for more @@ -791,7 +791,7 @@ namespace internal (structdim==1 ? typename - internal::Triangulation::Iterators:: + internal::TriangulationImplementation::Iterators:: raw_line_iterator (&dof_handler.get_triangulation(), obj_level, obj_index)->used() @@ -841,7 +841,7 @@ namespace internal (structdim==1 ? typename - internal::Triangulation::Iterators:: + internal::TriangulationImplementation::Iterators:: raw_line_iterator (&dof_handler.get_triangulation(), obj_level, obj_index)->used() @@ -1599,7 +1599,7 @@ DoFAccessor::dof_index (const unsigned int const unsigned int fe_index) const { // access the respective DoF - return dealii::internal::DoFAccessor::Implementation::get_dof_index (*this->dof_handler, + return dealii::internal::DoFAccessorImplementation::Implementation::get_dof_index (*this->dof_handler, this->level(), this->present_index, fe_index, @@ -1626,7 +1626,7 @@ DoFAccessor::set_dof_index (const unsigned const unsigned int fe_index) const { // access the respective DoF - dealii::internal::DoFAccessor::Implementation::set_dof_index (*this->dof_handler, + dealii::internal::DoFAccessorImplementation::Implementation::set_dof_index (*this->dof_handler, this->level(), this->present_index, fe_index, @@ -1644,7 +1644,7 @@ DoFAccessor::n_active_fe_indices () const { // access the respective DoF return - dealii::internal::DoFAccessor::Implementation:: + dealii::internal::DoFAccessorImplementation::Implementation:: n_active_fe_indices (*this->dof_handler, this->level(), this->present_index, @@ -1660,7 +1660,7 @@ DoFAccessor::nth_active_fe_index (const uns { // access the respective DoF return - dealii::internal::DoFAccessor::Implementation:: + dealii::internal::DoFAccessorImplementation::Implementation:: nth_active_fe_index (*this->dof_handler, this->level(), this->present_index, @@ -1677,7 +1677,7 @@ DoFAccessor::fe_index_is_active (const unsi { // access the respective DoF return - dealii::internal::DoFAccessor::Implementation:: + dealii::internal::DoFAccessorImplementation::Implementation:: fe_index_is_active (*this->dof_handler, this->level(), this->present_index, @@ -1696,7 +1696,7 @@ DoFAccessor::vertex_dof_index const unsigned int fe_index) const { return - dealii::internal::DoFAccessor::Implementation::get_vertex_dof_index + dealii::internal::DoFAccessorImplementation::Implementation::get_vertex_dof_index (*this->dof_handler, this->vertex_index(vertex), fe_index, @@ -1720,7 +1720,7 @@ DoFAccessor::mg_vertex_dof_index (co ExcIndexRange (i, 0, this->dof_handler->get_fe (fe_index).dofs_per_vertex)); return - dealii::internal::DoFAccessor::Implementation::mg_vertex_dof_index + dealii::internal::DoFAccessorImplementation::Implementation::mg_vertex_dof_index (*this->dof_handler, level, this->vertex_index(vertex), @@ -1736,7 +1736,7 @@ DoFAccessor::set_vertex_dof_index (c const types::global_dof_index index, const unsigned int fe_index) const { - dealii::internal::DoFAccessor::Implementation::set_vertex_dof_index + dealii::internal::DoFAccessorImplementation::Implementation::set_vertex_dof_index (*this->dof_handler, this->vertex_index(vertex), fe_index, @@ -1763,7 +1763,7 @@ DoFAccessor::set_mg_vertex_dof_index ExcIndexRange (i, 0, this->dof_handler->get_fe (fe_index).dofs_per_vertex)); return - dealii::internal::DoFAccessor::Implementation::set_mg_vertex_dof_index + dealii::internal::DoFAccessorImplementation::Implementation::set_mg_vertex_dof_index (*this->dof_handler, level, this->vertex_index(vertex), @@ -1800,7 +1800,7 @@ DoFAccessor::get_fe (const unsigned int fe_ namespace internal { - namespace DoFAccessor + namespace DoFAccessorImplementation { template void get_dof_indices (const dealii::DoFAccessor<1,DoFHandlerType,level_dof_access> &accessor, @@ -2065,7 +2065,7 @@ DoFAccessor::get_dof_indices ExcInternalError()); // now do the actual work - dealii::internal::DoFAccessor::get_dof_indices (*this, dof_indices, fe_index); + dealii::internal::DoFAccessorImplementation::get_dof_indices (*this, dof_indices, fe_index); } @@ -2115,10 +2115,10 @@ void DoFAccessor::get_mg_dof_indices Assert (false, ExcNotImplemented ()); } - internal::DoFAccessor::get_mg_dof_indices (*this, - level, - dof_indices, - fe_index); + internal::DoFAccessorImplementation::get_mg_dof_indices (*this, + level, + dof_indices, + fe_index); } @@ -2167,20 +2167,20 @@ void DoFAccessor::set_mg_dof_indices Assert (false, ExcNotImplemented ()); } - internal::DoFAccessor::Implementation::set_mg_dof_indices (*this, - level, - dof_indices, - fe_index); + internal::DoFAccessorImplementation::Implementation::set_mg_dof_indices (*this, + level, + dof_indices, + fe_index); } namespace internal { - namespace DoFAccessor + namespace DoFAccessorImplementation { template inline - typename dealii::internal::DoFHandler::Iterators::quad_iterator + typename dealii::internal::DoFHandlerImplementation::Iterators::quad_iterator get_quad(const dealii::Triangulation *, unsigned int /*index*/, DoFHandlerType *) @@ -2190,46 +2190,46 @@ namespace internal template inline - typename dealii::internal::DoFHandler::Iterators, level_dof_access>::quad_iterator + typename dealii::internal::DoFHandlerImplementation::Iterators, level_dof_access>::quad_iterator get_quad(const dealii::Triangulation<2,2> *, unsigned int, dealii::DoFHandler<2,2> *) { Assert(false, ExcNotImplemented()); - return typename dealii::internal::DoFHandler::Iterators, level_dof_access>::line_iterator(); + return typename dealii::internal::DoFHandlerImplementation::Iterators, level_dof_access>::line_iterator(); } template inline - typename dealii::internal::DoFHandler::Iterators, level_dof_access>::quad_iterator + typename dealii::internal::DoFHandlerImplementation::Iterators, level_dof_access>::quad_iterator get_quad(const dealii::Triangulation<2,3> *, unsigned int, dealii::DoFHandler<2,3> *) { Assert(false, ExcNotImplemented()); - return typename dealii::internal::DoFHandler::Iterators, level_dof_access>::line_iterator(); + return typename dealii::internal::DoFHandlerImplementation::Iterators, level_dof_access>::line_iterator(); } template inline - typename dealii::internal::DoFHandler::Iterators, level_dof_access>::quad_iterator + typename dealii::internal::DoFHandlerImplementation::Iterators, level_dof_access>::quad_iterator get_quad(const dealii::Triangulation<2,2> *, unsigned int, dealii::hp::DoFHandler<2,2> *) { Assert(false, ExcNotImplemented()); - return typename dealii::internal::DoFHandler::Iterators, level_dof_access>::line_iterator(); + return typename dealii::internal::DoFHandlerImplementation::Iterators, level_dof_access>::line_iterator(); } template inline - typename dealii::internal::DoFHandler::Iterators, level_dof_access>::quad_iterator + typename dealii::internal::DoFHandlerImplementation::Iterators, level_dof_access>::quad_iterator get_quad(const dealii::Triangulation<2,3> *, unsigned int, dealii::hp::DoFHandler<2,3> *) { Assert(false, ExcNotImplemented()); - return typename dealii::internal::DoFHandler::Iterators, level_dof_access>::line_iterator(); + return typename dealii::internal::DoFHandlerImplementation::Iterators, level_dof_access>::line_iterator(); } } } @@ -2237,7 +2237,7 @@ namespace internal template inline -typename dealii::internal::DoFHandler::Iterators::line_iterator +typename dealii::internal::DoFHandlerImplementation::Iterators::line_iterator DoFAccessor::line (const unsigned int i) const { // if we are asking for a particular line and this object refers to @@ -2248,7 +2248,7 @@ DoFAccessor::line (const unsigned int Assert (i==0, ExcMessage ("You can only ask for line zero if the " "current object is a line itself.")); return - typename dealii::internal::DoFHandler::Iterators::cell_iterator + typename dealii::internal::DoFHandlerImplementation::Iterators::cell_iterator (&this->get_triangulation(), this->level(), this->index(), @@ -2260,7 +2260,7 @@ DoFAccessor::line (const unsigned int Assert (DoFHandlerType::dimension > 1, ExcImpossibleInDim(DoFHandlerType::dimension)); // checking of 'i' happens in line_index(i) - return typename dealii::internal::DoFHandler::Iterators::line_iterator + return typename dealii::internal::DoFHandlerImplementation::Iterators::line_iterator (this->tria, 0, // only sub-objects are allowed, which have no level this->line_index(i), @@ -2270,7 +2270,7 @@ DoFAccessor::line (const unsigned int template inline -typename dealii::internal::DoFHandler::Iterators::quad_iterator +typename dealii::internal::DoFHandlerImplementation::Iterators::quad_iterator DoFAccessor::quad (const unsigned int i) const { // if we are asking for a @@ -2283,7 +2283,7 @@ DoFAccessor::quad (const unsigned int Assert (i==0, ExcMessage ("You can only ask for quad zero if the " "current object is a quad itself.")); return - typename dealii::internal::DoFHandler::Iterators::cell_iterator + typename dealii::internal::DoFHandlerImplementation::Iterators::cell_iterator (&this->get_triangulation(), this->level(), this->index(), @@ -2295,7 +2295,7 @@ DoFAccessor::quad (const unsigned int Assert (DoFHandlerType::dimension > 2, ExcImpossibleInDim(DoFHandlerType::dimension)); // checking of 'i' happens in quad_index(i) - return typename dealii::internal::DoFHandler::Iterators::quad_iterator + return typename dealii::internal::DoFHandlerImplementation::Iterators::quad_iterator (this->tria, 0, // only sub-objects are allowed, which have no level this->quad_index(i), @@ -2425,7 +2425,7 @@ DoFAccessor<0,DoFHandlerType<1,spacedim>, level_dof_access>::get_dof_indices { for (unsigned int i=0; iglobal_vertex_index, fe_index, @@ -2464,7 +2464,7 @@ vertex_dof_index (const unsigned int vertex, { (void)vertex; Assert (vertex == 0, ExcIndexRange (vertex, 0, 1)); - return dealii::internal::DoFAccessor::Implementation::get_vertex_dof_index ( + return dealii::internal::DoFAccessorImplementation::Implementation::get_vertex_dof_index ( *dof_handler, this->global_vertex_index, fe_index, @@ -2480,7 +2480,7 @@ DoFAccessor<0,DoFHandlerType<1,spacedim>, level_dof_access>:: dof_index (const unsigned int i, const unsigned int fe_index) const { - return dealii::internal::DoFAccessor::Implementation::get_vertex_dof_index + return dealii::internal::DoFAccessorImplementation::Implementation::get_vertex_dof_index (*this->dof_handler, this->vertex_index(0), fe_index, @@ -2574,26 +2574,26 @@ DoFAccessor<0,DoFHandlerType<1,spacedim>, level_dof_access>::child (const unsign template