* @ingroup simplex
*/
template <int dim>
- class PGauss : public QSimplex<dim>
+ class QGauss : public QSimplex<dim>
{
public:
/**
* Constructor taking the number of quadrature points @p n_points.
*/
- explicit PGauss(const unsigned int n_points);
+ explicit QGauss(const unsigned int n_points);
};
} // namespace Simplex
namespace Simplex
{
template <int dim>
- PGauss<dim>::PGauss(const unsigned int n_points)
+ QGauss<dim>::QGauss(const unsigned int n_points)
: QSimplex<dim>(Quadrature<dim>())
{
// fill quadrature points and quadrature weights
} // namespace Simplex
-template class Simplex::PGauss<1>;
-template class Simplex::PGauss<2>;
-template class Simplex::PGauss<3>;
+template class Simplex::QGauss<1>;
+template class Simplex::QGauss<2>;
+template class Simplex::QGauss<3>;
DEAL_II_NAMESPACE_CLOSE
{
initlog();
- test(Simplex::FE_P<2>(1), Simplex::PGauss<2>(3));
- test(Simplex::FE_P<2>(2), Simplex::PGauss<2>(7));
- test(Simplex::FE_P<3>(1), Simplex::PGauss<3>(4));
- test(Simplex::FE_P<3>(2), Simplex::PGauss<3>(10));
- test(Simplex::FE_DGP<2>(1), Simplex::PGauss<2>(3));
- test(Simplex::FE_DGP<2>(2), Simplex::PGauss<2>(7));
- test(Simplex::FE_DGP<3>(1), Simplex::PGauss<3>(4));
- test(Simplex::FE_DGP<3>(2), Simplex::PGauss<3>(10));
+ test(Simplex::FE_P<2>(1), Simplex::QGauss<2>(3));
+ test(Simplex::FE_P<2>(2), Simplex::QGauss<2>(7));
+ test(Simplex::FE_P<3>(1), Simplex::QGauss<3>(4));
+ test(Simplex::FE_P<3>(2), Simplex::QGauss<3>(10));
+ test(Simplex::FE_DGP<2>(1), Simplex::QGauss<2>(3));
+ test(Simplex::FE_DGP<2>(2), Simplex::QGauss<2>(7));
+ test(Simplex::FE_DGP<3>(1), Simplex::QGauss<3>(4));
+ test(Simplex::FE_DGP<3>(2), Simplex::QGauss<3>(10));
}
// 3) Select components
Simplex::FE_P<dim> fe(params.degree);
- Simplex::PGauss<dim> quad(dim == 2 ? (params.degree == 1 ? 3 : 7) :
+ Simplex::QGauss<dim> quad(dim == 2 ? (params.degree == 1 ? 3 : 7) :
(params.degree == 1 ? 4 : 10));
- Simplex::PGauss<dim - 1> face_quad(dim == 2 ? (params.degree == 1 ? 2 : 3) :
+ Simplex::QGauss<dim - 1> face_quad(dim == 2 ? (params.degree == 1 ? 2 : 3) :
(params.degree == 1 ? 3 : 7));
Simplex::FE_P<dim> fe_mapping(1);
false,
new Simplex::FE_DGP<dim>(degree),
new MappingFE<dim>(Simplex::FE_P<dim>(1)),
- new Simplex::PGauss<dim>(dim == 2 ? (degree == 1 ? 3 : 7) :
+ new Simplex::QGauss<dim>(dim == 2 ? (degree == 1 ? 3 : 7) :
(degree == 1 ? 4 : 10)),
- new Simplex::PGauss<dim - 1>(dim == 2 ? (degree == 1 ? 2 : 3) :
+ new Simplex::QGauss<dim - 1>(dim == 2 ? (degree == 1 ? 2 : 3) :
(degree == 1 ? 3 : 7)),
initial_refinement,
number_refinement);
// ---------------------------------------------------------------------
-// Test QProjection for Simplex::PGauss.
+// Test QProjection for Simplex::QGauss.
#include <deal.II/base/qprojector.h>
{
const int dim = 2;
- Simplex::PGauss<dim - 1> quad_ref(n_points);
+ Simplex::QGauss<dim - 1> quad_ref(n_points);
const auto quad =
QProjector<dim>::project_to_all_faces(ReferenceCell::Type::Tri, quad_ref);
{
const int dim = 3;
- Simplex::PGauss<dim - 1> quad_ref(n_points);
+ Simplex::QGauss<dim - 1> quad_ref(n_points);
const auto quad =
QProjector<dim>::project_to_all_faces(ReferenceCell::Type::Tet, quad_ref);
// ---------------------------------------------------------------------
-// Test Simplex::PGauss: output its quadrature points and weights.
+// Test Simplex::QGauss: output its quadrature points and weights.
#include <deal.II/simplex/quadrature_lib.h>
void
test(const unsigned int n_points)
{
- Simplex::PGauss<dim> quad(n_points);
+ Simplex::QGauss<dim> quad(n_points);
for (unsigned int q = 0; q < quad.size(); ++q)
{
QGauss<dim - 1> face_quad(degree + 1);
#else
- Simplex::PGauss<dim> quad(dim == 2 ? (degree == 1 ? 3 : 7) :
+ Simplex::QGauss<dim> quad(dim == 2 ? (degree == 1 ? 3 : 7) :
(degree == 1 ? 4 : 10));
- Simplex::PGauss<dim - 1> face_quad(dim == 2 ? (degree == 1 ? 2 : 3) :
+ Simplex::QGauss<dim - 1> face_quad(dim == 2 ? (degree == 1 ? 2 : 3) :
(degree == 1 ? 3 : 7));
#endif
: triangulation()
, fe(Simplex::FE_P<dim>(degree), dim)
, dof_handler(triangulation)
- , quadrature_formula(Simplex::PGauss<dim>(fe.degree == 1 ? 4 : 10))
+ , quadrature_formula(Simplex::QGauss<dim>(fe.degree == 1 ? 4 : 10))
, mapping(Simplex::FE_P<dim>(1))
, present_time(0.0)
, present_timestep(1.0)