using predicate_function = std::function<bool(
const typename Triangulation<dim, spacedim>::cell_iterator &)>;
+#ifndef DOXYGEN
namespace internal
{
/**
&fe_enriched, // FE multiplied by enrichment function
const FE_Nothing<dim, spacedim> &fe_nothing,
hp::FECollection<dim, spacedim> &fe_collection);
- } // namespace internal
+ } // namespace internal
+#endif // DOXYGEN
DEAL_II_NAMESPACE_OPEN
-
+#ifndef DOXYGEN
namespace internal
{
//
} // namespace internal
+#endif
DEAL_II_NAMESPACE_CLOSE
const MPI_Comm &,
const ArrayView<S> &);
+#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
const ArrayView<const S> &,
const MPI_Comm &,
const ArrayView<S> &);
+#endif
}
}
-
+#ifndef DOXYGEN
template <>
Quadrature<1>::Quadrature(const Point<1> &point)
: quadrature_points(std::vector<Point<1>>(1, point))
{
Assert(false, ExcImpossibleInDim(0));
}
+#endif // DOXYGEN
}
-
+#ifndef DOXYGEN
template <>
Quadrature<1>::Quadrature(const SubQuadrature &, const Quadrature<1> &q2)
: quadrature_points(q2.size())
++present_index;
}
-#ifdef DEBUG
+# ifdef DEBUG
if (size() > 0)
{
double sum = 0;
// near that.
Assert((sum > 0.999999) && (sum < 1.000001), ExcInternalError());
}
-#endif
+# endif
}
// copy constructor in 1d...
Assert(false, ExcImpossibleInDim(1));
}
+#endif // DOXYGEN
}
-
+#ifndef DOXYGEN
template <>
std::array<Quadrature<1>, 1>
Quadrature<1>::get_tensor_basis() const
return std::array<Quadrature<1>, 1>{{*this}};
}
+#endif
} // namespace internal
-
+#ifndef DOXYGEN
template <>
QGaussLobatto<1>::QGaussLobatto(const unsigned int n)
: Quadrature<1>(n)
this->weights[i] = 0.5 * w[i];
}
}
-
+#endif
template <>
}
-
+#ifndef DOXYGEN
// explicit instantiations for float
template void
Histogram::evaluate<float>(const std::vector<Vector<float>> &values,
Histogram::evaluate<double>(const Vector<double> &values,
const unsigned int n_intervals,
const IntervalSpacing interval_spacing);
+#endif
DEAL_II_NAMESPACE_CLOSE