From 2b80915af14d5eb099111bb4b3b6b7fb69b6fdca Mon Sep 17 00:00:00 2001 From: David Wells Date: Sat, 5 Mar 2016 14:53:46 -0500 Subject: [PATCH] Remove unused forward declarations. --- include/deal.II/distributed/grid_refinement.h | 4 ---- include/deal.II/distributed/shared_tria.h | 3 --- include/deal.II/distributed/tria.h | 2 -- include/deal.II/distributed/tria_base.h | 3 --- include/deal.II/dofs/dof_accessor.h | 1 - include/deal.II/dofs/dof_iterator_selector.h | 1 - include/deal.II/fe/fe.h | 5 ----- include/deal.II/fe/fe_abf.h | 2 -- include/deal.II/fe/fe_base.h | 3 --- include/deal.II/fe/fe_dg_vector.h | 3 --- include/deal.II/fe/fe_dgp.h | 2 -- include/deal.II/fe/fe_dgp_monomial.h | 3 --- include/deal.II/fe/fe_dgp_nonparametric.h | 4 ---- include/deal.II/fe/fe_nedelec.h | 3 --- include/deal.II/fe/fe_q_hierarchical.h | 3 --- include/deal.II/fe/fe_raviart_thomas.h | 3 --- include/deal.II/fe/fe_tools.h | 5 ----- include/deal.II/fe/fe_values.h | 5 ----- include/deal.II/fe/mapping_q.h | 3 --- include/deal.II/grid/grid_generator.h | 5 ----- include/deal.II/grid/grid_in.h | 2 -- include/deal.II/grid/grid_refinement.h | 1 - include/deal.II/grid/manifold.h | 3 --- include/deal.II/grid/tria.h | 1 - include/deal.II/grid/tria_boundary.h | 4 ---- include/deal.II/grid/tria_iterator.h | 1 - include/deal.II/lac/block_sparsity_pattern.h | 7 ------- include/deal.II/lac/block_vector.h | 1 - include/deal.II/lac/constraint_matrix.h | 2 -- include/deal.II/lac/dynamic_sparsity_pattern.h | 1 - include/deal.II/lac/filtered_matrix.h | 2 -- include/deal.II/lac/petsc_parallel_vector.h | 6 ------ include/deal.II/lac/precondition_block.h | 3 --- include/deal.II/lac/vector_space_vector.h | 4 ---- include/deal.II/meshworker/local_results.h | 2 -- include/deal.II/multigrid/mg_base.h | 2 -- include/deal.II/multigrid/mg_tools.h | 7 ------- include/deal.II/numerics/data_out.h | 2 -- include/deal.II/numerics/derivative_approximation.h | 8 -------- include/deal.II/numerics/error_estimator.h | 2 -- include/deal.II/numerics/matrix_tools.h | 1 - include/deal.II/numerics/point_value_history.h | 10 ---------- include/deal.II/numerics/vector_tools.h | 1 - 43 files changed, 136 deletions(-) diff --git a/include/deal.II/distributed/grid_refinement.h b/include/deal.II/distributed/grid_refinement.h index ff774b1bc9..1d09221300 100644 --- a/include/deal.II/distributed/grid_refinement.h +++ b/include/deal.II/distributed/grid_refinement.h @@ -30,10 +30,6 @@ namespace parallel { namespace distributed { - // forward declarations - template class Triangulation; - - /** * Collection of functions controlling refinement and coarsening of * parallel::distributed::Triangulation objects. This namespace provides diff --git a/include/deal.II/distributed/shared_tria.h b/include/deal.II/distributed/shared_tria.h index 3d3d66900c..9f5b2ce1ba 100644 --- a/include/deal.II/distributed/shared_tria.h +++ b/include/deal.II/distributed/shared_tria.h @@ -41,9 +41,6 @@ DEAL_II_NAMESPACE_OPEN -template class Triangulation; - - namespace parallel { diff --git a/include/deal.II/distributed/tria.h b/include/deal.II/distributed/tria.h index 1c347c6cce..5e0afca59d 100644 --- a/include/deal.II/distributed/tria.h +++ b/include/deal.II/distributed/tria.h @@ -50,8 +50,6 @@ DEAL_II_NAMESPACE_OPEN -template class Triangulation; - #ifdef DEAL_II_WITH_P4EST namespace internal diff --git a/include/deal.II/distributed/tria_base.h b/include/deal.II/distributed/tria_base.h index 6dd25d0749..27cd704e07 100644 --- a/include/deal.II/distributed/tria_base.h +++ b/include/deal.II/distributed/tria_base.h @@ -35,9 +35,6 @@ DEAL_II_NAMESPACE_OPEN -template class Triangulation; - - namespace parallel { /** diff --git a/include/deal.II/dofs/dof_accessor.h b/include/deal.II/dofs/dof_accessor.h index d103013ec8..e25e74412f 100644 --- a/include/deal.II/dofs/dof_accessor.h +++ b/include/deal.II/dofs/dof_accessor.h @@ -27,7 +27,6 @@ DEAL_II_NAMESPACE_OPEN template class FullMatrix; -template class SparseMatrix; template class Vector; class ConstraintMatrix; diff --git a/include/deal.II/dofs/dof_iterator_selector.h b/include/deal.II/dofs/dof_iterator_selector.h index f3a7ec3451..d5a8ef7e3d 100644 --- a/include/deal.II/dofs/dof_iterator_selector.h +++ b/include/deal.II/dofs/dof_iterator_selector.h @@ -31,7 +31,6 @@ template class TriaRawIterator; template class TriaIterator; template class TriaActiveIterator; template class Triangulation; -template class DoFHandler; namespace internal diff --git a/include/deal.II/fe/fe.h b/include/deal.II/fe/fe.h index 1ae29d7467..9e90def998 100644 --- a/include/deal.II/fe/fe.h +++ b/include/deal.II/fe/fe.h @@ -32,11 +32,6 @@ template class FEValues; template class FEFaceValues; template class FESubfaceValues; template class FESystem; -namespace hp -{ - template class FECollection; -} - /** * This is the base class for finite elements in arbitrary dimensions. It diff --git a/include/deal.II/fe/fe_abf.h b/include/deal.II/fe/fe_abf.h index 3df9ceb16f..0202f6767d 100644 --- a/include/deal.II/fe/fe_abf.h +++ b/include/deal.II/fe/fe_abf.h @@ -29,8 +29,6 @@ DEAL_II_NAMESPACE_OPEN -template class MappingQ; - /*!@addtogroup fe */ /*@{*/ diff --git a/include/deal.II/fe/fe_base.h b/include/deal.II/fe/fe_base.h index fe4f0e9025..471766078f 100644 --- a/include/deal.II/fe/fe_base.h +++ b/include/deal.II/fe/fe_base.h @@ -33,9 +33,6 @@ DEAL_II_NAMESPACE_OPEN -template class FESystem; - - /** * A namespace solely for the purpose of defining the Domination enum as well * as associated operators. diff --git a/include/deal.II/fe/fe_dg_vector.h b/include/deal.II/fe/fe_dg_vector.h index 0735e94073..c08df9df40 100644 --- a/include/deal.II/fe/fe_dg_vector.h +++ b/include/deal.II/fe/fe_dg_vector.h @@ -31,9 +31,6 @@ DEAL_II_NAMESPACE_OPEN -template class MappingQ; - - /** * DG elements based on vector valued polynomials. * diff --git a/include/deal.II/fe/fe_dgp.h b/include/deal.II/fe/fe_dgp.h index aa73c24e46..06de18714a 100644 --- a/include/deal.II/fe/fe_dgp.h +++ b/include/deal.II/fe/fe_dgp.h @@ -22,8 +22,6 @@ DEAL_II_NAMESPACE_OPEN -template class MappingQ; - /*!@addtogroup fe */ /*@{*/ diff --git a/include/deal.II/fe/fe_dgp_monomial.h b/include/deal.II/fe/fe_dgp_monomial.h index ccf7c518cc..893c3479d6 100644 --- a/include/deal.II/fe/fe_dgp_monomial.h +++ b/include/deal.II/fe/fe_dgp_monomial.h @@ -22,9 +22,6 @@ DEAL_II_NAMESPACE_OPEN -template class MappingQ; - - /*!@addtogroup fe */ /*@{*/ diff --git a/include/deal.II/fe/fe_dgp_nonparametric.h b/include/deal.II/fe/fe_dgp_nonparametric.h index a3e0caf6e3..1533e66ca5 100644 --- a/include/deal.II/fe/fe_dgp_nonparametric.h +++ b/include/deal.II/fe/fe_dgp_nonparametric.h @@ -23,10 +23,6 @@ DEAL_II_NAMESPACE_OPEN -template class PolynomialSpace; -template class MappingQ; - - /*!@addtogroup fe */ /*@{*/ diff --git a/include/deal.II/fe/fe_nedelec.h b/include/deal.II/fe/fe_nedelec.h index 4bee4f1ebc..a3a5fad5a4 100644 --- a/include/deal.II/fe/fe_nedelec.h +++ b/include/deal.II/fe/fe_nedelec.h @@ -31,9 +31,6 @@ DEAL_II_NAMESPACE_OPEN -template class MappingQ; - - /*!@addtogroup fe */ /*@{*/ diff --git a/include/deal.II/fe/fe_q_hierarchical.h b/include/deal.II/fe/fe_q_hierarchical.h index f3a78cc7be..02bab36c07 100644 --- a/include/deal.II/fe/fe_q_hierarchical.h +++ b/include/deal.II/fe/fe_q_hierarchical.h @@ -22,9 +22,6 @@ DEAL_II_NAMESPACE_OPEN -template class MappingQ; - - /*!@addtogroup fe */ /*@{*/ diff --git a/include/deal.II/fe/fe_raviart_thomas.h b/include/deal.II/fe/fe_raviart_thomas.h index 0ab401d81d..69d7eb8cbb 100644 --- a/include/deal.II/fe/fe_raviart_thomas.h +++ b/include/deal.II/fe/fe_raviart_thomas.h @@ -29,9 +29,6 @@ DEAL_II_NAMESPACE_OPEN -template class MappingQ; - - /*!@addtogroup fe */ /*@{*/ diff --git a/include/deal.II/fe/fe_tools.h b/include/deal.II/fe/fe_tools.h index b61a792d84..dab7a60736 100644 --- a/include/deal.II/fe/fe_tools.h +++ b/include/deal.II/fe/fe_tools.h @@ -32,14 +32,9 @@ DEAL_II_NAMESPACE_OPEN template class FullMatrix; -template class Vector; template class Quadrature; template class FiniteElement; template class DoFHandler; -namespace hp -{ - template class DoFHandler; -} template class FiniteElementData; class ConstraintMatrix; diff --git a/include/deal.II/fe/fe_values.h b/include/deal.II/fe/fe_values.h index f01219e4e4..f5eff081e7 100644 --- a/include/deal.II/fe/fe_values.h +++ b/include/deal.II/fe/fe_values.h @@ -48,13 +48,8 @@ DEAL_II_NAMESPACE_OPEN -template class Quadrature; template class FEValuesBase; -template class Vector; -template class BlockVector; - - namespace internal { /** diff --git a/include/deal.II/fe/mapping_q.h b/include/deal.II/fe/mapping_q.h index 6188a4e65f..7787f93fa9 100644 --- a/include/deal.II/fe/mapping_q.h +++ b/include/deal.II/fe/mapping_q.h @@ -22,9 +22,6 @@ DEAL_II_NAMESPACE_OPEN -template class TensorProductPolynomials; - - /*!@addtogroup mapping */ /*@{*/ diff --git a/include/deal.II/grid/grid_generator.h b/include/deal.II/grid/grid_generator.h index b1c9c7701d..a7395bba71 100644 --- a/include/deal.II/grid/grid_generator.h +++ b/include/deal.II/grid/grid_generator.h @@ -28,11 +28,6 @@ DEAL_II_NAMESPACE_OPEN -template class Triangulation; -template class Vector; -template class SparseMatrix; - - /** * This namespace provides a collection of functions for generating * triangulations for some basic geometries. diff --git a/include/deal.II/grid/grid_in.h b/include/deal.II/grid/grid_in.h index 14976f4fe1..198f029ddd 100644 --- a/include/deal.II/grid/grid_in.h +++ b/include/deal.II/grid/grid_in.h @@ -29,8 +29,6 @@ DEAL_II_NAMESPACE_OPEN template class Triangulation; template struct CellData; -struct SubCellData; - /** * This class implements an input mechanism for grid data. It allows to read a diff --git a/include/deal.II/grid/grid_refinement.h b/include/deal.II/grid/grid_refinement.h index 319e8bbc5f..94dcde8b8b 100644 --- a/include/deal.II/grid/grid_refinement.h +++ b/include/deal.II/grid/grid_refinement.h @@ -28,7 +28,6 @@ DEAL_II_NAMESPACE_OPEN // forward declarations template class Triangulation; -template class Vector; /** diff --git a/include/deal.II/grid/manifold.h b/include/deal.II/grid/manifold.h index 5e00cfd1d5..30c650b9f4 100644 --- a/include/deal.II/grid/manifold.h +++ b/include/deal.II/grid/manifold.h @@ -29,9 +29,6 @@ DEAL_II_NAMESPACE_OPEN -template class Triangulation; - - /** * We collect here some helper functions used in the Manifold * classes. diff --git a/include/deal.II/grid/tria.h b/include/deal.II/grid/tria.h index e0405a4934..2bc1a31244 100644 --- a/include/deal.II/grid/tria.h +++ b/include/deal.II/grid/tria.h @@ -75,7 +75,6 @@ namespace internal } } -template class DoFHandler; namespace hp { template class DoFHandler; diff --git a/include/deal.II/grid/tria_boundary.h b/include/deal.II/grid/tria_boundary.h index 127b3feb12..16cd34a611 100644 --- a/include/deal.II/grid/tria_boundary.h +++ b/include/deal.II/grid/tria_boundary.h @@ -29,10 +29,6 @@ DEAL_II_NAMESPACE_OPEN -template class Triangulation; - - - /** * This class is used to represent a boundary to a triangulation. When a * triangulation creates a new vertex on the boundary of the domain, it diff --git a/include/deal.II/grid/tria_iterator.h b/include/deal.II/grid/tria_iterator.h index 1286c7226b..2884bf92bf 100644 --- a/include/deal.II/grid/tria_iterator.h +++ b/include/deal.II/grid/tria_iterator.h @@ -35,7 +35,6 @@ DEAL_II_NAMESPACE_OPEN template class Triangulation; template class TriaAccessorBase; -template class TriaRawIterator; template class TriaIterator; template class TriaActiveIterator; diff --git a/include/deal.II/lac/block_sparsity_pattern.h b/include/deal.II/lac/block_sparsity_pattern.h index 14c04a5b01..662af1b73a 100644 --- a/include/deal.II/lac/block_sparsity_pattern.h +++ b/include/deal.II/lac/block_sparsity_pattern.h @@ -33,14 +33,7 @@ DEAL_II_NAMESPACE_OPEN template class BlockSparseMatrix; -class BlockSparsityPattern; class BlockDynamicSparsityPattern; -#ifdef DEAL_II_WITH_TRILINOS -namespace TrilinosWrappers -{ - class BlockSparsityPattern; -} -#endif /*! @addtogroup Sparsity *@{ diff --git a/include/deal.II/lac/block_vector.h b/include/deal.II/lac/block_vector.h index d4a47a683b..9f5aabdd17 100644 --- a/include/deal.II/lac/block_vector.h +++ b/include/deal.II/lac/block_vector.h @@ -31,7 +31,6 @@ DEAL_II_NAMESPACE_OPEN #ifdef DEAL_II_WITH_TRILINOS namespace TrilinosWrappers { - class Vector; class BlockVector; } #endif diff --git a/include/deal.II/lac/constraint_matrix.h b/include/deal.II/lac/constraint_matrix.h index e413a6b033..a9cef518b1 100644 --- a/include/deal.II/lac/constraint_matrix.h +++ b/include/deal.II/lac/constraint_matrix.h @@ -43,8 +43,6 @@ class BlockSparsityPattern; class BlockDynamicSparsityPattern; template class SparseMatrix; template class BlockSparseMatrix; -class BlockIndices; - namespace internals { diff --git a/include/deal.II/lac/dynamic_sparsity_pattern.h b/include/deal.II/lac/dynamic_sparsity_pattern.h index ee85de1820..86882de5b7 100644 --- a/include/deal.II/lac/dynamic_sparsity_pattern.h +++ b/include/deal.II/lac/dynamic_sparsity_pattern.h @@ -29,7 +29,6 @@ DEAL_II_NAMESPACE_OPEN -template class SparseMatrix; class DynamicSparsityPattern; diff --git a/include/deal.II/lac/filtered_matrix.h b/include/deal.II/lac/filtered_matrix.h index 289cfb9dfc..b01e150579 100644 --- a/include/deal.II/lac/filtered_matrix.h +++ b/include/deal.II/lac/filtered_matrix.h @@ -29,10 +29,8 @@ DEAL_II_NAMESPACE_OPEN -template class Vector; template class FilteredMatrixBlock; - /*! @addtogroup Matrix2 *@{ */ diff --git a/include/deal.II/lac/petsc_parallel_vector.h b/include/deal.II/lac/petsc_parallel_vector.h index 6b668464ec..dd9a324a61 100644 --- a/include/deal.II/lac/petsc_parallel_vector.h +++ b/include/deal.II/lac/petsc_parallel_vector.h @@ -30,12 +30,6 @@ DEAL_II_NAMESPACE_OPEN - -// forward declaration -template class Vector; -class IndexSet; - - /*! @addtogroup PETScWrappers *@{ */ diff --git a/include/deal.II/lac/precondition_block.h b/include/deal.II/lac/precondition_block.h index e66a9feb54..579f2df9f2 100644 --- a/include/deal.II/lac/precondition_block.h +++ b/include/deal.II/lac/precondition_block.h @@ -27,9 +27,6 @@ DEAL_II_NAMESPACE_OPEN -template -class PreconditionBlockJacobi; - /*! @addtogroup Preconditioners *@{ */ diff --git a/include/deal.II/lac/vector_space_vector.h b/include/deal.II/lac/vector_space_vector.h index ff306146d8..54f818fe9e 100644 --- a/include/deal.II/lac/vector_space_vector.h +++ b/include/deal.II/lac/vector_space_vector.h @@ -27,10 +27,6 @@ class IndexSet; namespace LinearAlgebra { - template - class ReadWriteVector; - - /*! @addtogroup Vectors *@{ */ diff --git a/include/deal.II/meshworker/local_results.h b/include/deal.II/meshworker/local_results.h index d9427c0d92..15b4b40336 100644 --- a/include/deal.II/meshworker/local_results.h +++ b/include/deal.II/meshworker/local_results.h @@ -27,8 +27,6 @@ DEAL_II_NAMESPACE_OPEN class BlockIndices; -template class DoFHandler; - /** * A collection of functions and classes for the mesh loops that are an diff --git a/include/deal.II/multigrid/mg_base.h b/include/deal.II/multigrid/mg_base.h index 04e10af897..24cf06546d 100644 --- a/include/deal.II/multigrid/mg_base.h +++ b/include/deal.II/multigrid/mg_base.h @@ -29,8 +29,6 @@ DEAL_II_NAMESPACE_OPEN -template class MGLevelObject; - /*!@addtogroup mg */ /*@{*/ diff --git a/include/deal.II/multigrid/mg_tools.h b/include/deal.II/multigrid/mg_tools.h index 63d1de5368..b7c148f74c 100644 --- a/include/deal.II/multigrid/mg_tools.h +++ b/include/deal.II/multigrid/mg_tools.h @@ -27,14 +27,7 @@ DEAL_II_NAMESPACE_OPEN -template class MGLevelObject; template class DoFHandler; -template class Vector; -template class SparseMatrix; -template class BlockVector; -template class BlockSparseMatrix; -template class FullMatrix; -template class BlockSparseMatrix; /* !@addtogroup mg */ /* @{ */ diff --git a/include/deal.II/numerics/data_out.h b/include/deal.II/numerics/data_out.h index e85bb7adf5..239ef110bb 100644 --- a/include/deal.II/numerics/data_out.h +++ b/include/deal.II/numerics/data_out.h @@ -25,8 +25,6 @@ DEAL_II_NAMESPACE_OPEN -template class FEValuesBase; - namespace internal { namespace DataOut diff --git a/include/deal.II/numerics/derivative_approximation.h b/include/deal.II/numerics/derivative_approximation.h index 5f232acd13..fab1b4f477 100644 --- a/include/deal.II/numerics/derivative_approximation.h +++ b/include/deal.II/numerics/derivative_approximation.h @@ -31,14 +31,6 @@ DEAL_II_NAMESPACE_OPEN -template class DoFHandler; -namespace hp -{ - template class DoFHandler; -} - - - /** * This namespace provides functions that compute a cell-wise approximation of * the norm of a derivative of a finite element field by taking difference diff --git a/include/deal.II/numerics/error_estimator.h b/include/deal.II/numerics/error_estimator.h index 2435f3ad5d..a65d103cd4 100644 --- a/include/deal.II/numerics/error_estimator.h +++ b/include/deal.II/numerics/error_estimator.h @@ -27,13 +27,11 @@ DEAL_II_NAMESPACE_OPEN -template class DoFHandler; template class Mapping; template class Quadrature; namespace hp { - template class DoFHandler; template class QCollection; } diff --git a/include/deal.II/numerics/matrix_tools.h b/include/deal.II/numerics/matrix_tools.h index 294b8f91f8..0d1161f2ae 100644 --- a/include/deal.II/numerics/matrix_tools.h +++ b/include/deal.II/numerics/matrix_tools.h @@ -46,7 +46,6 @@ template class BlockVector; template class Mapping; template class DoFHandler; -template class FEValues; namespace hp { diff --git a/include/deal.II/numerics/point_value_history.h b/include/deal.II/numerics/point_value_history.h index 2a75666075..32f1aa701c 100644 --- a/include/deal.II/numerics/point_value_history.h +++ b/include/deal.II/numerics/point_value_history.h @@ -42,16 +42,6 @@ DEAL_II_NAMESPACE_OPEN -namespace internal -{ - namespace PointValueHistory - { - template class PointGeometryData; - } -} - - - namespace internal { namespace PointValueHistory diff --git a/include/deal.II/numerics/vector_tools.h b/include/deal.II/numerics/vector_tools.h index e7dcca2b9b..9d752e47aa 100644 --- a/include/deal.II/numerics/vector_tools.h +++ b/include/deal.II/numerics/vector_tools.h @@ -43,7 +43,6 @@ template class InterGridMap; namespace hp { template class DoFHandler; - template class MappingCollection; template class QCollection; } class ConstraintMatrix; -- 2.39.5