]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Fix unused-but-set-variable warnings 12590/head
authorBruno Turcksin <bruno.turcksin@gmail.com>
Wed, 21 Jul 2021 16:04:03 +0000 (16:04 +0000)
committerBruno Turcksin <bruno.turcksin@gmail.com>
Wed, 21 Jul 2021 16:07:01 +0000 (16:07 +0000)
source/base/index_set.cc
source/fe/fe_bernstein.cc
source/fe/fe_dgq.cc
source/fe/fe_face.cc
source/fe/fe_q_base.cc
source/fe/fe_raviart_thomas_nodal.cc
source/grid/grid_generator.cc

index 8815d6919b5c9f30d246da8cadc98da5c82ffe4d..4216908880c8f6fbffd9e44c0234f8c4422a280a 100644 (file)
@@ -243,14 +243,21 @@ IndexSet::split_by_block(
 
   partitioned.reserve(n_blocks);
   types::global_dof_index start = 0;
-  types::global_dof_index sum   = 0;
   for (const auto n_block_indices : n_indices_per_block)
     {
       partitioned.push_back(this->get_view(start, start + n_block_indices));
       start += n_block_indices;
-      sum += partitioned.back().size();
+    }
+
+#ifdef DEBUG
+  types::global_dof_index sum = 0;
+  for (const auto &partition : partitioned)
+    {
+      sum += partition.size();
     }
   AssertDimension(sum, this->size());
+#endif
+
   return partitioned;
 }
 
index 9f1f10ff3bb6cc6311f9acdefef9064b6036d9cc..aeec6aa96c87ba798f678e8901105445b12b7fe3 100644 (file)
@@ -182,6 +182,7 @@ FE_Bernstein<dim, spacedim>::get_subface_interpolation_matrix(
             }
         }
 
+#ifdef DEBUG
       // make sure that the row sum of each of the matrices is 1 at this
       // point. this must be so since the shape functions sum up to 1
       for (unsigned int j = 0; j < source_fe->n_dofs_per_face(face_no); ++j)
@@ -193,6 +194,7 @@ FE_Bernstein<dim, spacedim>::get_subface_interpolation_matrix(
 
           Assert(std::fabs(sum - 1) < eps, ExcInternalError());
         }
+#endif
     }
   else
     {
index 9b2a90a48dd397a219b7377ed70acb0bd08874cc..ce2a845039da7b90df030dbcfe757d0826c7c580 100644 (file)
@@ -330,6 +330,7 @@ FE_DGQ<dim, spacedim>::get_interpolation_matrix(
       if (std::fabs(interpolation_matrix(i, j)) < 1e-15)
         interpolation_matrix(i, j) = 0.;
 
+#ifdef DEBUG
   // make sure that the row sum of
   // each of the matrices is 1 at
   // this point. this must be so
@@ -344,6 +345,7 @@ FE_DGQ<dim, spacedim>::get_interpolation_matrix(
       Assert(std::fabs(sum - 1) < 5e-14 * std::max(this->degree, 1U) * dim,
              ExcInternalError());
     }
+#endif
 }
 
 
index 44526e32e03c8ecf4ab1e265ca68fb338381d17e..dd66427daa16ad85f026ade880f99c01d2882590 100644 (file)
@@ -223,6 +223,7 @@ FE_FaceQ<dim, spacedim>::get_subface_interpolation_matrix(
             }
         }
 
+#ifdef DEBUG
       // make sure that the row sum of each of the matrices is 1 at this
       // point. this must be so since the shape functions sum up to 1
       for (unsigned int j = 0; j < source_fe->n_dofs_per_face(face_no); ++j)
@@ -234,6 +235,7 @@ FE_FaceQ<dim, spacedim>::get_subface_interpolation_matrix(
 
           Assert(std::fabs(sum - 1) < eps, ExcInternalError());
         }
