* only.
*/
CutOffFunctionLinfty (const double radius = 1.,
- Point<dim> = Point<dim>(),
+ const Point<dim> = Point<dim>(),
const unsigned int n_components = 1,
const unsigned int select = no_component);
* component only.
*/
CutOffFunctionW1 (const double radius = 1.,
- Point<dim> = Point<dim>(),
+ const Point<dim> = Point<dim>(),
const unsigned int n_components = 1,
const unsigned int select = no_component);
* component only.
*/
CutOffFunctionCinfty (const double radius = 1.,
- Point<dim> = Point<dim>(),
+ const Point<dim> = Point<dim>(),
const unsigned int n_components = 1,
const unsigned int select = no_component);
/* -------------- declaration of explicit specializations ------------- */
-template <> QGauss<1>::QGauss (unsigned int n);
+template <> QGauss<1>::QGauss (const unsigned int n);
template <> QGauss2<1>::QGauss2 ();
template <> QGauss3<1>::QGauss3 ();
template <> QGauss4<1>::QGauss4 ();
CutOffFunctionLinfty<dim>::CutOffFunctionLinfty (const double r,
const Point<dim> p,
const unsigned int n_components,
- unsigned int select)
+ const unsigned int select)
:
Function<dim> (n_components),
center(p),
CutOffFunctionW1<dim>::CutOffFunctionW1 (const double r,
const Point<dim> p,
const unsigned int n_components,
- unsigned int select)
+ const unsigned int select)
:
Function<dim> (n_components),
center(p),
CutOffFunctionCinfty<dim>::CutOffFunctionCinfty (const double r,
const Point<dim> p,
const unsigned int n_components,
- unsigned int select)
+ const unsigned int select)
:
Function<dim> (n_components),
center(p),
# include <strstream>
#endif
+#ifdef HAVE_STD_NUMERIC_LIMITS
+# include <limits>
+#endif
+
namespace Patterns
{
// tensor product of lower dimensions
template <int dim>
-QGauss<dim>::QGauss (unsigned int n)
+QGauss<dim>::QGauss (const unsigned int n)
: Quadrature<dim> (QGauss<dim-1>(n), QGauss<1>(n))
{};
/**
* Constructor.
*/
- DX (bool write_faces = false,
- bool write_all_faces = false);
+ DX (const bool write_faces = false,
+ const bool write_all_faces = false);
};
/**
template <int dim>
bool
-FE_DGQ<dim>::has_support_on_face (unsigned int shape_index,
+FE_DGQ<dim>::has_support_on_face (const unsigned int shape_index,
const unsigned int face_index) const
{
template class BlockVector<double>;
template BlockVector<double>& BlockVector<double>::operator=(
const BlockVector<float>&);
-template void BlockVector<double>::reinit(const BlockVector<double>&, bool);
-template void BlockVector<double>::reinit(const BlockVector<float>&, bool);
-template void BlockVector<double>::equ(double, const BlockVector<double>&);
-template void BlockVector<double>::equ(double, const BlockVector<float>&);
+template void BlockVector<double>::reinit(const BlockVector<double>&, const bool);
+template void BlockVector<double>::reinit(const BlockVector<float>&, const bool);
+template void BlockVector<double>::equ(const double, const BlockVector<double>&);
+template void BlockVector<double>::equ(const double, const BlockVector<float>&);
template class BlockVector<float>;
template BlockVector<float>& BlockVector<float>::operator=(
const BlockVector<double>&);
-template void BlockVector<float>::reinit(const BlockVector<double>&, bool);
-template void BlockVector<float>::reinit(const BlockVector<float>&, bool);
-template void BlockVector<float>::equ(float, const BlockVector<double>&);
-template void BlockVector<float>::equ(float, const BlockVector<float>&);
+template void BlockVector<float>::reinit(const BlockVector<double>&, const bool);
+template void BlockVector<float>::reinit(const BlockVector<float>&, const bool);
+template void BlockVector<float>::equ(const float, const BlockVector<double>&);
+template void BlockVector<float>::equ(const float, const BlockVector<float>&);
namespace BlockVectorIterators
{
template Vector<double>& Vector<double>::operator=(const Vector<float>&);
template double Vector<double>::operator*(const Vector<float>&) const;
template double Vector<double>::operator*(const Vector<double>&) const;
-template void Vector<double>::reinit(const Vector<double>&, bool);
-template void Vector<double>::reinit(const Vector<float>&, bool);
-template void Vector<double>::equ(double, const Vector<double>&);
-template void Vector<double>::equ(double, const Vector<float>&);
+template void Vector<double>::reinit(const Vector<double>&, const bool);
+template void Vector<double>::reinit(const Vector<float>&, const bool);
+template void Vector<double>::equ(const double, const Vector<double>&);
+template void Vector<double>::equ(const double, const Vector<float>&);
template class Vector<float>;
template Vector<float>& Vector<float>::operator=(const Vector<double>&);
template float Vector<float>::operator*(const Vector<float>&) const;
template float Vector<float>::operator*(const Vector<double>&) const;
-template void Vector<float>::reinit(const Vector<double>&, bool);
-template void Vector<float>::reinit(const Vector<float>&, bool);
-template void Vector<float>::equ(float, const Vector<double>&);
-template void Vector<float>::equ(float, const Vector<float>&);
+template void Vector<float>::reinit(const Vector<double>&, const bool);
+template void Vector<float>::reinit(const Vector<float>&, const bool);
+template void Vector<float>::equ(const float, const Vector<double>&);
+template void Vector<float>::equ(const float, const Vector<float>&);
// see the .h file for why these functions are disabled.
// template Vector<float>::Vector (const Vector<double>& v);
template long double Vector<long double>::operator * (const Vector<long double> &) const;
template long double Vector<long double>::operator * (const Vector<double> &) const;
template long double Vector<long double>::operator * (const Vector<float> &) const;
-template void Vector<long double>::reinit(const Vector<long double>&, bool);
-template void Vector<long double>::reinit(const Vector<double>&, bool);
-template void Vector<long double>::reinit(const Vector<float>&, bool);
-template void Vector<long double>::equ(long double, const Vector<long double>&);
-template void Vector<long double>::equ(long double, const Vector<double>&);
-template void Vector<long double>::equ(long double, const Vector<float>&);
+template void Vector<long double>::reinit(const Vector<long double>&, const bool);
+template void Vector<long double>::reinit(const Vector<double>&, const bool);
+template void Vector<long double>::reinit(const Vector<float>&, const bool);
+template void Vector<long double>::equ(const long double, const Vector<long double>&);
+template void Vector<long double>::equ(const long double, const Vector<double>&);
+template void Vector<long double>::equ(const long double, const Vector<float>&);
template Vector<double>& Vector<double>::operator=(const Vector<long double>&);
template double Vector<double>::operator * (const Vector<long double> &) const;
-template void Vector<double>::reinit(const Vector<long double>&, bool);
-template void Vector<double>::equ(double, const Vector<long double>&);
+template void Vector<double>::reinit(const Vector<long double>&, const bool);
+template void Vector<double>::equ(const double, const Vector<long double>&);
template Vector<float>& Vector<float>::operator=(const Vector<long double>&);
template float Vector<float>::operator * (const Vector<long double> &) const;
-template void Vector<float>::reinit(const Vector<long double>&, bool);
-template void Vector<float>::equ(float, const Vector<long double>&);
+template void Vector<float>::reinit(const Vector<long double>&, const bool);
+template void Vector<float>::equ(const float, const Vector<long double>&);
// see the .h file for why these functions are disabled.
// template Vector<float>::Vector (const Vector<double>& v);