]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Rename QTrapez to QTrapezoid in the rest of deal.II.
authorWolfgang Bangerth <bangerth@colostate.edu>
Tue, 29 Sep 2020 01:35:56 +0000 (19:35 -0600)
committerWolfgang Bangerth <bangerth@colostate.edu>
Wed, 30 Sep 2020 13:03:09 +0000 (07:03 -0600)
14 files changed:
include/deal.II/base/data_out_base.h
include/deal.II/base/quadrature_selector.h
include/deal.II/fe/fe_q.h
include/deal.II/fe/fe_tools.templates.h
include/deal.II/numerics/data_out_dof_data.templates.h
source/base/quadrature_selector.cc
source/fe/fe_bernstein.cc
source/fe/fe_dgq.cc
source/fe/fe_q.cc
source/fe/fe_q_bubbles.cc
source/fe/fe_q_dg0.cc
source/fe/fe_q_iso_q1.cc
source/numerics/data_out_stack.cc
source/numerics/error_estimator_1d.cc

index db588abba1e3881c5c67ee8e397002051bb5b0e8..9e6b93b568673ca7819b213c3444aeec11d3959b 100644 (file)
@@ -296,7 +296,7 @@ namespace DataOutBase
      * output point <tt>j</tt>, where <tt>j</tt> denotes the usual
      * lexicographic ordering in deal.II. This is also the order of points as
      * provided by the <tt>QIterated</tt> class when used with the
-     * <tt>QTrapez</tt> class as subquadrature.
+     * <tt>QTrapezoid</tt> class as subquadrature.
      *
      * Since the number of data vectors is usually the same for all patches to
      * be printed, <tt>data.size()</tt> should yield the same value for all
index 21fdf50893a1a18300039e405c9f7b0951d45e7e..56d23032e48fb422e8efbbd4f94d4bbf1e631584 100644 (file)
@@ -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).
index b9cc62968411365cbdf57563bc90b16c3653d352..34ebe53e6c1f9b1db5ded1854f7142bb1f9860e5 100644 (file)
@@ -563,7 +563,7 @@ public:
    * <tt>FE_Q<dim>(QGaussLobatto<1>(fe_degree+1))</tt> is equivalent to the
    * constructor that specifies the polynomial degree only. For selecting
    * equidistant nodes at <tt>fe_degree > 2</tt>, construct
-   * <tt>FE_Q<dim>(QIterated<1>(QTrapez<1>(),fe_degree))</tt>.
+   * <tt>FE_Q<dim>(QIterated<1>(QTrapezoid<1>(),fe_degree))</tt>.
    */
   FE_Q(const Quadrature<1> &points);
 
index cf8ac7d1534abc37bd32927d56a0e8f87aa4cf5e..e5812d22d046ff6dcfca493dbbb8582d707331aa 100644 (file)
@@ -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<int, unsigned int> tmp =
                       Utilities::get_integer_at_position(name, 0);
@@ -2637,7 +2637,7 @@ namespace FETools
                     const FETools::FEFactoryBase<dim, spacedim> *fef =
                       dynamic_cast<
                         const FETools::FEFactoryBase<dim, spacedim> *>(ptr);
-                    return fef->get(QIterated<1>(QTrapez<1>(), tmp.first));
+                    return fef->get(QIterated<1>(QTrapezoid<1>(), tmp.first));
                   }
                 else
                   {
index a477639ea07fbb5f1858aca35a4b52cc9c8fb942..19332c8938f9e340d98d18ec234131e25ead0327 100644 (file)
@@ -140,7 +140,7 @@ namespace internal
           if (do_hex)
             {
               quadrature2.reset(new Quadrature<dim>(
-                QIterated<dim>(QTrapez<1>(), n_subdivisions)));
+                QIterated<dim>(QTrapezoid<1>(), n_subdivisions)));
             }
 
           n_q_points = std::max(do_simplex ? quadrature1->size() : 0,
@@ -183,7 +183,7 @@ namespace internal
       else
         {
           dealii::hp::QCollection<dim - 1> quadrature(
-            QIterated<dim - 1>(QTrapez<1>(), n_subdivisions));
+            QIterated<dim - 1>(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<dim>(
-                QIterated<dim>(QTrapez<1>(), n_subdivisions)));
+                QIterated<dim>(QTrapezoid<1>(), n_subdivisions)));
             }
 
           x_fe_values.resize(this->finite_elements.size());
