]> https://gitweb.dealii.org/ - dealii.git/commitdiff
base/polynomials_bdm: rewrap comments and remove dead code
authorMatthias Maier <tamiko@43-1.org>
Tue, 7 Jun 2022 22:36:04 +0000 (17:36 -0500)
committerMatthias Maier <tamiko@43-1.org>
Tue, 7 Jun 2022 22:36:04 +0000 (17:36 -0500)
source/base/polynomials_bdm.cc

index 1302106c753ec1953f97decacf37ba4ddd277752..0fc44c86b09263cc2faa3a71610997da938b723a 100644 (file)
@@ -81,11 +81,8 @@ PolynomialsBDM<dim>::evaluate(
 
   const unsigned int n_sub = polynomial_space.n();
 
-  // guard access to the scratch
-  // arrays in the following block
-  // using a mutex to make sure they
-  // are not used by multiple threads
-  // at once
+  // guard access to the scratch arrays in the following block using a
+  // mutex to make sure they are not used by multiple threads at once
   {
     std::lock_guard<std::mutex> lock(mutex);
 
@@ -93,11 +90,8 @@ PolynomialsBDM<dim>::evaluate(
     p_grads.resize((grads.size() == 0) ? 0 : n_sub);
     p_grad_grads.resize((grad_grads.size() == 0) ? 0 : n_sub);
 
-    // Compute values of complete space
-    // and insert into tensors.  Result
-    // will have first all polynomials
-    // in the x-component, then y and
-    // z.
+    // Compute values of complete space and insert into tensors.  Result
+    // will have first all polynomials in the x-component, then y and z.
     polynomial_space.evaluate(unit_point,
                               p_values,
                               p_grads,
@@ -121,13 +115,10 @@ PolynomialsBDM<dim>::evaluate(
         grad_grads[i + j * n_sub][j] = p_grad_grads[i];
   }
 
-  // This is the first polynomial not
-  // covered by the P_k subspace
+  // This is the first polynomial not covered by the P_k subspace
   unsigned int start = dim * n_sub;
 
-  // Store values of auxiliary
-  // polynomials and their three
-  // derivatives
+  // Store values of auxiliary polynomials and their three derivatives
   std::vector<std::vector<double>> monovali(dim, std::vector<double>(4));
   std::vector<std::vector<double>> monovalk(dim, std::vector<double>(4));
 
@@ -175,16 +166,11 @@ PolynomialsBDM<dim>::evaluate(
     }
   else // dim == 3
     {
-      // The number of curls in each
-      // component. Note that the
-      // table in BrezziFortin91 has
-      // a typo, but the text has the
-      // right basis
-
-      // Note that the next basis
-      // function is always obtained
-      // from the previous by cyclic
-      // rotation of the coordinates
+      // The number of curls in each component. Note that the table in
+      // BrezziFortin91 has a typo, but the text has the right basis
+
+      // Note that the next basis function is always obtained from the
+      // previous by cyclic rotation of the coordinates
       const unsigned int n_curls = monomials.size() - 1;
       for (unsigned int i = 0; i < n_curls; ++i, start += dim)
         {
@@ -361,73 +347,6 @@ PolynomialsBDM<dim>::evaluate(
 }
 
 
-/*
-template <int dim>
-void
-PolynomialsBDM<dim>::compute_node_matrix (Table<2,double>& A) const
-{
-  std::vector<Polynomial<double> > moment_weight(2);
-  for (unsigned int i=0;i<moment_weight.size();++i)
-    moment_weight[i] = Monomial<double>(i);
-
-  QGauss<dim-1> qface(polynomial_space.degree()+1);
-
-  std::vector<Tensor<1,dim> > values(n());
-  std::vector<Tensor<2,dim> > grads;
-  std::vector<Tensor<3,dim> > grad_grads;
-  values.resize(n());
-
-  for (unsigned int face=0;face<2*dim;++face)
-    {
-      double orientation = 1.;
-      if ((face==0) || (face==3))
-        orientation = -1.;
-
-      for (unsigned int k=0;k<qface.size();++k)
-        {
-          const double w = qface.weight(k) * orientation;
-          const double x = qface.point(k)(0);
-          Point<dim> p;
-          switch (face)
-            {
-              case 2:
-                p(1) = 1.;
-              case 0:
-                p(0) = x;
-                break;
-              case 1:
-                p(0) = 1.;
-              case 3:
-                p(1) = x;
-                break;
-            }
-//      std::cerr << p
-//                << '\t' << moment_weight[0].value(x)
-//                << '\t' << moment_weight[1].value(x);
-
-          compute (p, values, grads, grad_grads);
-
-          for (unsigned int i=0;i<n();++i)
-            {
-//          std::cerr << '\t' << std::setw(6) << values[i][1-face%2];
-                                               // Integrate normal component.
-                                               // This is easy on the unit
-square for (unsigned int j=0;j<moment_weight.size();++j)
-                A(moment_weight.size()*face+j,i)
-                  += w * values[i][1-face%2] * moment_weight[j].value(x);
-            }
-//      std::cerr << std::endl;
-        }
-    }
-
-                                   // Volume integrals are missing
-                                   //
-                                   // This degree is one larger
-  Assert (polynomial_space.degree() <= 2,
-          ExcNotImplemented());
-}
-*/
-
 template <int dim>
 unsigned int
 PolynomialsBDM<dim>::n_polynomials(const unsigned int k)

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.