From 7dc7a6672934f2b32f6fa13f1471e1265af2cbd9 Mon Sep 17 00:00:00 2001 From: Reza Rastak Date: Mon, 6 Apr 2020 19:14:27 -0700 Subject: [PATCH] Fix some Doxygen warnings --- include/deal.II/base/discrete_time.h | 2 +- include/deal.II/base/quadrature_lib.h | 3 +- include/deal.II/base/tensor.h | 4 +-- include/deal.II/distributed/cell_weights.h | 6 ++-- include/deal.II/grid/grid_out.h | 19 +++++++++++ include/deal.II/hp/fe_values.h | 15 ++++----- include/deal.II/opencascade/manifold_lib.h | 4 +-- source/base/polynomial.cc | 2 ++ .../sd/symengine_number_types.cc | 20 ++++++------ source/distributed/cell_weights.cc | 3 +- source/grid/grid_out.cc | 8 ++--- source/hp/fe_values.cc | 32 +++++++++---------- source/lac/block_vector.cc | 4 ++- source/lac/chunk_sparsity_pattern.cc | 2 ++ 14 files changed, 74 insertions(+), 50 deletions(-) diff --git a/include/deal.II/base/discrete_time.h b/include/deal.II/base/discrete_time.h index e1b9ca7ada..409face8a2 100644 --- a/include/deal.II/base/discrete_time.h +++ b/include/deal.II/base/discrete_time.h @@ -35,7 +35,7 @@ DEAL_II_NAMESPACE_OPEN * { * // Insert simulation code here * } - * @code + * @endcode * * In the above example the time starts at $t = 0$. Assuming the time step * $dt = 0.3$ is not modified inside the loop, the time is advanced to diff --git a/include/deal.II/base/quadrature_lib.h b/include/deal.II/base/quadrature_lib.h index 03d71c2906..7679316c36 100644 --- a/include/deal.II/base/quadrature_lib.h +++ b/include/deal.II/base/quadrature_lib.h @@ -805,6 +805,7 @@ public: /* -------------- declaration of explicit specializations ------------- */ +#ifndef DOXYGEN template <> QGauss<1>::QGauss(const unsigned int n); template <> @@ -841,9 +842,9 @@ QGaussOneOverR<2>::QGaussOneOverR(const unsigned int n, template <> QTelles<1>::QTelles(const Quadrature<1> &base_quad, const Point<1> & singularity); +#endif // DOXYGEN DEAL_II_NAMESPACE_CLOSE - #endif diff --git a/include/deal.II/base/tensor.h b/include/deal.II/base/tensor.h index 3f1844d1f4..d938de5a68 100644 --- a/include/deal.II/base/tensor.h +++ b/include/deal.II/base/tensor.h @@ -1582,8 +1582,8 @@ Tensor::serialize(Archive &ar, const unsigned int) } -template -constexpr unsigned int Tensor::n_independent_components; +template +constexpr unsigned int Tensor::n_independent_components; /* ----------------- Non-member functions operating on tensors. ------------ */ diff --git a/include/deal.II/distributed/cell_weights.h b/include/deal.II/distributed/cell_weights.h index 4ccd92b51c..924d6fc7f1 100644 --- a/include/deal.II/distributed/cell_weights.h +++ b/include/deal.II/distributed/cell_weights.h @@ -109,8 +109,8 @@ namespace parallel * @param[in] weighting_function The function that determines each * cell's weight during load balancing. */ - CellWeights(const dealii::hp::DoFHandler &dof_handler, - const WeightingFunction &weighting_function); + CellWeights(const hp::DoFHandler &dof_handler, + const WeightingFunction & weighting_function); /** * Destructor. @@ -194,7 +194,7 @@ namespace parallel * determine each cell's finite element. */ DEAL_II_DEPRECATED - CellWeights(const dealii::hp::DoFHandler &dof_handler); + CellWeights(const hp::DoFHandler &dof_handler); /** * @copydoc CellWeights::constant_weighting() diff --git a/include/deal.II/grid/grid_out.h b/include/deal.II/grid/grid_out.h index 667cba0e90..22c8472c72 100644 --- a/include/deal.II/grid/grid_out.h +++ b/include/deal.II/grid/grid_out.h @@ -1685,6 +1685,11 @@ private: write_msh_lines(const Triangulation<1, 2> &tria, const unsigned int next_element_index, std::ostream & out) const; + + /** + * Declaration of the specialization of above function for 1d, 3sd. Does + * nothing. + */ unsigned int write_msh_lines(const Triangulation<1, 3> &tria, const unsigned int next_element_index, @@ -1804,6 +1809,10 @@ private: write_ucd_lines(const Triangulation<1, 2> &tria, const unsigned int next_element_index, std::ostream & out) const; + /** + * Declaration of the specialization of above function for 1d, 3sd. Does + * nothing. + */ unsigned int write_ucd_lines(const Triangulation<1, 3> &tria, const unsigned int next_element_index, @@ -1856,6 +1865,11 @@ private: */ unsigned int n_boundary_faces(const Triangulation<1, 2> &tria) const; + + /** + * Declaration of the specialization of above function for 1d, 3sd. Simply + * returns zero. + */ unsigned int n_boundary_faces(const Triangulation<1, 3> &tria) const; @@ -1888,6 +1902,11 @@ private: */ unsigned int n_boundary_lines(const Triangulation<1, 2> &tria) const; + + /** + * Declaration of the specialization of above function for 1d, 3sd. Simply + * returns zero. + */ unsigned int n_boundary_lines(const Triangulation<1, 3> &tria) const; diff --git a/include/deal.II/hp/fe_values.h b/include/deal.II/hp/fe_values.h index 2f08cc6f4b..44b56c85e7 100644 --- a/include/deal.II/hp/fe_values.h +++ b/include/deal.II/hp/fe_values.h @@ -242,11 +242,10 @@ namespace hp /** * Constructor. Initialize this object with the given parameters. */ - FEValues( - const dealii::hp::MappingCollection &mapping_collection, - const dealii::hp::FECollection & fe_collection, - const dealii::hp::QCollection & q_collection, - const UpdateFlags update_flags); + FEValues(const MappingCollection &mapping_collection, + const FECollection & fe_collection, + const QCollection & q_collection, + const UpdateFlags update_flags); /** @@ -254,9 +253,9 @@ namespace hp * that it makes the object use a $Q_1$ mapping (i.e., an object of type * MappingQGeneric(1)) implicitly. */ - FEValues(const hp::FECollection &fe_collection, - const hp::QCollection & q_collection, - const UpdateFlags update_flags); + FEValues(const FECollection &fe_collection, + const QCollection & q_collection, + const UpdateFlags update_flags); /** diff --git a/include/deal.II/opencascade/manifold_lib.h b/include/deal.II/opencascade/manifold_lib.h index 4b617a63ba..223964090f 100644 --- a/include/deal.II/opencascade/manifold_lib.h +++ b/include/deal.II/opencascade/manifold_lib.h @@ -360,8 +360,8 @@ namespace OpenCASCADE public: /** * The constructor takes an OpenCASCADE TopoDS_Face @p face and an optional - * @p tolerance. This class uses the interval OpenCASCADE variables @var u, - * @var v to describe the manifold. + * @p tolerance. This class uses the interval OpenCASCADE variables u, v + * to describe the manifold. */ NURBSPatchManifold(const TopoDS_Face &face, const double tolerance = 1e-7); diff --git a/source/base/polynomial.cc b/source/base/polynomial.cc index 1820829b2e..fde08725cb 100644 --- a/source/base/polynomial.cc +++ b/source/base/polynomial.cc @@ -1548,6 +1548,7 @@ namespace Polynomials // ------------------ explicit instantiations --------------- // +#ifndef DOXYGEN namespace Polynomials { template class Polynomial; @@ -1571,5 +1572,6 @@ namespace Polynomials template class Monomial; template class Monomial; } // namespace Polynomials +#endif // DOXYGEN DEAL_II_NAMESPACE_CLOSE diff --git a/source/differentiation/sd/symengine_number_types.cc b/source/differentiation/sd/symengine_number_types.cc index f4ff2f1206..051771555e 100644 --- a/source/differentiation/sd/symengine_number_types.cc +++ b/source/differentiation/sd/symengine_number_types.cc @@ -55,12 +55,12 @@ namespace Differentiation {} - Expression::Expression(const SE::integer_class &value) + Expression::Expression(const SymEngine::integer_class &value) : expression(value) {} - Expression::Expression(const SE::rational_class &value) + Expression::Expression(const SymEngine::rational_class &value) : expression(value) {} @@ -150,17 +150,17 @@ namespace Differentiation {} - Expression::Expression(const SE::Expression &rhs) + Expression::Expression(const SymEngine::Expression &rhs) : expression(rhs) {} - Expression::Expression(const SE::RCP &rhs) + Expression::Expression(const SymEngine::RCP &rhs) : expression(rhs) {} - Expression::Expression(SE::RCP &&rhs) + Expression::Expression(SymEngine::RCP &&rhs) : expression(rhs) {} @@ -241,14 +241,16 @@ namespace Differentiation Expression - Expression::differentiate(const SE::RCP &symbol) const + Expression::differentiate( + const SymEngine::RCP &symbol) const { return Expression(SE::diff(get_RCP(), symbol)); } Expression - Expression::differentiate(const SE::RCP &symbol) const + Expression::differentiate( + const SymEngine::RCP &symbol) const { // Potential symbol return Expression(SE::sdiff(get_RCP(), symbol)); @@ -265,13 +267,13 @@ namespace Differentiation /* ------------- Conversion operators ------------------------- */ - Expression::operator const SE::Expression &() const + Expression::operator const SymEngine::Expression &() const { return get_expression(); } - Expression::operator const SE::RCP &() const + Expression::operator const SymEngine::RCP &() const { return get_expression().get_basic(); } diff --git a/source/distributed/cell_weights.cc b/source/distributed/cell_weights.cc index c6c796695c..9b27ba16b2 100644 --- a/source/distributed/cell_weights.cc +++ b/source/distributed/cell_weights.cc @@ -27,8 +27,7 @@ namespace parallel template CellWeights::CellWeights( const hp::DoFHandler &dof_handler, - const typename CellWeights::WeightingFunction - &weighting_function) + const WeightingFunction & weighting_function) { reinit(dof_handler, weighting_function); } diff --git a/source/grid/grid_out.cc b/source/grid/grid_out.cc index 5532c7b8e3..e2f173a744 100644 --- a/source/grid/grid_out.cc +++ b/source/grid/grid_out.cc @@ -3516,13 +3516,13 @@ GridOut::write_mesh_per_processor_as_vtu( unsigned int -GridOut::n_boundary_faces(const Triangulation<1> &) const +GridOut::n_boundary_faces(const Triangulation<1, 1> &) const { return 0; } unsigned int -GridOut::n_boundary_lines(const Triangulation<1> &) const +GridOut::n_boundary_lines(const Triangulation<1, 1> &) const { return 0; } @@ -3669,7 +3669,7 @@ GridOut::write_msh_lines(const Triangulation<1, 3> &, unsigned int -GridOut::write_msh_lines(const Triangulation<2> &, +GridOut::write_msh_lines(const Triangulation<2, 2> &, const unsigned int next_element_index, std::ostream &) const { @@ -3830,7 +3830,7 @@ GridOut::write_ucd_lines(const Triangulation<1, 3> &, unsigned int -GridOut::write_ucd_lines(const Triangulation<2> &, +GridOut::write_ucd_lines(const Triangulation<2, 2> &, const unsigned int next_element_index, std::ostream &) const { diff --git a/source/hp/fe_values.cc b/source/hp/fe_values.cc index 1832bb4a2e..e980cbe931 100644 --- a/source/hp/fe_values.cc +++ b/source/hp/fe_values.cc @@ -25,12 +25,11 @@ namespace hp template FEValuesBase::FEValuesBase( - const dealii::hp::MappingCollection - &mapping_collection, - const dealii::hp::FECollection - & fe_collection, - const dealii::hp::QCollection &q_collection, - const UpdateFlags update_flags) + const MappingCollection + & mapping_collection, + const FECollection &fe_collection, + const QCollection & q_collection, + const UpdateFlags update_flags) : fe_collection(&fe_collection) , mapping_collection(&mapping_collection) , q_collection(q_collection) @@ -46,10 +45,9 @@ namespace hp template FEValuesBase::FEValuesBase( - const dealii::hp::FECollection - & fe_collection, - const dealii::hp::QCollection &q_collection, - const UpdateFlags update_flags) + const FECollection &fe_collection, + const QCollection & q_collection, + const UpdateFlags update_flags) : fe_collection(&fe_collection) , mapping_collection( &dealii::hp::StaticMappingQ1:: @@ -104,10 +102,10 @@ namespace hp template FEValues::FEValues( - const hp::MappingCollection &mapping, - const hp::FECollection & fe_collection, - const hp::QCollection & q_collection, - const UpdateFlags update_flags) + const MappingCollection &mapping, + const FECollection & fe_collection, + const QCollection & q_collection, + const UpdateFlags update_flags) : hp::FEValuesBase>(mapping, fe_collection, q_collection, @@ -117,9 +115,9 @@ namespace hp template FEValues::FEValues( - const hp::FECollection &fe_collection, - const hp::QCollection & q_collection, - const UpdateFlags update_flags) + const FECollection &fe_collection, + const QCollection & q_collection, + const UpdateFlags update_flags) : hp::FEValuesBase>(fe_collection, q_collection, update_flags) diff --git a/source/lac/block_vector.cc b/source/lac/block_vector.cc index 037f586a21..6ddf62f7c3 100644 --- a/source/lac/block_vector.cc +++ b/source/lac/block_vector.cc @@ -20,16 +20,18 @@ DEAL_II_NAMESPACE_OPEN #include "block_vector.inst" +#ifndef DOXYGEN // these functions can't be generated by the preprocessor since // the template arguments need to be different template BlockVector::BlockVector(const BlockVector &); template BlockVector::BlockVector(const BlockVector &); -#ifdef DEAL_II_WITH_COMPLEX_VALUES +# ifdef DEAL_II_WITH_COMPLEX_VALUES template BlockVector>::BlockVector( const BlockVector> &); template BlockVector>::BlockVector( const BlockVector> &); +# endif #endif DEAL_II_NAMESPACE_CLOSE diff --git a/source/lac/chunk_sparsity_pattern.cc b/source/lac/chunk_sparsity_pattern.cc index fd7fc16258..9f5cb6e7cc 100644 --- a/source/lac/chunk_sparsity_pattern.cc +++ b/source/lac/chunk_sparsity_pattern.cc @@ -592,6 +592,7 @@ ChunkSparsityPattern::memory_consumption() const +#ifndef DOXYGEN // explicit instantiations template void ChunkSparsityPattern::copy_from( @@ -616,5 +617,6 @@ ChunkSparsityPattern::copy_from(const FullMatrix &, template void ChunkSparsityPattern::copy_from(const FullMatrix &, const size_type); +#endif DEAL_II_NAMESPACE_CLOSE -- 2.39.5