From: Daniel Arndt Date: Sun, 12 Apr 2020 23:44:59 +0000 (-0400) Subject: Hide internal functions and specializations X-Git-Tag: v9.2.0-rc1~207^2~14 X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=ebc20070a2114a88cbb82ee3857de551e8b5674f;p=dealii.git Hide internal functions and specializations --- diff --git a/include/deal.II/fe/fe_enriched.h b/include/deal.II/fe/fe_enriched.h index 0737d05002..748f42fa86 100644 --- a/include/deal.II/fe/fe_enriched.h +++ b/include/deal.II/fe/fe_enriched.h @@ -735,6 +735,7 @@ namespace ColorEnriched using predicate_function = std::function::cell_iterator &)>; +#ifndef DOXYGEN namespace internal { /** @@ -922,7 +923,8 @@ namespace ColorEnriched &fe_enriched, // FE multiplied by enrichment function const FE_Nothing &fe_nothing, hp::FECollection &fe_collection); - } // namespace internal + } // namespace internal +#endif // DOXYGEN diff --git a/include/deal.II/matrix_free/type_traits.h b/include/deal.II/matrix_free/type_traits.h index 70d784d954..c9a55d25f5 100644 --- a/include/deal.II/matrix_free/type_traits.h +++ b/include/deal.II/matrix_free/type_traits.h @@ -28,7 +28,7 @@ DEAL_II_NAMESPACE_OPEN - +#ifndef DOXYGEN namespace internal { // @@ -322,6 +322,7 @@ namespace internal } // namespace internal +#endif DEAL_II_NAMESPACE_CLOSE diff --git a/source/base/mpi.inst.in b/source/base/mpi.inst.in index 73572aea05..633c44b057 100644 --- a/source/base/mpi.inst.in +++ b/source/base/mpi.inst.in @@ -65,6 +65,7 @@ for (S : MPI_SCALARS) const MPI_Comm &, const ArrayView &); +#ifndef DOXYGEN // The fixed-length array (i.e., things declared like T(&values)[N]) // versions of the functions above live in the header file mpi.h since the // length (N) is a compile-time constant. Those functions all call @@ -84,6 +85,7 @@ for (S : MPI_SCALARS) const ArrayView &, const MPI_Comm &, const ArrayView &); +#endif } diff --git a/source/base/quadrature.cc b/source/base/quadrature.cc index 2560832e71..389f4a29c8 100644 --- a/source/base/quadrature.cc +++ b/source/base/quadrature.cc @@ -97,7 +97,7 @@ Quadrature::Quadrature(const Point &point) } - +#ifndef DOXYGEN template <> Quadrature<1>::Quadrature(const Point<1> &point) : quadrature_points(std::vector>(1, point)) @@ -112,6 +112,7 @@ Quadrature<0>::Quadrature(const SubQuadrature &, const Quadrature<1> &) { Assert(false, ExcImpossibleInDim(0)); } +#endif // DOXYGEN @@ -160,7 +161,7 @@ Quadrature::Quadrature(const SubQuadrature &q1, const Quadrature<1> &q2) } - +#ifndef DOXYGEN template <> Quadrature<1>::Quadrature(const SubQuadrature &, const Quadrature<1> &q2) : quadrature_points(q2.size()) @@ -180,7 +181,7 @@ Quadrature<1>::Quadrature(const SubQuadrature &, const Quadrature<1> &q2) ++present_index; } -#ifdef DEBUG +# ifdef DEBUG if (size() > 0) { double sum = 0; @@ -191,7 +192,7 @@ Quadrature<1>::Quadrature(const SubQuadrature &, const Quadrature<1> &q2) // near that. Assert((sum > 0.999999) && (sum < 1.000001), ExcInternalError()); } -#endif +# endif } @@ -215,6 +216,7 @@ Quadrature<1>::Quadrature(const Quadrature<0> &) // copy constructor in 1d... Assert(false, ExcImpossibleInDim(1)); } +#endif // DOXYGEN @@ -324,7 +326,7 @@ Quadrature::get_tensor_basis() const } - +#ifndef DOXYGEN template <> std::array, 1> Quadrature<1>::get_tensor_basis() const @@ -335,6 +337,7 @@ Quadrature<1>::get_tensor_basis() const return std::array, 1>{{*this}}; } +#endif diff --git a/source/base/quadrature_lib.cc b/source/base/quadrature_lib.cc index 875f519e65..680486bb08 100644 --- a/source/base/quadrature_lib.cc +++ b/source/base/quadrature_lib.cc @@ -136,7 +136,7 @@ namespace internal } // namespace internal - +#ifndef DOXYGEN template <> QGaussLobatto<1>::QGaussLobatto(const unsigned int n) : Quadrature<1>(n) @@ -157,7 +157,7 @@ QGaussLobatto<1>::QGaussLobatto(const unsigned int n) this->weights[i] = 0.5 * w[i]; } } - +#endif template <> diff --git a/source/numerics/histogram.cc b/source/numerics/histogram.cc index 4ee42cb262..ffe1696993 100644 --- a/source/numerics/histogram.cc +++ b/source/numerics/histogram.cc @@ -308,7 +308,7 @@ Histogram::memory_consumption() const } - +#ifndef DOXYGEN // explicit instantiations for float template void Histogram::evaluate(const std::vector> &values, @@ -331,5 +331,6 @@ template void Histogram::evaluate(const Vector &values, const unsigned int n_intervals, const IntervalSpacing interval_spacing); +#endif DEAL_II_NAMESPACE_CLOSE