From: Wolfgang Bangerth Date: Tue, 29 Sep 2020 01:35:56 +0000 (-0600) Subject: Rename QTrapez to QTrapezoid in the rest of deal.II. X-Git-Tag: v9.3.0-rc1~1053^2~6 X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=7532199328973d6ab8731e025ac2b47fbf2b9aad;p=dealii.git Rename QTrapez to QTrapezoid in the rest of deal.II. --- diff --git a/include/deal.II/base/data_out_base.h b/include/deal.II/base/data_out_base.h index db588abba1..9e6b93b568 100644 --- a/include/deal.II/base/data_out_base.h +++ b/include/deal.II/base/data_out_base.h @@ -296,7 +296,7 @@ namespace DataOutBase * output point j, where j denotes the usual * lexicographic ordering in deal.II. This is also the order of points as * provided by the QIterated class when used with the - * QTrapez class as subquadrature. + * QTrapezoid class as subquadrature. * * Since the number of data vectors is usually the same for all patches to * be printed, data.size() should yield the same value for all diff --git a/include/deal.II/base/quadrature_selector.h b/include/deal.II/base/quadrature_selector.h index 21fdf50893..56d23032e4 100644 --- a/include/deal.II/base/quadrature_selector.h +++ b/include/deal.II/base/quadrature_selector.h @@ -30,7 +30,7 @@ DEAL_II_NAMESPACE_OPEN /** * This class implements the quadrature rule passed to its constructor as a * string. Supported quadratures are QGauss (of all orders), QMidpoint, - * QMilne, QSimpson, QTrapez and QWeddle. + * QMilne, QSimpson, QTrapezoid and QWeddle. * * This class is useful if you want to use flexible quadrature rules, that are * read from a parameter file (see ParameterHandler for this). diff --git a/include/deal.II/fe/fe_q.h b/include/deal.II/fe/fe_q.h index b9cc629684..34ebe53e6c 100644 --- a/include/deal.II/fe/fe_q.h +++ b/include/deal.II/fe/fe_q.h @@ -563,7 +563,7 @@ public: * FE_Q(QGaussLobatto<1>(fe_degree+1)) is equivalent to the * constructor that specifies the polynomial degree only. For selecting * equidistant nodes at fe_degree > 2, construct - * FE_Q(QIterated<1>(QTrapez<1>(),fe_degree)). + * FE_Q(QIterated<1>(QTrapezoid<1>(),fe_degree)). */ FE_Q(const Quadrature<1> &points); diff --git a/include/deal.II/fe/fe_tools.templates.h b/include/deal.II/fe/fe_tools.templates.h index cf8ac7d153..e5812d22d0 100644 --- a/include/deal.II/fe/fe_tools.templates.h +++ b/include/deal.II/fe/fe_tools.templates.h @@ -2622,11 +2622,11 @@ namespace FETools // find sub-quadrature position = name.find('('); const std::string subquadrature_name(name, 0, position); - AssertThrow(subquadrature_name.compare("QTrapez") == 0, + AssertThrow(subquadrature_name.compare("QTrapezoid") == 0, ExcNotImplemented( "Could not detect quadrature of name " + subquadrature_name)); - // delete "QTrapez()," + // delete "QTrapezoid()," name.erase(0, position + 3); const std::pair tmp = Utilities::get_integer_at_position(name, 0); @@ -2637,7 +2637,7 @@ namespace FETools const FETools::FEFactoryBase *fef = dynamic_cast< const FETools::FEFactoryBase *>(ptr); - return fef->get(QIterated<1>(QTrapez<1>(), tmp.first)); + return fef->get(QIterated<1>(QTrapezoid<1>(), tmp.first)); } else { diff --git a/include/deal.II/numerics/data_out_dof_data.templates.h b/include/deal.II/numerics/data_out_dof_data.templates.h index a477639ea0..19332c8938 100644 --- a/include/deal.II/numerics/data_out_dof_data.templates.h +++ b/include/deal.II/numerics/data_out_dof_data.templates.h @@ -140,7 +140,7 @@ namespace internal if (do_hex) { quadrature2.reset(new Quadrature( - QIterated(QTrapez<1>(), n_subdivisions))); + QIterated(QTrapezoid<1>(), n_subdivisions))); } n_q_points = std::max(do_simplex ? quadrature1->size() : 0, @@ -183,7 +183,7 @@ namespace internal else { dealii::hp::QCollection quadrature( - QIterated(QTrapez<1>(), n_subdivisions)); + QIterated(QTrapezoid<1>(), n_subdivisions)); n_q_points = quadrature[0].size(); x_fe_face_values.resize(this->finite_elements.size()); for (unsigned int i = 0; i < this->finite_elements.size(); ++i) @@ -279,7 +279,7 @@ namespace internal if (do_hex) { quadrature2.reset(new Quadrature( - QIterated(QTrapez<1>(), n_subdivisions))); + QIterated(QTrapezoid<1>(), n_subdivisions))); } x_fe_values.resize(this->finite_elements.size()); @@ -320,7 +320,7 @@ namespace internal else { dealii::hp::QCollection quadrature( - QIterated(QTrapez<1>(), n_subdivisions)); + QIterated(QTrapezoid<1>(), n_subdivisions)); x_fe_face_values.resize(this->finite_elements.size()); for (unsigned int i = 0; i < this->finite_elements.size(); ++i) { diff --git a/source/base/quadrature_selector.cc b/source/base/quadrature_selector.cc index be892d3e7b..42696bdd01 100644 --- a/source/base/quadrature_selector.cc +++ b/source/base/quadrature_selector.cc @@ -45,7 +45,7 @@ QuadratureSelector::create_quadrature(const std::string &s, else if (s == "simpson") return QSimpson(); else if (s == "trapez") - return QTrapez(); + return QTrapezoid(); else if (s == "weddle") return QWeddle(); } diff --git a/source/fe/fe_bernstein.cc b/source/fe/fe_bernstein.cc index 86525d8659..07e2aa9db9 100644 --- a/source/fe/fe_bernstein.cc +++ b/source/fe/fe_bernstein.cc @@ -139,7 +139,7 @@ FE_Bernstein::get_subface_interpolation_matrix( spacedim>::ExcInterpolationNotImplemented())); const Quadrature quad_face_support( - FE_Q(QIterated<1>(QTrapez<1>(), source_fe->degree)) + FE_Q(QIterated<1>(QTrapezoid<1>(), source_fe->degree)) .get_unit_face_support_points(face_no)); // Rule of thumb for FP accuracy, that can be expected for a given diff --git a/source/fe/fe_dgq.cc b/source/fe/fe_dgq.cc index 6d1297c843..d5ff7a977a 100644 --- a/source/fe/fe_dgq.cc +++ b/source/fe/fe_dgq.cc @@ -863,7 +863,7 @@ FE_DGQArbitraryNodes::get_name() const if (this->degree > 2) namebuf << "FE_DGQArbitraryNodes<" << Utilities::dim_string(dim, spacedim) - << ">(QIterated(QTrapez()," << this->degree << "))"; + << ">(QIterated(QTrapezoid()," << this->degree << "))"; else namebuf << "FE_DGQ<" << Utilities::dim_string(dim, spacedim) << ">(" << this->degree << ")"; diff --git a/source/fe/fe_q.cc b/source/fe/fe_q.cc index 87fe157b67..b851a3e5a7 100644 --- a/source/fe/fe_q.cc +++ b/source/fe/fe_q.cc @@ -118,7 +118,7 @@ FE_Q::get_name() const { if (this->degree > 2) namebuf << "FE_Q<" << Utilities::dim_string(dim, spacedim) - << ">(QIterated(QTrapez()," << this->degree << "))"; + << ">(QIterated(QTrapezoid()," << this->degree << "))"; else namebuf << "FE_Q<" << Utilities::dim_string(dim, spacedim) << ">(" << this->degree << ")"; diff --git a/source/fe/fe_q_bubbles.cc b/source/fe/fe_q_bubbles.cc index ce1b950f14..3e06400cdf 100644 --- a/source/fe/fe_q_bubbles.cc +++ b/source/fe/fe_q_bubbles.cc @@ -315,7 +315,7 @@ FE_Q_Bubbles::get_name() const { if (this->degree > 3) namebuf << "FE_Q_Bubbles<" << Utilities::dim_string(dim, spacedim) - << ">(QIterated(QTrapez()," << this->degree - 1 << "))"; + << ">(QIterated(QTrapezoid()," << this->degree - 1 << "))"; else namebuf << "FE_Q_Bubbles<" << Utilities::dim_string(dim, spacedim) << ">(" << this->degree - 1 << ")"; diff --git a/source/fe/fe_q_dg0.cc b/source/fe/fe_q_dg0.cc index e85acf4dc5..647f841f4f 100644 --- a/source/fe/fe_q_dg0.cc +++ b/source/fe/fe_q_dg0.cc @@ -140,7 +140,7 @@ FE_Q_DG0::get_name() const { if (this->degree > 2) namebuf << "FE_Q_DG0<" << Utilities::dim_string(dim, spacedim) - << ">(QIterated(QTrapez()," << this->degree << "))"; + << ">(QIterated(QTrapezoid()," << this->degree << "))"; else namebuf << "FE_Q_DG0<" << Utilities::dim_string(dim, spacedim) << ">(" << this->degree << ")"; diff --git a/source/fe/fe_q_iso_q1.cc b/source/fe/fe_q_iso_q1.cc index 27a01ea3ce..23b99d0fe8 100644 --- a/source/fe/fe_q_iso_q1.cc +++ b/source/fe/fe_q_iso_q1.cc @@ -50,8 +50,8 @@ FE_Q_iso_Q1::FE_Q_iso_Q1(const unsigned int subdivisions) ExcMessage("This element can only be used with a positive number of " "subelements")); - QTrapez<1> trapez; - QIterated<1> points(trapez, subdivisions); + QTrapezoid<1> trapez; + QIterated<1> points(trapez, subdivisions); this->initialize(points.get_points()); } diff --git a/source/numerics/data_out_stack.cc b/source/numerics/data_out_stack.cc index b789fc681f..68389f23eb 100644 --- a/source/numerics/data_out_stack.cc +++ b/source/numerics/data_out_stack.cc @@ -289,7 +289,7 @@ DataOutStack::build_patches( // patch, and an object that // extracts the data on each // cell to these points - QTrapez<1> q_trapez; + QTrapezoid<1> q_trapez; QIterated patch_points(q_trapez, n_subdivisions); // create collection objects from diff --git a/source/numerics/error_estimator_1d.cc b/source/numerics/error_estimator_1d.cc index 911cdd2af2..5a098cc9f6 100644 --- a/source/numerics/error_estimator_1d.cc +++ b/source/numerics/error_estimator_1d.cc @@ -415,7 +415,7 @@ KellyErrorEstimator<1, spacedim>::estimate( for (unsigned int c = 0; c < n_components; ++c) coefficient_values(c) = 1; - const QTrapez<1> quadrature; + const QTrapezoid<1> quadrature; const hp::QCollection<1> q_collection(quadrature); const QGauss<0> face_quadrature(1); const hp::QCollection<0> q_face_collection(face_quadrature);