+#endif
     }
   else if (dynamic_cast<const FE_Nothing<dim> *>(&x_source_fe) != nullptr)
     {
index ab3d5cef45dbc32acbf8a3524474344aecfac16d..28f809838e9e55870d15b5aa8d48a2a9c622429a 100644 (file)
@@ -568,6 +568,7 @@ FE_Q_Base<dim, spacedim>::get_interpolation_matrix(
           if (std::fabs(interpolation_matrix(i, j)) < eps)
             interpolation_matrix(i, j) = 0.;
 
+#ifdef DEBUG
       // make sure that the row sum of each of the matrices is 1 at this
       // point. this must be so since the shape functions sum up to 1
       for (unsigned int i = 0; i < this->n_dofs_per_cell(); ++i)
@@ -578,6 +579,7 @@ FE_Q_Base<dim, spacedim>::get_interpolation_matrix(
 
           Assert(std::fabs(sum - 1) < eps, ExcInternalError());
         }
+#endif
     }
   else if (dynamic_cast<const FE_Nothing<dim> *>(&x_source_fe))
     {
index aa4a1b9d73d8a54133914077b0c2885a06931694..08ecfed20f342e57c65f6115caaa5d014afd2aca 100644 (file)
@@ -920,6 +920,7 @@ FE_RaviartThomasNodal<dim>::get_face_interpolation_matrix(
         }
     }
 
+#ifdef DEBUG
   // make sure that the row sum of each of the matrices is 1 at this
   // point. this must be so since the shape functions sum up to 1
   for (unsigned int j = 0; j < source_fe.n_dofs_per_face(face_no); ++j)
@@ -932,6 +933,7 @@ FE_RaviartThomasNodal<dim>::get_face_interpolation_matrix(
       Assert(std::fabs(sum - 1) < 2e-13 * this->degree * (dim - 1),
              ExcInternalError());
     }
+#endif
 }
 
 
@@ -1009,6 +1011,7 @@ FE_RaviartThomasNodal<dim>::get_subface_interpolation_matrix(
         }
     }
 
+#ifdef DEBUG
   // make sure that the row sum of each of the matrices is 1 at this
   // point. this must be so since the shape functions sum up to 1
   for (unsigned int j = 0; j < source_fe.n_dofs_per_face(face_no); ++j)
@@ -1021,6 +1024,7 @@ FE_RaviartThomasNodal<dim>::get_subface_interpolation_matrix(
       Assert(std::fabs(sum - 1) < 2e-13 * this->degree * (dim - 1),
              ExcInternalError());
     }
+#endif
 }
 
 
index 81fdd1eef02ef80e286007392507574e70478605..fbf9ec8b1bb63200a8e531edcf7d22e26897f113 100644 (file)
@@ -2961,12 +2961,10 @@ namespace GridGenerator
     Assert(spacing.size() == 2, ExcInvalidRepetitionsDimension(2));
 
     std::vector<unsigned int> repetitions(2);
-    unsigned int              n_cells = 1;
-    double                    delta   = std::numeric_limits<double>::max();
+    double                    delta = std::numeric_limits<double>::max();
     for (unsigned int i = 0; i < 2; i++)
       {
         repetitions[i] = spacing[i].size();
-        n_cells *= repetitions[i];
         for (unsigned int j = 0; j < repetitions[i]; j++)
           {
             Assert(spacing[i][j] >= 0, ExcInvalidRepetitions(-1));
@@ -3057,12 +3055,10 @@ namespace GridGenerator
     Assert(spacing.size() == dim, ExcInvalidRepetitionsDimension(dim));
 
     std::vector<unsigned int> repetitions(dim);
-    unsigned int              n_cells = 1;
-    double                    delta   = std::numeric_limits<double>::max();
+    double                    delta = std::numeric_limits<double>::max();
     for (unsigned int i = 0; i < dim; i++)
       {
         repetitions[i] = spacing[i].size();
-        n_cells *= repetitions[i];
         for (unsigned int j = 0; j < repetitions[i]; j++)
           {
             Assert(spacing[i][j] >= 0, ExcInvalidRepetitions(-1));

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.