@@ -320,7 +320,7 @@ namespace internal
       else
         {
           dealii::hp::QCollection<dim - 1> quadrature(
-            QIterated<dim - 1>(QTrapez<1>(), n_subdivisions));
+            QIterated<dim - 1>(QTrapezoid<1>(), n_subdivisions));
           x_fe_face_values.resize(this->finite_elements.size());
           for (unsigned int i = 0; i < this->finite_elements.size(); ++i)
             {
index be892d3e7b809eba32c89d04eeeaa6ad012d8aef..42696bdd01da48ac81ad8799b6f5134289d233e3 100644 (file)
@@ -45,7 +45,7 @@ QuadratureSelector<dim>::create_quadrature(const std::string &s,
       else if (s == "simpson")
         return QSimpson<dim>();
       else if (s == "trapez")
-        return QTrapez<dim>();
+        return QTrapezoid<dim>();
       else if (s == "weddle")
         return QWeddle<dim>();
     }
index 86525d86593b82bf5ea8112ad7a9fe25dc1f4a41..07e2aa9db99565f20202604d16da1a95444939b3 100644 (file)
@@ -139,7 +139,7 @@ FE_Bernstein<dim, spacedim>::get_subface_interpolation_matrix(
                                 spacedim>::ExcInterpolationNotImplemented()));
 
       const Quadrature<dim - 1> quad_face_support(
-        FE_Q<dim, spacedim>(QIterated<1>(QTrapez<1>(), source_fe->degree))
+        FE_Q<dim, spacedim>(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
index 6d1297c8433a4629cf3d2ea3c957ff8adfb4d7bd..d5ff7a977a3e9e5d5cafa14bc9822fded5724882 100644 (file)
@@ -863,7 +863,7 @@ FE_DGQArbitraryNodes<dim, spacedim>::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 << ")";
index 87fe157b6763f79061b5ad8307ce969800178157..b851a3e5a7721164b534b12bb89d1960797c0efa 100644 (file)
@@ -118,7 +118,7 @@ FE_Q<dim, spacedim>::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 << ")";
index ce1b950f1478bd90578702d6c29c797eaf9affb8..3e06400cdfcc76337bd006e5dfb0458fca01be5b 100644 (file)
@@ -315,7 +315,7 @@ FE_Q_Bubbles<dim, spacedim>::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 << ")";
index e85acf4dc51ff03d0556ef0994374b686b8d24ca..647f841f4f462e7bdae8f5effd2b23c0e92bf25b 100644 (file)
@@ -140,7 +140,7 @@ FE_Q_DG0<dim, spacedim>::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 << ")";
index 27a01ea3ceab2b0d5c2f718be45428f0ce0ea435..23b99d0fe81dc88eae29453e1d0ed3eb85b08e27 100644 (file)
@@ -50,8 +50,8 @@ FE_Q_iso_Q1<dim, spacedim>::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());
 }
index b789fc681fb71fa5d8d97ac57173a6540ca6ce51..68389f23eb87f4e0646f4ebeb7b9e8bf8ab105dc 100644 (file)
@@ -289,7 +289,7 @@ DataOutStack<dim, spacedim, DoFHandlerType>::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<dim> patch_points(q_trapez, n_subdivisions);
 
   // create collection objects from
index 911cdd2af2e171e61151b69a88ebe5e0145d3a54..5a098cc9f664bc5cf6a717905fbb42acea9b0aec 100644 (file)
@@ -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);

In the beginning the Universe was created. This has made a lot of people very angry and has been widely regarded as a bad move.

Douglas Adams


Typeset in Trocchi and Trocchi Bold Sans Serif.