16 #ifndef dealii__quadrature_lib_h 17 #define dealii__quadrature_lib_h 20 #include <deal.II/base/config.h> 21 #include <deal.II/base/quadrature.h> 23 DEAL_II_NAMESPACE_OPEN
46 QGauss (
const unsigned int n);
92 std::vector<long double>
95 const int beta)
const;
104 std::vector<long double>
107 const int beta)
const;
115 long double JacobiP(
const long double x,
118 const unsigned int n)
const;
124 static long double gamma(
const unsigned int n);
225 const bool revert=
false);
295 const double alpha = 1,
296 const bool factor_out_singular_weight=
false);
298 #ifdef DEAL_II_WITH_CXX11 376 const bool factor_out_singular_weight=
false);
412 const unsigned int vertex_index,
413 const bool factor_out_singular_weight=
false);
421 const unsigned int n);
452 const unsigned int b)
const;
555 static std::vector<double>
559 static std::vector<double>
603 #ifdef DEAL_II_WITH_CXX11 614 static std::vector<double>
618 static std::vector<double>
647 static std::vector<double>
651 static std::vector<double>
668 JacobiP(
const long double,
const int,
const int,
const unsigned int)
const;
688 DEAL_II_NAMESPACE_CLOSE
static long double gamma(const unsigned int n)
QGaussLog(const unsigned int n, const bool revert=false)
QGaussOneOverR(const unsigned int n, const Point< dim > singularity, const bool factor_out_singular_weight=false)
static std::vector< double > get_quadrature_weights(const unsigned int n)
Computes the weights of the quadrature formula.
static std::vector< double > get_quadrature_weights(const unsigned int n, EndPoint ep)
Computes the weights of the quadrature formula.
std::vector< long double > compute_quadrature_points(const unsigned int q, const int alpha, const int beta) const
QGaussChebyshev(const unsigned int n)
Generate a formula with n quadrature points.
static std::vector< double > get_quadrature_points(const unsigned int n)
QGauss(const unsigned int n)
static std::vector< double > get_quadrature_weights(const unsigned int n)
Computes the weights of the quadrature formula.
std::vector< long double > compute_quadrature_weights(const std::vector< long double > &x, const int alpha, const int beta) const
static std::vector< double > get_quadrature_weights(const unsigned int n)
QGaussRadauChebyshev(const unsigned int n, EndPoint ep=QGaussRadauChebyshev::left)
Generate a formula with n quadrature points.
bool compare_weights(const unsigned int a, const unsigned int b) const
static std::vector< double > get_quadrature_points(const unsigned int n)
Computes the points of the quadrature formula.
QGaussLobatto(const unsigned int n)
long double JacobiP(const long double x, const int alpha, const int beta, const unsigned int n) const
QTelles(const Quadrature< 1 > &base_quad, const Point< dim > &singularity)
static std::vector< double > get_quadrature_points(const unsigned int n, EndPoint ep)
Computes the points of the quadrature formula.
static std::vector< double > get_quadrature_points(const unsigned int n)
Computes the points of the quadrature formula.
QGaussLobattoChebyshev(const unsigned int n)
Generate a formula with n quadrature points.
QSorted(const Quadrature< dim > &quad)
QGaussLogR(const unsigned int n, const Point< dim > x0=Point< dim >(), const double alpha=1, const bool factor_out_singular_weight=false)
static unsigned int quad_size(const Point< dim > singularity, const unsigned int n)