]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Add a (void) cast to unused values in .cc files.
authorDavid Wells <drwells@vt.edu>
Sat, 11 Apr 2015 12:43:34 +0000 (08:43 -0400)
committerMatthias Maier <matthias.maier@iwr.uni-heidelberg.de>
Tue, 14 Apr 2015 10:50:18 +0000 (12:50 +0200)
This should *crosses fingers* get rid of all unused parameter warnings
when compiling the library.

61 files changed:
source/base/data_out_base.cc
source/base/flow_function.cc
source/base/function_lib.cc
source/base/geometry_info.cc
source/base/mpi.cc
source/base/subscriptor.cc
source/base/symmetric_tensor.cc
source/base/tensor_function.cc
source/distributed/tria.cc
source/dofs/dof_handler.cc
source/dofs/dof_handler_policy.cc
source/dofs/dof_objects.cc
source/dofs/dof_renumbering.cc
source/dofs/dof_tools.cc
source/dofs/dof_tools_constraints.cc
source/dofs/dof_tools_sparsity.cc
source/fe/fe.cc
source/fe/fe_dgp.cc
source/fe/fe_dgp_monomial.cc
source/fe/fe_dgp_nonparametric.cc
source/fe/fe_dgq.cc
source/fe/fe_face.cc
source/fe/fe_nothing.cc
source/fe/fe_q.cc
source/fe/fe_q_dg0.cc
source/fe/fe_q_hierarchical.cc
source/fe/fe_tools.cc
source/fe/fe_tools_interpolate.cc
source/fe/fe_values.cc
source/fe/mapping_c1.cc
source/fe/mapping_q1.cc
source/fe/mapping_q_eulerian.cc
source/grid/grid_generator.cc
source/grid/grid_tools.cc
source/grid/tria.cc
source/grid/tria_accessor.cc
source/grid/tria_boundary_lib.cc
source/grid/tria_levels.cc
source/hp/dof_level.cc
source/lac/block_sparsity_pattern.cc
source/lac/dynamic_sparsity_pattern.cc
source/lac/lapack_full_matrix.cc
source/lac/petsc_matrix_base.cc
source/lac/petsc_parallel_vector.cc
source/lac/slepc_spectral_transformation.cc
source/lac/sparsity_pattern.cc
source/lac/sparsity_tools.cc
source/lac/trilinos_block_sparse_matrix.cc
source/lac/trilinos_precondition.cc
source/lac/trilinos_sparse_matrix.cc
source/lac/trilinos_sparsity_pattern.cc
source/lac/trilinos_vector.cc
source/lac/trilinos_vector_base.cc
source/multigrid/mg_tools.cc
source/multigrid/mg_transfer_prebuilt.cc
source/numerics/error_estimator.cc
source/numerics/matrix_tools.cc
source/numerics/point_value_history.cc
source/numerics/solution_transfer.cc
source/opencascade/boundary_lib.cc
source/opencascade/utilities.cc

index 80db87a97b4c9452271484f32f95956092127c32..ee4bc101203a45a461ce8d6d7e63030c22216cdc 100644 (file)
@@ -245,6 +245,7 @@ namespace
                              (const Bytef *) &data[0],
                              data.size() * sizeof(T),
                              Z_BEST_COMPRESSION);
+        (void)err;
         Assert (err == Z_OK, ExcInternalError());
 
         // now encode the compression header
@@ -398,6 +399,7 @@ namespace DataOutBase
            patch != patches.end(); ++patch)
         {
           const unsigned int n_subdivisions = patch->n_subdivisions;
+          (void)n_subdivisions;
 
           Assert ((patch->data.n_rows() == n_data_sets && !patch->points_are_available) ||
                   (patch->data.n_rows() == n_data_sets+spacedim && patch->points_are_available),
@@ -3610,6 +3612,7 @@ namespace DataOutBase
     Assert (spacedim==2, ExcNotImplemented());
 
     const unsigned int n_data_sets = data_names.size();
+    (void)n_data_sets;
 
     // write preamble
     if (true)
index f31bafe51aceb2bd1e80d7d829484786e30ecbec..5f0fe5d0a34707e07b861f1481d4dbd8ad8a209d 100644 (file)
@@ -269,6 +269,7 @@ namespace Functions
     std::vector<std::vector<double> > &values) const
   {
     unsigned int n = points.size();
+    (void)n;
     Assert(values.size() == dim+1, ExcDimensionMismatch(values.size(), dim+1));
     for (unsigned int d=0; d<dim+1; ++d)
       Assert(values[d].size() == n, ExcDimensionMismatch(values[d].size(), n));
@@ -629,6 +630,7 @@ namespace Functions
     std::vector<std::vector<double> > &values) const
   {
     unsigned int n = points.size();
+    (void)n;
     Assert(values.size() == 2+1, ExcDimensionMismatch(values.size(), 2+1));
     for (unsigned int d=0; d<2+1; ++d)
       Assert(values[d].size() == n, ExcDimensionMismatch(values[d].size(), n));
index f9ff174ab856c47e9d1c9e60e84966fdd4b182d6..1ff631533a7033f3c2e22994c4481cc17002b33c 100644 (file)
@@ -1852,6 +1852,7 @@ namespace Functions
   FourierCosineFunction<dim>::value (const Point<dim>   &p,
                                      const unsigned int  component) const
   {
+    (void)component;
     Assert (component==0, ExcIndexRange(component,0,1));
     return std::cos(fourier_coefficients * p);
   }
@@ -1863,6 +1864,7 @@ namespace Functions
   FourierCosineFunction<dim>::gradient (const Point<dim>   &p,
                                         const unsigned int  component) const
   {
+    (void)component;
     Assert (component==0, ExcIndexRange(component,0,1));
     return -fourier_coefficients * std::sin(fourier_coefficients * p);
   }
@@ -1874,6 +1876,7 @@ namespace Functions
   FourierCosineFunction<dim>::laplacian (const Point<dim>   &p,
                                          const unsigned int  component) const
   {
+    (void)component;
     Assert (component==0, ExcIndexRange(component,0,1));
     return (fourier_coefficients * fourier_coefficients) * (-std::cos(fourier_coefficients * p));
   }
@@ -1900,6 +1903,7 @@ namespace Functions
   FourierSineFunction<dim>::value (const Point<dim>   &p,
                                    const unsigned int  component) const
   {
+    (void)component;
     Assert (component==0, ExcIndexRange(component,0,1));
     return std::sin(fourier_coefficients * p);
   }
@@ -1911,6 +1915,7 @@ namespace Functions
   FourierSineFunction<dim>::gradient (const Point<dim>   &p,
                                       const unsigned int  component) const
   {
+    (void)component;
     Assert (component==0, ExcIndexRange(component,0,1));
     return fourier_coefficients * std::cos(fourier_coefficients * p);
   }
@@ -1922,6 +1927,7 @@ namespace Functions
   FourierSineFunction<dim>::laplacian (const Point<dim>   &p,
                                        const unsigned int  component) const
   {
+    (void)component;
     Assert (component==0, ExcIndexRange(component,0,1));
     return (fourier_coefficients * fourier_coefficients) * (-std::sin(fourier_coefficients * p));
   }
@@ -1955,6 +1961,7 @@ namespace Functions
   FourierSineSum<dim>::value (const Point<dim>   &p,
                               const unsigned int  component) const
   {
+    (void)component;
     Assert (component==0, ExcIndexRange(component,0,1));
 
     const unsigned int n = weights.size();
@@ -1972,6 +1979,7 @@ namespace Functions
   FourierSineSum<dim>::gradient (const Point<dim>   &p,
                                  const unsigned int  component) const
   {
+    (void)component;
     Assert (component==0, ExcIndexRange(component,0,1));
 
     const unsigned int n = weights.size();
@@ -1989,6 +1997,7 @@ namespace Functions
   FourierSineSum<dim>::laplacian (const Point<dim>   &p,
                                   const unsigned int  component) const
   {
+    (void)component;
     Assert (component==0, ExcIndexRange(component,0,1));
 
     const unsigned int n = weights.size();
@@ -2027,6 +2036,7 @@ namespace Functions
   FourierCosineSum<dim>::value (const Point<dim>   &p,
                                 const unsigned int  component) const
   {
+    (void)component;
     Assert (component==0, ExcIndexRange(component,0,1));
 
     const unsigned int n = weights.size();
@@ -2044,6 +2054,7 @@ namespace Functions
   FourierCosineSum<dim>::gradient (const Point<dim>   &p,
                                    const unsigned int  component) const
   {
+    (void)component;
     Assert (component==0, ExcIndexRange(component,0,1));
 
     const unsigned int n = weights.size();
@@ -2061,6 +2072,7 @@ namespace Functions
   FourierCosineSum<dim>::laplacian (const Point<dim>   &p,
                                     const unsigned int  component) const
   {
+    (void)component;
     Assert (component==0, ExcIndexRange(component,0,1));
 
     const unsigned int n = weights.size();
@@ -2094,6 +2106,7 @@ namespace Functions
   Monomial<dim>::value (const Point<dim>   &p,
                         const unsigned int  component) const
   {
+    (void)component;
     Assert (component<this->n_components,
             ExcIndexRange(component, 0, this->n_components)) ;
 
@@ -2125,6 +2138,7 @@ namespace Functions
   Monomial<dim>::gradient (const Point<dim>   &p,
                            const unsigned int  component) const
   {
+    (void)component;
     Assert (component==0, ExcIndexRange(component,0,1)) ;
 
     Tensor<1,dim> r;
@@ -2343,6 +2357,7 @@ namespace Functions
   InterpolatedTensorProductGridData<dim>::value(const Point<dim> &p,
                                                 const unsigned int component) const
   {
+    (void)component;
     Assert (component == 0,
             ExcMessage ("This is a scalar function object, the component can only be zero."));
 
@@ -2415,6 +2430,7 @@ namespace Functions
   InterpolatedUniformGridData<dim>::value(const Point<dim> &p,
                                           const unsigned int component) const
   {
+    (void)component;
     Assert (component == 0,
             ExcMessage ("This is a scalar function object, the component can only be zero."));
 
index 1b57e05b3182e7c25d00bbdb15412b170b3e377c..9c22482b44b3574f36a6379bbb9a4c3287fe157e 100644 (file)
@@ -547,7 +547,9 @@ RefinementCase<1>
 GeometryInfo<1>::line_refinement_case(const RefinementCase<1> &cell_refinement_case,
                                       const unsigned int line_no)
 {
+  (void)line_no;
   const unsigned int dim = 1;
+  (void)dim;
   Assert(cell_refinement_case<RefinementCase<dim>::isotropic_refinement+1,
          ExcIndexRange(cell_refinement_case, 0, RefinementCase<dim>::isotropic_refinement+1));
   Assert(line_no<GeometryInfo<dim>::lines_per_cell,
@@ -709,6 +711,7 @@ template<>
 RefinementCase<1>
 GeometryInfo<1>::min_cell_refinement_case_for_line_refinement(const unsigned int line_no)
 {
+  (void)line_no;
   Assert(line_no==0, ExcIndexRange(line_no,0,1));
 
   return RefinementCase<1>::cut_x;
@@ -720,6 +723,7 @@ RefinementCase<2>
 GeometryInfo<2>::min_cell_refinement_case_for_line_refinement(const unsigned int line_no)
 {
   const unsigned int dim = 2;
+  (void)dim;
   Assert(line_no<GeometryInfo<dim>::lines_per_cell,
          ExcIndexRange(line_no, 0, GeometryInfo<dim>::lines_per_cell));
 
@@ -1086,6 +1090,7 @@ GeometryInfo<1>::child_cell_on_face (const RefinementCase<1> &,
                                      const bool, const bool, const bool,
                                      const RefinementCase<0> &)
 {
+  (void)subface;
   Assert (face<faces_per_cell, ExcIndexRange(face, 0, faces_per_cell));
   Assert (subface<max_children_per_face,
           ExcIndexRange(subface, 0, max_children_per_face));
@@ -1429,6 +1434,7 @@ unsigned int
 GeometryInfo<1>::line_to_cell_vertices (const unsigned int line,
                                         const unsigned int vertex)
 {
+  (void)line;
   Assert (line<lines_per_cell, ExcIndexRange(line, 0, lines_per_cell));
   Assert (vertex<2, ExcIndexRange(vertex, 0, 2));
 
@@ -1488,6 +1494,8 @@ GeometryInfo<1>::face_to_cell_lines (const unsigned int face,
                                      const unsigned int line,
                                      const bool, const bool, const bool)
 {
+  (void)face;
+  (void)line;
   Assert (face+1<faces_per_cell+1, ExcIndexRange(face, 0, faces_per_cell));
   Assert (line+1<lines_per_face+1, ExcIndexRange(line, 0, lines_per_face));
 
@@ -1504,6 +1512,7 @@ GeometryInfo<2>::face_to_cell_lines (const unsigned int face,
                                      const unsigned int line,
                                      const bool, const bool, const bool)
 {
+  (void)line;
   Assert (face<faces_per_cell, ExcIndexRange(face, 0, faces_per_cell));
   Assert (line<lines_per_face, ExcIndexRange(line, 0, lines_per_face));
 
index 5641b4dc875871e54b381f51713c4243959b702d..cd69c9c358fb1793b484d041cd2e260357486bd8 100644 (file)
@@ -192,6 +192,7 @@ namespace Utilities
                         int *len,
                         MPI_Datatype *)
       {
+        (void)len;
         const MinMaxAvg *in_lhs = static_cast<const MinMaxAvg *>(in_lhs_);
         MinMaxAvg *inout_rhs = static_cast<MinMaxAvg *>(inout_rhs_);
 
@@ -334,6 +335,7 @@ namespace Utilities
                                         const unsigned int max_num_threads)
     {
       static bool constructor_has_already_run = false;
+      (void)constructor_has_already_run;
       Assert (constructor_has_already_run == false,
               ExcMessage ("You can only create a single object of this class "
                           "in a program since it initializes the MPI system."));
index 0719f90218e56326520fc648bff7bdefac4e6311..2a44b7963283765d192eae2bb8dd161703f4c6b2 100644 (file)
@@ -46,7 +46,11 @@ Subscriptor::Subscriptor ()
   :
   counter (0),
   object_info (0)
-{}
+{
+  // this has to go somewhere to avoid an extra warning.
+  (void)unknown_subscriber;
+}
+
 
 
 Subscriptor::Subscriptor (const Subscriptor &)
@@ -161,6 +165,8 @@ Subscriptor::subscribe(const char *id) const
 
   else
     it->second++;
+#  else
+  (void)id;
 #  endif
 #else
   (void)id;
index 658a87a303ed473ad2975c560ba82c28af1071f2..df85d5d2daff195dee76c52d2f21b3987bde4db4 100644 (file)
@@ -46,6 +46,7 @@ invert<3,double> (const SymmetricTensor<4,3,double> &t)
   for (unsigned int i=0; i<N; ++i)
     diagonal_sum += std::fabs(tmp.data[i][i]);
   const double typical_diagonal_element = diagonal_sum/N;
+  (void)typical_diagonal_element;
 
   unsigned int p[N];
   for (unsigned int i=0; i<N; ++i)
index f9eb5a3da48e83525101087e6e5caa39b198c2d7..28d2618c665b63b4d4ddebc15398e3f596f02404 100644 (file)
@@ -117,6 +117,7 @@ void
 ConstantTensorFunction<rank, dim, Number>::value_list (const std::vector<Point<dim> > &points,
                                                        std::vector<typename TensorFunction<rank, dim, Number>::value_type> &values) const
 {
+  (void)points;
   Assert (values.size() == points.size(),
           ExcDimensionMismatch(values.size(), points.size()));
 
@@ -140,6 +141,7 @@ void
 ConstantTensorFunction<rank, dim, Number>::gradient_list (const std::vector<Point<dim> >   &points,
                                                           std::vector<typename TensorFunction<rank, dim, Number>::gradient_type> &gradients) const
 {
+  (void)points;
   Assert (gradients.size() == points.size(),
           ExcDimensionMismatch(gradients.size(), points.size()));
 
index d91c8f8dd5dcb8bff08eab7a56ff6324be51c1cd..c9f25b85d073bc64b353cab2ed50b2894c468a90 100644 (file)
@@ -1130,6 +1130,7 @@ namespace
     num_vtt = std::accumulate (vertex_touch_count.begin(),
                                vertex_touch_count.end(),
                                0);
+    (void)num_vtt;
     Assert (connectivity->ctt_offset[triangulation.n_vertices()] ==
             num_vtt,
             ExcInternalError());
@@ -3295,6 +3296,7 @@ namespace parallel
       // many non-artificial cells as parallel_forest->local_num_quadrants)
       {
         const unsigned int total_local_cells = this->n_active_cells();
+        (void)total_local_cells;
 
         if (Utilities::MPI::n_mpi_processes (mpi_communicator) == 1)
           Assert (static_cast<unsigned int>(parallel_forest->local_num_quadrants) ==
@@ -3630,6 +3632,7 @@ namespace parallel
            ++it, ++buffer, ++idx)
         {
           const unsigned int num_cells = it->second.tree_index.size();
+          (void)num_cells;
           destinations.push_back(it->first);
 
           Assert(num_cells==it->second.quadrants.size(), ExcInternalError());
index 42753e08db9955995249ffc8225721fbabf6b349..1e3e8857dbd248f963176c464b1be6cfe6f808ab 100644 (file)
@@ -1239,9 +1239,11 @@ void DoFHandler<dim,spacedim>::distribute_dofs (const FiniteElement<dim,spacedim
 template<int dim, int spacedim>
 void DoFHandler<dim, spacedim>::distribute_mg_dofs (const FiniteElement<dim, spacedim> &fe)
 {
+  (void)fe;
   Assert(levels.size()>0, ExcMessage("Distribute active DoFs using distribute_dofs() before calling distribute_mg_dofs()."));
 
   const FiniteElement<dim, spacedim> *old_fe = selected_fe;
+  (void)old_fe;
   Assert(old_fe == &fe, ExcMessage("You are required to use the same FE for level and active DoFs!") );
 
   clear_mg_space();
index 95bc3ae2ea740a41ad67f1b5b74b15993a201c33..99bbb4bd8da7e2238113aab937dddd400ea2e9cb 100644 (file)
@@ -1529,6 +1529,7 @@ namespace internal
                ++it, ++buffer, ++idx)
             {
               const unsigned int num_cells = it->second.tree_index.size();
+              (void)num_cells;
 
               Assert(num_cells==it->second.quadrants.size(), ExcInternalError());
               Assert(num_cells>0, ExcInternalError());
@@ -1762,6 +1763,7 @@ namespace internal
                ++it, ++buffer, ++idx)
             {
               const unsigned int num_cells = it->second.tree_index.size();
+              (void)num_cells;
 
               Assert(num_cells==it->second.quadrants.size(), ExcInternalError());
               Assert(num_cells>0, ExcInternalError());
index 0275f3b5e5db9e78248be3c0cdd2f2fa4ebd5564..1bcabde8b086d27f360922af173b88ddec6e7e1e 100644 (file)
@@ -44,6 +44,7 @@ namespace internal
                    const unsigned int       local_index,
                    const types::global_dof_index       global_index)
     {
+      (void)fe_index;
       Assert ((fe_index == dealii::DoFHandler<dh_dim, spacedim>::default_fe_index),
               ExcMessage ("Only the default FE index is allowed for non-hp DoFHandler objects"));
       Assert (local_index<dof_handler.get_fe().template n_dofs_per_object<dim>(),
index e209c33cffaf12d2c36cfc29601b32460a4db7b6..9e440a0eb2e2ea129f111d300d05770e9c6baaf5 100644 (file)
@@ -255,6 +255,7 @@ namespace DoFRenumbering
                             const bool       reversed_numbering,
                             const bool       use_constraints)
     {
+      (void)use_constraints;
       Assert (use_constraints == false, ExcNotImplemented());
 
       // the following code is pretty
index d94a23cd72db9e47a84bf9c83d0af49107e8acdf..0f845024e92a35bba3af75f35bb3e33107ef790a 100644 (file)
@@ -258,6 +258,7 @@ namespace DoFTools
     const unsigned int dim = DH::dimension;
     const unsigned int spacedim = DH::space_dimension;
     const Triangulation<dim,spacedim> &tria = dof_handler.get_tria();
+    (void)tria;
 
     AssertDimension (cell_data.size(), tria.n_active_cells());
     AssertDimension (dof_data.size(), dof_handler.n_dofs());
@@ -336,6 +337,7 @@ namespace DoFTools
                 std::vector<bool>       &selected_dofs)
   {
     const FiniteElement<dim,spacedim> &fe = dof.get_fe();
+    (void)fe;
 
     Assert(component_mask.represents_n_components(fe.n_components()),
            ExcMessage ("The given component mask is not sized correctly to represent the "
@@ -381,6 +383,7 @@ namespace DoFTools
                 std::vector<bool>       &selected_dofs)
   {
     const FiniteElement<dim,spacedim> &fe = dof.begin_active()->get_fe();
+    (void)fe;
 
     Assert(component_mask.represents_n_components(fe.n_components()),
            ExcMessage ("The given component mask is not sized correctly to represent the "
index b329b0c31a84ce07f8652f73eac9552f2f442b10..f3f2e78164b73906cfb2593fd16808e435d2e885 100644 (file)
@@ -2226,6 +2226,7 @@ namespace DoFTools
                                 const ComponentMask            &component_mask)
   {
     static const int space_dim = DH::space_dimension;
+    (void)space_dim;
     Assert (0<=direction && direction<space_dim,
             ExcIndexRange (direction, 0, space_dim));
 
@@ -2256,6 +2257,8 @@ namespace DoFTools
   {
     static const int dim = DH::dimension;
     static const int space_dim = DH::space_dimension;
+    (void)dim;
+    (void)space_dim;
 
     Assert (0<=direction && direction<space_dim,
             ExcIndexRange (direction, 0, space_dim));
@@ -2756,6 +2759,7 @@ namespace DoFTools
                                                fine_grid, fine_component,
                                                coarse_to_fine_grid_map,
                                                weights, weight_mapping);
+    (void)n_parameters_on_fine_grid;
 
     // global numbers of dofs
     const types::global_dof_index n_coarse_dofs = coarse_grid.n_dofs(),
index a3f034c3e5c8829fa8b9e2a0090b8afb6b832e4e..fcccfa68cab1798d694ca8a34cea6229ce416eae 100644 (file)
@@ -59,6 +59,7 @@ namespace DoFTools
                          const types::subdomain_id subdomain_id)
   {
     const types::global_dof_index n_dofs = dof.n_dofs();
+    (void)n_dofs;
 
     Assert (sparsity.n_rows() == n_dofs,
             ExcDimensionMismatch (sparsity.n_rows(), n_dofs));
@@ -118,6 +119,7 @@ namespace DoFTools
                          const types::subdomain_id subdomain_id)
   {
     const types::global_dof_index n_dofs = dof.n_dofs();
+    (void)n_dofs;
 
     Assert (sparsity.n_rows() == n_dofs,
             ExcDimensionMismatch (sparsity.n_rows(), n_dofs));
@@ -231,6 +233,8 @@ namespace DoFTools
   {
     const types::global_dof_index n_dofs_row = dof_row.n_dofs();
     const types::global_dof_index n_dofs_col = dof_col.n_dofs();
+    (void)n_dofs_row;
+    (void)n_dofs_col;
 
     Assert (sparsity.n_rows() == n_dofs_row,
             ExcDimensionMismatch (sparsity.n_rows(), n_dofs_row));
@@ -346,6 +350,7 @@ namespace DoFTools
       }
 
     const types::global_dof_index n_dofs = dof.n_dofs();
+    (void)n_dofs;
 
     AssertDimension (dof_to_boundary_mapping.size(), n_dofs);
     AssertDimension (sparsity.n_rows(), dof.n_boundary_dofs());
@@ -434,6 +439,7 @@ namespace DoFTools
       }
 
     const types::global_dof_index n_dofs = dof.n_dofs();
+    (void)n_dofs;
 
     AssertDimension (dof_to_boundary_mapping.size(), n_dofs);
     Assert (boundary_ids.find(numbers::internal_face_boundary_id) == boundary_ids.end(),
@@ -491,6 +497,7 @@ namespace DoFTools
 
   {
     const types::global_dof_index n_dofs = dof.n_dofs();
+    (void)n_dofs;
 
     AssertDimension (sparsity.n_rows(), n_dofs);
     AssertDimension (sparsity.n_cols(), n_dofs);
@@ -1135,7 +1142,9 @@ namespace DoFTools
     // do the error checking and frame code here, and then pass on to more
     // specialized functions in the internal namespace
     const types::global_dof_index n_dofs = dof.n_dofs();
+    (void)n_dofs;
     const unsigned int n_comp = dof.get_fe().n_components();
+    (void)n_comp;
 
     Assert (sparsity.n_rows() == n_dofs,
             ExcDimensionMismatch (sparsity.n_rows(), n_dofs));
index c7a6edaf6136459f27b14032b863f4233f2ee4c3..feb9f106e1c45ccd69248dda1a6efb1df6c63b24 100644 (file)
@@ -821,6 +821,7 @@ template <int dim, int spacedim>
 const FullMatrix<double> &
 FiniteElement<dim,spacedim>::constraints (const internal::SubfaceCase<dim> &subface_case) const
 {
+  (void)subface_case;
   Assert (subface_case==internal::SubfaceCase<dim>::case_isotropic,
           ExcMessage("Constraints for this element are only implemented "
                      "for the case that faces are refined isotropically "
@@ -1447,6 +1448,7 @@ template <int dim, int spacedim>
 const FiniteElement<dim,spacedim> &
 FiniteElement<dim,spacedim>::base_element(const unsigned int index) const
 {
+  (void)index;
   Assert (index==0, ExcIndexRange(index,0,1));
   // This function should not be
   // called for a system element
index 06ce4847f00207973e6acf99580c83ad98b582bf..a93a0e1b69cdac12e2e995e1664b0d014211e818 100644 (file)
@@ -102,6 +102,7 @@ get_face_interpolation_matrix (const FiniteElement<dim,spacedim> &x_source_fe,
   // case, both elements have no dofs on their faces and the face
   // interpolation matrix is necessarily empty -- i.e. there isn't much we
   // need to do here.
+  (void)interpolation_matrix;
   typedef FiniteElement<dim,spacedim> FE;
   typedef FE_DGP<dim,spacedim> FEDGP;
   AssertThrow ((x_source_fe.get_name().find ("FE_DGP<") == 0)
@@ -131,6 +132,7 @@ get_subface_interpolation_matrix (const FiniteElement<dim,spacedim> &x_source_fe
   // case, both elements have no dofs on their faces and the face
   // interpolation matrix is necessarily empty -- i.e. there isn't much we
   // need to do here.
+  (void)interpolation_matrix;
   typedef FiniteElement<dim,spacedim> FE;
   typedef FE_DGP<dim,spacedim> FEDGP;
   AssertThrow ((x_source_fe.get_name().find ("FE_DGP<") == 0)
index ce1eb804db855bf09aaa388c269be69d51c5b28f..7c0a9cfb16d55e67362700ce334331ef5e32500a 100644 (file)
@@ -181,6 +181,8 @@ get_interpolation_matrix (const FiniteElement<dim> &source_fe,
       // matrix is simple
       const unsigned int m=interpolation_matrix.m();
       const unsigned int n=interpolation_matrix.n();
+      (void)m;
+      (void)n;
       Assert (m == this->dofs_per_cell, ExcDimensionMismatch (m, this->dofs_per_cell));
       Assert (n == source_dgp_monomial->dofs_per_cell,
               ExcDimensionMismatch (n, source_dgp_monomial->dofs_per_cell));
@@ -255,6 +257,7 @@ get_face_interpolation_matrix (const FiniteElement<dim> &x_source_fe,
   // faces and the face interpolation matrix
   // is necessarily empty -- i.e. there isn't
   // much we need to do here.
+  (void)interpolation_matrix;
   AssertThrow ((x_source_fe.get_name().find ("FE_DGPMonomial<") == 0)
                ||
                (dynamic_cast<const FE_DGPMonomial<dim>*>(&x_source_fe) != 0),
@@ -284,6 +287,7 @@ get_subface_interpolation_matrix (const FiniteElement<dim> &x_source_fe,
   // faces and the face interpolation matrix
   // is necessarily empty -- i.e. there isn't
   // much we need to do here.
+  (void)interpolation_matrix;
   AssertThrow ((x_source_fe.get_name().find ("FE_DGPMonomial<") == 0)
                ||
                (dynamic_cast<const FE_DGPMonomial<dim>*>(&x_source_fe) != 0),
index c81d8bb0aa5e05aa6158c2074df94df61ea6ee8f..b431c1f48249d1d9399e1d0ea2f547a9fceb4844 100644 (file)
@@ -140,6 +140,7 @@ FE_DGPNonparametric<dim,spacedim>::shape_value_component (const unsigned int i,
                                                           const Point<dim> &p,
                                                           const unsigned int component) const
 {
+  (void)component;
   Assert (i<this->dofs_per_cell, ExcIndexRange(i, 0, this->dofs_per_cell));
   Assert (component == 0, ExcIndexRange (component, 0, 1));
   return polynomial_space.compute_value(i, p);
@@ -163,6 +164,7 @@ FE_DGPNonparametric<dim,spacedim>::shape_grad_component (const unsigned int i,
                                                          const Point<dim> &p,
                                                          const unsigned int component) const
 {
+  (void)component;
   Assert (i<this->dofs_per_cell, ExcIndexRange(i, 0, this->dofs_per_cell));
   Assert (component == 0, ExcIndexRange (component, 0, 1));
   return polynomial_space.compute_grad(i, p);
@@ -187,6 +189,7 @@ FE_DGPNonparametric<dim,spacedim>::shape_grad_grad_component (const unsigned int
     const Point<dim> &p,
     const unsigned int component) const
 {
+  (void)component;
   Assert (i<this->dofs_per_cell, ExcIndexRange(i, 0, this->dofs_per_cell));
   Assert (component == 0, ExcIndexRange (component, 0, 1));
   return polynomial_space.compute_grad_grad(i, p);
@@ -430,6 +433,7 @@ get_face_interpolation_matrix (const FiniteElement<dim,spacedim> &x_source_fe,
   // faces and the face interpolation matrix
   // is necessarily empty -- i.e. there isn't
   // much we need to do here.
+  (void)interpolation_matrix;
   typedef              FiniteElement<dim,spacedim> FEE;
   AssertThrow ((x_source_fe.get_name().find ("FE_DGPNonparametric<") == 0)
                ||
@@ -460,6 +464,7 @@ get_subface_interpolation_matrix (const FiniteElement<dim,spacedim> &x_source_fe
   // faces and the face interpolation matrix
   // is necessarily empty -- i.e. there isn't
   // much we need to do here.
+  (void)interpolation_matrix;
   typedef              FiniteElement<dim,spacedim> FEE;
   AssertThrow ((x_source_fe.get_name().find ("FE_DGPNonparametric<") == 0)
                ||
index ce7b60592009df402da169484a0f9e47708bd3da..19d0e1d28b6c7f92d9777ea3d2d55064c2fbe9bf 100644 (file)
@@ -430,6 +430,7 @@ get_face_interpolation_matrix (const FiniteElement<dim, spacedim> &x_source_fe,
   // faces and the face interpolation matrix
   // is necessarily empty -- i.e. there isn't
   // much we need to do here.
+  (void)interpolation_matrix;
   typedef FiniteElement<dim,spacedim> FE;
   AssertThrow ((dynamic_cast<const FE_DGQ<dim, spacedim>*>(&x_source_fe) != 0),
                typename FE::ExcInterpolationNotImplemented());
@@ -457,6 +458,7 @@ get_subface_interpolation_matrix (const FiniteElement<dim, spacedim> &x_source_f
   // faces and the face interpolation matrix
   // is necessarily empty -- i.e. there isn't
   // much we need to do here.
+  (void)interpolation_matrix;
   typedef FiniteElement<dim, spacedim> FE;
   AssertThrow ((dynamic_cast<const FE_DGQ<dim, spacedim>*>(&x_source_fe) != 0),
                typename FE::ExcInterpolationNotImplemented());
index 2b8d7df436cc97db721c364cac1e57cc926c9165..26c200b990ccdb73939149b09c2ef7ad8e6f947e 100644 (file)
@@ -366,6 +366,7 @@ get_subface_interpolation_matrix (const FiniteElement<1,spacedim> &x_source_fe,
                                   const unsigned int        /*subface*/,
                                   FullMatrix<double>       &interpolation_matrix) const
 {
+  (void)x_source_fe;
   Assert (interpolation_matrix.n() == this->dofs_per_face,
           ExcDimensionMismatch (interpolation_matrix.n(),
                                 this->dofs_per_face));
@@ -489,6 +490,7 @@ FE_FaceQ<1,spacedim>::get_face_data (
   const UpdateFlags flags(data->update_flags);
   const unsigned int n_q_points = quadrature.size();
   AssertDimension(n_q_points, 1);
+  (void)n_q_points;
 
   // No derivatives of this element are implemented.
   if (flags & update_gradients || flags & update_hessians)
@@ -757,6 +759,7 @@ get_subface_interpolation_matrix (const FiniteElement<dim,spacedim> &x_source_fe
               v_in(k) = this->poly_space.compute_value(i, p);
             }
           const double result = H.least_squares(v_out, v_in);
+          (void)result;
           Assert(result < 1e-12, FETools::ExcLeastSquaresError (result));
 
           for (unsigned int j = 0; j < source_fe->dofs_per_face; ++j)
index ab24f7179ab16d868d975c1d219e2d09bb3dbc82..18b4838ad0e1b53e78b8a06ef9ae3021565b0fd3 100644 (file)
@@ -91,6 +91,7 @@ double
 FE_Nothing<dim,spacedim>::shape_value (const unsigned int /*i*/,
                                        const Point<dim> & /*p*/) const
 {
+  (void)zero_dof_message;
   Assert(false,ExcMessage(zero_dof_message));
   return 0;
 }
@@ -224,6 +225,7 @@ get_face_interpolation_matrix (const FiniteElement<dim,spacedim> &/*source_fe*/,
 {
   // since this element has no face dofs, the
   // interpolation matrix is necessarily empty
+  (void)interpolation_matrix;
 
   Assert (interpolation_matrix.m() == 0,
           ExcDimensionMismatch (interpolation_matrix.m(),
@@ -244,6 +246,7 @@ get_subface_interpolation_matrix (const FiniteElement<dim,spacedim> & /*source_f
   // since this element has no face dofs, the
   // interpolation matrix is necessarily empty
 
+  (void)interpolation_matrix;
   Assert (interpolation_matrix.m() == 0,
           ExcDimensionMismatch (interpolation_matrix.m(),
                                 0));
index fe8fd248ed5aee6c927ceb0bb3ad56f6b2c68eac..0b5ee5062a43677e7ab664db2f934ff2107f3856 100644 (file)
@@ -59,6 +59,7 @@ FE_Q<dim,spacedim>::FE_Q (const Quadrature<1> &points)
     std::vector<bool> (1, false))
 {
   const unsigned int degree = points.size()-1;
+  (void)degree;
   Assert (degree > 0,
           ExcMessage ("This element can only be used for polynomial degrees "
                       "at least zero"));
index dff6341bced86f55b6f31e06bb6b4f6a21819339..4312e6a3773b2d25b7226dbe518a8310dd8fa083 100644 (file)
@@ -70,6 +70,7 @@ FE_Q_DG0<dim,spacedim>::FE_Q_DG0 (const Quadrature<1> &points)
     get_riaf_vector(points.size()-1))
 {
   const int degree = points.size()-1;
+  (void)degree;
 
   Assert (degree > 0,
           ExcMessage ("This element can only be used for polynomial degrees "
index 90e6d1ed712e2a5ceee3aa6bd32c2c9011375ac8..eb3350d14c745f79bac1b5fadd2c301337315bc2 100644 (file)
@@ -851,6 +851,7 @@ get_face_interpolation_matrix (const FiniteElement<dim> &x_source_fe,
   // we will be able to do the work
   const FE_Q_Hierarchical<dim> &source_fe
     = dynamic_cast<const FE_Q_Hierarchical<dim>&>(x_source_fe);
+  (void)source_fe;
 
   // Make sure, that the element,
   // for which the DoFs should be
index 443943b90308f953d1484a10d6c539e1cdbfa33e..75b263d3a0ffc0b97637f1eac15e2412373291f3 100644 (file)
@@ -736,6 +736,7 @@ namespace FETools
       // solve the least squares
       // problem.
       const double result = H.least_squares (v_fine, v_coarse);
+      (void)result;
       Assert (result < 1.e-12, ExcLeastSquaresError (result));
 
       // Copy into the result
@@ -1071,6 +1072,7 @@ namespace FETools
             // solve the least squares
             // problem.
             const double result = H.least_squares(v_fine, v_coarse);
+            (void)result;
             Assert (result < 1.e-12, ExcLeastSquaresError(result));
 
             // Copy into the result
@@ -1578,6 +1580,7 @@ namespace FETools
         if (pos2-pos1 == 2)
           {
             const char dimchar = '0' + dim;
+            (void)dimchar;
             if (name.at(pos1+1) != 'd')
               Assert (name.at(pos1+1) == dimchar,
                       ExcInvalidFEDimension(name.at(pos1+1), dim));
index 14e349fa691e62af5ee12a51f9209f842c8bbf95..5f4c02f06923bcc432b1be7ae16c8fc75a296f75 100644 (file)
@@ -123,6 +123,7 @@ namespace FETools
                                                      endc1 = dof1.end();
     typename DH2<dim,spacedim>::active_cell_iterator cell2 = dof2.begin_active(),
                                                      endc2 = dof2.end();
+    (void)endc2;
 
     std::vector<types::global_dof_index> dofs;
     dofs.reserve (DoFTools::max_dofs_per_cell (dof2));
index d9bee6e3ab38dcebd3034c066078c6b550933791..858f50a69e3bd27ee54b259b35a5c77cd112d6da 100644 (file)
@@ -2263,6 +2263,7 @@ namespace internal
 
     // Assert that we can write all components into the result vectors
     const unsigned result_components = n_components * component_multiple;
+    (void)result_components;
     if (quadrature_points_fastest)
       {
         AssertDimension(values.size(), result_components);
@@ -2395,6 +2396,7 @@ namespace internal
 
     // Assert that we can write all components into the result vectors
     const unsigned result_components = n_components * component_multiple;
+    (void)result_components;
     if (quadrature_points_fastest)
       {
         AssertDimension(derivatives.size(), result_components);
@@ -2516,6 +2518,7 @@ namespace internal
 
     // Assert that we can write all components into the result vectors
     const unsigned result_components = n_components * component_multiple;
+    (void)result_components;
     if (quadrature_points_fastest)
       {
         AssertDimension(laplacians.size(), result_components);
index 2a03de037652f199a31ce0cb05da6b7796f0e847..019d5274d9f0e5b093cc6c5f7a5098a404814c13 100644 (file)
@@ -39,6 +39,7 @@ MappingC1<1>::add_line_support_points (const Triangulation<1>::cell_iterator &,
                                        std::vector<Point<1> > &) const
 {
   const unsigned int dim = 1;
+  (void)dim;
   Assert (dim > 1, ExcImpossibleInDim(dim));
 }
 
@@ -160,6 +161,7 @@ MappingC1<1>::add_quad_support_points (const Triangulation<1>::cell_iterator &,
                                        std::vector<Point<1> > &) const
 {
   const unsigned int dim = 1;
+  (void)dim;
   Assert (dim > 2, ExcImpossibleInDim(dim));
 }
 
@@ -171,6 +173,7 @@ MappingC1<2>::add_quad_support_points (const Triangulation<2>::cell_iterator &,
                                        std::vector<Point<2> > &) const
 {
   const unsigned int dim = 2;
+  (void)dim;
   Assert (dim > 2, ExcImpossibleInDim(dim));
 }
 
index 60738e1000edf4873ab51717e12217a4c23dd35f..77bbb34aa90217d72fc144aff2c26cf482fb24df 100644 (file)
@@ -98,6 +98,7 @@ namespace internal
                             const std::vector<Point<1> > &unit_points,
                             typename dealii::MappingQ1<1,spacedim>::InternalData &data)
     {
+      (void)n_shape_functions;
       const unsigned int n_points=unit_points.size();
       for (unsigned int k = 0 ; k < n_points ; ++k)
         {
@@ -138,6 +139,7 @@ namespace internal
                             const std::vector<Point<2> > &unit_points,
                             typename dealii::MappingQ1<2,spacedim>::InternalData &data)
     {
+      (void)n_shape_functions;
       const unsigned int n_points=unit_points.size();
       for (unsigned int k = 0 ; k < n_points ; ++k)
         {
@@ -198,6 +200,7 @@ namespace internal
                             const std::vector<Point<3> > &unit_points,
                             typename dealii::MappingQ1<3,spacedim>::InternalData &data)
     {
+      (void)n_shape_functions;
       const unsigned int n_points=unit_points.size();
       for (unsigned int k = 0 ; k < n_points ; ++k)
         {
@@ -815,6 +818,7 @@ MappingQ1<dim,spacedim>::fill_fe_values (
                 else
                   {
                     const unsigned int codim = spacedim-dim;
+                    (void)codim;
 
                     if (update_flags & update_normal_vectors)
                       {
@@ -1457,6 +1461,7 @@ MappingQ1<dim,spacedim>::
 transform_unit_to_real_cell_internal (const InternalData &data) const
 {
   const unsigned int n_mapping_points=data.mapping_support_points.size();
+  (void)n_mapping_points;
   AssertDimension (data.shape_values.size(), n_mapping_points);
 
   // use now the InternalData to
@@ -1699,6 +1704,7 @@ transform_real_to_unit_cell_internal
  InternalData                                     &mdata) const
 {
   const unsigned int n_shapes=mdata.shape_values.size();
+  (void)n_shapes;
   Assert(n_shapes!=0, ExcInternalError());
   AssertDimension (mdata.shape_derivatives.size(), n_shapes);
 
@@ -1929,6 +1935,7 @@ transform_real_to_unit_cell_internal_codim1
 
 
   const unsigned int n_shapes=mdata.shape_values.size();
+  (void)n_shapes;
   Assert(n_shapes!=0, ExcInternalError());
   Assert(mdata.shape_derivatives.size()==n_shapes, ExcInternalError());
   Assert(mdata.shape_second_derivatives.size()==n_shapes, ExcInternalError());
index 4a2ad9b68f54ae557ad51838cffb1cefc8c9407f..9e0afc39e31878043f5645601665db2b338603d2 100644 (file)
@@ -108,6 +108,8 @@ compute_mapping_support_points
 
   const types::global_dof_index n_dofs  = euler_dof_handler->n_dofs();
   const types::global_dof_index vector_size = euler_vector->size();
+  (void)n_dofs;
+  (void)vector_size;
 
   AssertDimension(vector_size,n_dofs);
 
index fa5f966efbb90c048966f7570511db33d5edd3ea..efb52df10e239b56f7e50c1617623e98f1d65d2b 100644 (file)
@@ -3027,6 +3027,7 @@ namespace GridGenerator
                     const unsigned int n,
                     const bool colorize)
   {
+    (void)colorize;
     Assert ((inner_radius > 0) && (inner_radius < outer_radius),
             ExcInvalidRadii ());
     Assert(colorize == false, ExcNotImplemented());
@@ -3726,6 +3727,7 @@ namespace GridGenerator
     const parallel::distributed::Triangulation<dim, spacedim1> *pt =
       dynamic_cast<const parallel::distributed::Triangulation<dim, spacedim1> *>(&in_tria);
 
+    (void)pt;
     Assert (pt == NULL,
             ExcMessage("Cannot use this function on parallel::distributed::Triangulation."));
 
index 81b3be4ba0ac7c3b16e321b17d0095a6bc67abb0..3e68b4d91b1292f961004b78f88d7ab999e7f715 100644 (file)
@@ -2729,6 +2729,7 @@ next_cell:
    const std::vector<unsigned int>                  &first_vector_components)
   {
     static const int space_dim = CellIterator::AccessorType::space_dimension;
+    (void)space_dim;
     Assert (0<=direction && direction<space_dim,
             ExcIndexRange (direction, 0, space_dim));
 
@@ -2795,6 +2796,8 @@ next_cell:
   {
     static const int dim = CONTAINER::dimension;
     static const int space_dim = CONTAINER::space_dimension;
+    (void)dim;
+    (void)space_dim;
     Assert (0<=direction && direction<space_dim,
             ExcIndexRange (direction, 0, space_dim));
 
@@ -2849,6 +2852,8 @@ next_cell:
   {
     static const int dim = CONTAINER::dimension;
     static const int space_dim = CONTAINER::space_dimension;
+    (void)dim;
+    (void)space_dim;
     Assert (0<=direction && direction<space_dim,
             ExcIndexRange (direction, 0, space_dim));
 
index 26d538d502ee2572023b4ac9bb5a556b15f8e8b9..63f8372e43c929da07d3454a290eecdff832268d 100644 (file)
@@ -4632,6 +4632,7 @@ namespace internal
                   // two child lines.  To this end, find a pair of
                   // unused lines
                   bool pair_found=false;
+                  (void)pair_found;
                   for (; next_unused_line!=endl; ++next_unused_line)
                     if (!next_unused_line->used() &&
                         !(++next_unused_line)->used())
index 9d00889701fa17afcc763ec4fa3305fce6062b51..8ddc1794d4380a3a8e4177f07498b4999c5ef22e 100644 (file)
@@ -1111,6 +1111,7 @@ measure () const
 template <>
 double TriaAccessor<1,1,1>::extent_in_direction(const unsigned int axis) const
 {
+  (void)axis;
   Assert (axis == 0, ExcIndexRange (axis, 0, 1));
 
   return this->diameter();
@@ -1120,6 +1121,7 @@ double TriaAccessor<1,1,1>::extent_in_direction(const unsigned int axis) const
 template <>
 double TriaAccessor<1,1,2>::extent_in_direction(const unsigned int axis) const
 {
+  (void)axis;
   Assert (axis == 0, ExcIndexRange (axis, 0, 1));
 
   return this->diameter();
index 4f5c7dd39183492ef0305bf6ac849c1acce40a86..4ad712eccc6239cc8cdcc68edb3f8f7096ebe8fd 100644 (file)
@@ -594,6 +594,7 @@ HyperBallBoundary<dim,spacedim>::get_intermediate_points_between_points (
   const double length=(v1-v0).norm();
 
   double eps=1e-12;
+  (void)eps;
   double r=0;
   if (compute_radius_automatically)
     r = (p0 - center).norm();
index 944021dcd24a5e30dbc296277e424646be653b42..2fc0ec8a719f8ea548bd6f8061c24a0cfefff9de 100644 (file)
@@ -84,6 +84,7 @@ namespace internal
     void
     TriaLevel<dim>::monitor_memory (const unsigned int true_dimension) const
     {
+      (void)true_dimension;
       Assert (2*true_dimension*refine_flags.size() == neighbors.size(),
               ExcMemoryInexact (refine_flags.size(), neighbors.size()));
       Assert (2*true_dimension*coarsen_flags.size() == neighbors.size(),
@@ -168,6 +169,7 @@ namespace internal
     void
     TriaLevel<3>::monitor_memory (const unsigned int true_dimension) const
     {
+      (void)true_dimension;
       Assert (2*true_dimension*refine_flags.size() == neighbors.size(),
               ExcMemoryInexact (refine_flags.size(), neighbors.size()));
       Assert (2*true_dimension*coarsen_flags.size() == neighbors.size(),
index c813e955d9250581378cd66fe76344809f717b5c..1562b118b308d87c26776842dfdddd7cf3ea2810 100644 (file)
@@ -28,6 +28,7 @@ namespace internal
     void
     DoFLevel::compress_data (const dealii::hp::FECollection<dim,spacedim> &fe_collection)
     {
+      (void)fe_collection;
       return;
 
       if (dof_offsets.size() == 0 || dof_indices.size()==0)
index 05f3e9a55fc39bfdf4ae6ed0126e05c2a80c1e51..8dc962e960382e93836fd62086c02c4154a06f39 100644 (file)
@@ -49,6 +49,7 @@ BlockSparsityPatternBase (const BlockSparsityPatternBase &s)
   :
   Subscriptor ()
 {
+  (void)s;
   Assert(s.rows==0, ExcInvalidConstructorCall());
   Assert(s.columns==0, ExcInvalidConstructorCall());
 
index e43f56c585935fea5f63bd0f6ab5fae741e9d11f..94c3be446f0eaf50dedf480e5609eb5a12d93b81 100644 (file)
@@ -231,6 +231,7 @@ DynamicSparsityPattern (const DynamicSparsityPattern &s)
   cols(0),
   rowset(0)
 {
+  (void)s;
   Assert (s.rows == 0, ExcInvalidConstructorCall());
   Assert (s.cols == 0, ExcInvalidConstructorCall());
 }
@@ -274,6 +275,7 @@ DynamicSparsityPattern::DynamicSparsityPattern (const size_type n)
 DynamicSparsityPattern &
 DynamicSparsityPattern::operator = (const DynamicSparsityPattern &s)
 {
+  (void)s;
   Assert (s.rows == 0, ExcInvalidConstructorCall());
   Assert (s.cols == 0, ExcInvalidConstructorCall());
 
index 74cde57dc850d199d050241d9630e12923be5eff..faa648809fbf69696500e65f7cd108e83aec7e4a 100644 (file)
@@ -119,6 +119,7 @@ template <typename number>
 LAPACKFullMatrix<number> &
 LAPACKFullMatrix<number>::operator = (const double d)
 {
+  (void)d;
   Assert (d==0, ExcScalarAssignmentOnlyForZeroValue());
 
   if (this->n_elements() != 0)
index 27e83fa3bc55df6791b3d01d24e73fa23491d979..b496dbee86acfeba123fef19e812040c7f02d06d 100644 (file)
@@ -50,6 +50,7 @@ namespace PETScWrappers
       const PetscScalar *values;
 
       int ierr;
+      (void)ierr;
       ierr = MatGetRow(*matrix, this->a_row, &ncols, &colnums, &values);
       AssertThrow (ierr == 0, MatrixBase::ExcPETScError(ierr));
 
@@ -113,6 +114,7 @@ namespace PETScWrappers
   MatrixBase &
   MatrixBase::operator = (const value_type d)
   {
+    (void)d;
     Assert (d==value_type(), ExcScalarAssignmentOnlyForZeroValue());
 
     assert_is_compressed ();
@@ -473,6 +475,7 @@ namespace PETScWrappers
   {
     const int ierr = MatAXPY (matrix, factor,
                               other, DIFFERENT_NONZERO_PATTERN);
+    (void)ierr;
 
     Assert (ierr == 0, ExcPETScError(ierr));
 
@@ -487,6 +490,7 @@ namespace PETScWrappers
     Assert (&src != &dst, ExcSourceEqualsDestination());
 
     const int ierr = MatMult (matrix, src, dst);
+    (void)ierr;
     AssertThrow (ierr == 0, ExcPETScError(ierr));
   }
 
@@ -499,6 +503,7 @@ namespace PETScWrappers
     Assert (&src != &dst, ExcSourceEqualsDestination());
 
     const int ierr = MatMultTranspose (matrix, src, dst);
+    (void)ierr;
     AssertThrow (ierr == 0, ExcPETScError(ierr));
   }
 
@@ -511,6 +516,7 @@ namespace PETScWrappers
     Assert (&src != &dst, ExcSourceEqualsDestination());
 
     const int ierr = MatMultAdd (matrix, src, dst, dst);
+    (void)ierr;
     AssertThrow (ierr == 0, ExcPETScError(ierr));
   }
 
@@ -523,6 +529,7 @@ namespace PETScWrappers
     Assert (&src != &dst, ExcSourceEqualsDestination());
 
     const int ierr = MatMultTransposeAdd (matrix, src, dst, dst);
+    (void)ierr;
     AssertThrow (ierr == 0, ExcPETScError(ierr));
   }
 
@@ -553,6 +560,7 @@ namespace PETScWrappers
   MatrixBase::transpose ()
   {
     int ierr = MatTranspose(matrix, MAT_REUSE_MATRIX, &matrix);
+    (void)ierr;
     AssertThrow (ierr == 0, ExcPETScError(ierr));
   }
 
index cd9155941a26ba708731b57b144e503c7a7918b0..1bae4a90459a69d00e04624da4d10b813ff1d4a0 100644 (file)
@@ -251,6 +251,7 @@ namespace PETScWrappers
     Vector::create_vector (const size_type n,
                            const size_type local_size)
     {
+      (void)n;
       Assert (local_size <= n, ExcIndexRange (local_size, 0, n));
       ghosted = false;
 
@@ -270,6 +271,7 @@ namespace PETScWrappers
                            const size_type local_size,
                            const IndexSet &ghostnodes)
     {
+      (void)n;
       Assert (local_size <= n, ExcIndexRange (local_size, 0, n));
       ghosted = true;
       ghost_indices = ghostnodes;
index f5a132ddd38cb95331ffccb7f2a6e4d4d7039b11..c8adc711411c36f846b2060c092c83b6cb8ce3fe 100644 (file)
@@ -137,12 +137,15 @@ namespace SLEPcWrappers
 #if DEAL_II_PETSC_VERSION_LT(3,5,0)
     int ierr;
     ierr = STSetType (st, const_cast<char *>(STFOLD));
+    (void)ierr;
     AssertThrow (ierr == 0, SolverBase::ExcSLEPcError(ierr));
 
     ierr = STSetShift (st, additional_data.shift_parameter);
+    (void)ierr;
     AssertThrow (ierr == 0, SolverBase::ExcSLEPcError(ierr));
 #else
     // PETSc/SLEPc version must be < 3.5.0.
+    (void)st;
     Assert ((false),
             ExcMessage ("Folding transformation has been removed in SLEPc 3.5.0 and newer."
                         "You cannot use this transformation anymore."));
@@ -184,4 +187,3 @@ namespace SLEPcWrappers
 DEAL_II_NAMESPACE_CLOSE
 
 #endif // DEAL_II_WITH_SLEPC
-
index 13a27414171c87bd6a7c9985c44073bf7f27d3b1..dcfed47bda1410c3a8371acd5b6f266357d56b0f 100644 (file)
@@ -61,6 +61,7 @@ SparsityPattern::SparsityPattern (const SparsityPattern &s)
   compressed(false),
   store_diagonal_first_in_row(false)
 {
+  (void)s;
   Assert (s.rowstart == 0, ExcInvalidConstructorCall());
   Assert (s.colnums == 0, ExcInvalidConstructorCall());
   Assert (s.rows == 0, ExcInvalidConstructorCall());
@@ -224,6 +225,7 @@ SparsityPattern::~SparsityPattern ()
 SparsityPattern &
 SparsityPattern::operator = (const SparsityPattern &s)
 {
+  (void)s;
   Assert (s.rowstart == 0, ExcInvalidConstructorCall());
   Assert (s.colnums == 0, ExcInvalidConstructorCall());
   Assert (s.rows == 0, ExcInvalidConstructorCall());
index 01977a0ab1371b93c9e5bfcfb617168914203be1..547f7c4e9961958f1a1ce9111706086852a7395d 100644 (file)
@@ -66,6 +66,7 @@ namespace SparsityTools
     // Make sure that METIS is actually
     // installed and detected
 #ifndef DEAL_II_WITH_METIS
+    (void)sparsity_pattern;
     AssertThrow (false, ExcMETISNotInstalled());
 #else
 
index f5743f70ab7a69fd23efa9326c0e3949c4177c78..9b32ff79bf50ee1786da549867bc313d386fe776 100644 (file)
@@ -94,6 +94,7 @@ namespace TrilinosWrappers
                                   block_sparsity_pattern.n_block_cols()));
 
     const size_type n_block_rows = parallel_partitioning.size();
+    (void)n_block_rows;
 
     Assert (n_block_rows == block_sparsity_pattern.n_block_rows(),
             ExcDimensionMismatch (n_block_rows,
index 8012fda8ff6aee6466c83b5ea769b1b906a9811c..ce47fdda0ec437acfcee8fc1382d52c44b2e1df0 100644 (file)
@@ -820,6 +820,7 @@ namespace TrilinosWrappers
           additional_data.constant_modes[0].size() == n_rows;
         const size_type n_relevant_rows =
           constant_modes_are_global ? n_rows : additional_data.constant_modes[0].size();
+        (void)n_relevant_rows;
         const size_type my_size = domain_map.NumMyElements();
         if (constant_modes_are_global == false)
           Assert (n_relevant_rows == my_size,
@@ -828,6 +829,7 @@ namespace TrilinosWrappers
                 static_cast<size_type>(global_length(distributed_constant_modes)),
                 ExcDimensionMismatch(n_rows,
                                      global_length(distributed_constant_modes)));
+        (void)global_length;
 
         // Reshape null space as a contiguous vector of doubles so that
         // Trilinos can read from it.
index 256ddbcadb52cd45af8e921f460440c07b7833c9..6b5c05cf75a0c839badc53b748e0b8e7dbe6d1de 100644 (file)
@@ -409,6 +409,7 @@ namespace TrilinosWrappers
             int *index_ptr, *rhs_index_ptr;
             ierr = rhs.matrix->ExtractMyRowView (row_local, rhs_n_entries,
                                                  rhs_value_ptr, rhs_index_ptr);
+            (void)ierr;
             Assert (ierr == 0, ExcTrilinosError(ierr));
 
             ierr = matrix->ExtractMyRowView (row_local, n_entries, value_ptr,
@@ -596,6 +597,7 @@ namespace TrilinosWrappers
     // check whether we got the number of columns right.
     AssertDimension (sparsity_pattern.n_cols(),static_cast<size_type>(
                        n_global_cols(*graph)));
+    (void)n_global_cols;
 
     // And now finally generate the matrix.
     matrix.reset (new Epetra_FECrsMatrix(Copy, *graph, false));
@@ -746,6 +748,7 @@ namespace TrilinosWrappers
           {
             Epetra_Export exporter(nonlocal_graph->RowMap(), input_row_map);
             int ierr = graph->Export(*nonlocal_graph, exporter, Add);
+            (void)ierr;
             Assert (ierr==0, ExcTrilinosError(ierr));
           }
 
@@ -1079,6 +1082,7 @@ namespace TrilinosWrappers
         int num_entries;
         const int ierr = matrix->ExtractMyRowView(local_row, num_entries,
                                                   values, col_indices);
+        (void)ierr;
 
         Assert (ierr == 0,
                 ExcTrilinosError(ierr));
@@ -1149,6 +1153,7 @@ namespace TrilinosWrappers
         // TODO Check that col_indices are int and not long long
         int ierr = matrix->ExtractMyRowView(trilinos_i, nnz_extracted,
                                             values, col_indices);
+        (void)ierr;
         Assert (ierr==0, ExcTrilinosError(ierr));
 
         Assert (nnz_present == nnz_extracted,
@@ -1221,6 +1226,7 @@ namespace TrilinosWrappers
         // an error.
         int ierr = matrix->ExtractMyRowView(trilinos_i, nnz_extracted,
                                             values, col_indices);
+        (void)ierr;
         Assert (ierr==0, ExcTrilinosError(ierr));
 
         Assert (nnz_present == nnz_extracted,
@@ -1578,6 +1584,7 @@ namespace TrilinosWrappers
         int *index_ptr, *rhs_index_ptr;
         ierr = rhs.matrix->ExtractMyRowView (row_local, rhs_n_entries,
                                              rhs_value_ptr, rhs_index_ptr);
+        (void)ierr;
         Assert (ierr == 0, ExcTrilinosError(ierr));
 
         ierr = matrix->ExtractMyRowView (row_local, n_entries, value_ptr,
index 4e773176f27c640852494966b67aeb02925f7390..45b16000722144fe21b1036c1ac974267fe5aea5 100644 (file)
@@ -240,6 +240,7 @@ namespace TrilinosWrappers
                                  *column_space_map,
                                  0))
   {
+    (void)input_sparsity;
     Assert (input_sparsity.n_rows() == 0,
             ExcMessage ("Copy constructor only works for empty sparsity patterns."));
   }
@@ -781,6 +782,7 @@ namespace TrilinosWrappers
             int ierr = graph->ExtractGlobalRowView(
                          static_cast<TrilinosWrappers::types::int_type>(trilinos_i),
                          nnz_extracted, col_indices);
+            (void)ierr;
             Assert (ierr==0, ExcTrilinosError(ierr));
             Assert (nnz_present == nnz_extracted,
                     ExcDimensionMismatch(nnz_present, nnz_extracted));
@@ -809,6 +811,7 @@ namespace TrilinosWrappers
             // an error.
             int ierr = graph->ExtractMyRowView(trilinos_i,
                                                nnz_extracted, col_indices);
+            (void)ierr;
             Assert (ierr==0, ExcTrilinosError(ierr));
 
             Assert (nnz_present == nnz_extracted,
index 4009a1773fce6582ae91343299f09306b8a7a511..f09397c5433f9a2e96d99fe108955cc13fd2124c 100644 (file)
@@ -192,6 +192,7 @@ namespace TrilinosWrappers
       else if (fast == false)
         {
           const int ierr = vector->PutScalar(0.);
+          (void)ierr;
           Assert (ierr == 0, ExcTrilinosError(ierr));
         }
 
@@ -242,6 +243,7 @@ namespace TrilinosWrappers
               // distribution
               int ierr;
               ierr = vector->GlobalAssemble (last_action);
+              (void)ierr;
               Assert (ierr == 0, ExcTrilinosError(ierr));
 
               ierr = vector->PutScalar(0.0);
@@ -545,6 +547,7 @@ namespace TrilinosWrappers
       {
         int ierr;
         ierr = vector->GlobalAssemble(last_action);
+        (void)ierr;
         Assert (ierr == 0, ExcTrilinosError(ierr));
 
         ierr = vector->PutScalar(0.0);
@@ -571,6 +574,7 @@ namespace TrilinosWrappers
       {
         int ierr;
         ierr = vector->GlobalAssemble(last_action);
+        (void)ierr;
         Assert (ierr == 0, ExcTrilinosError(ierr));
 
         ierr = vector->PutScalar(0.0);
@@ -604,6 +608,7 @@ namespace TrilinosWrappers
       {
         int ierr;
         ierr = vector->GlobalAssemble(last_action);
+        (void)ierr;
         Assert (ierr == 0, ExcTrilinosError(ierr));
 
         ierr = vector->PutScalar(0.0);
@@ -627,6 +632,7 @@ namespace TrilinosWrappers
     // the vector, initialize our
     // map with the map in v, and
     // generate the vector.
+    (void)fast;
     if (allow_different_maps == false)
       {
         if (local_range() != v.local_range())
@@ -645,6 +651,7 @@ namespace TrilinosWrappers
                                 " seems to be the same. Check vector setup!"));
 
             ierr = vector->GlobalAssemble(last_action);
+            (void)ierr;
             Assert (ierr == 0, ExcTrilinosError(ierr));
 
             ierr = vector->PutScalar(0.0);
@@ -711,6 +718,7 @@ namespace TrilinosWrappers
 
     const int ierr = vector->Update(1.0, *v.vector, 0.0);
     Assert (ierr == 0, ExcTrilinosError(ierr));
+    (void)ierr;
 
     return *this;
   }
index 2ee2e31a072ddfbc14713ff12454f62c9f8aee4f..ad8356a833175f43fccd48d10e4e2638c01deb1d 100644 (file)
@@ -419,6 +419,7 @@ namespace TrilinosWrappers
   VectorBase::print (const char *format) const
   {
     Assert (global_length(*vector)!=0, ExcEmptyObject());
+    (void)global_length;
 
     for (size_type j=0; j<size(); ++j)
       {
index 764aaa1d339ac8ab027c76c5aa4420b4903bd03e..eb4de3b17d75d0f12b726d4c45365040cd93e118 100644 (file)
@@ -542,6 +542,7 @@ namespace MGTools
     const unsigned int       level)
   {
     const types::global_dof_index n_dofs = dof.n_dofs(level);
+    (void)n_dofs;
 
     Assert (sparsity.n_rows() == n_dofs,
             ExcDimensionMismatch (sparsity.n_rows(), n_dofs));
@@ -575,6 +576,7 @@ namespace MGTools
     const unsigned int level)
   {
     const types::global_dof_index n_dofs = dof.n_dofs(level);
+    (void)n_dofs;
 
     Assert (sparsity.n_rows() == n_dofs,
             ExcDimensionMismatch (sparsity.n_rows(), n_dofs));
@@ -647,6 +649,8 @@ namespace MGTools
 
     const types::global_dof_index fine_dofs = dof.n_dofs(level);
     const types::global_dof_index coarse_dofs = dof.n_dofs(level-1);
+    (void)fine_dofs;
+    (void)coarse_dofs;
 
     // Matrix maps from fine level to coarse level
 
@@ -708,6 +712,8 @@ namespace MGTools
     const FiniteElement<dim> &fe = dof.get_fe();
     const types::global_dof_index n_dofs = dof.n_dofs(level);
     const unsigned int n_comp = fe.n_components();
+    (void)n_dofs;
+    (void)n_comp;
 
     Assert (sparsity.n_rows() == n_dofs,
             ExcDimensionMismatch (sparsity.n_rows(), n_dofs));
@@ -885,12 +891,15 @@ namespace MGTools
   {
     const FiniteElement<dim> &fe = dof.get_fe();
     const unsigned int n_comp = fe.n_components();
+    (void)n_comp;
 
     Assert ((level>=1) && (level<dof.get_tria().n_global_levels()),
             ExcIndexRange(level, 1, dof.get_tria().n_global_levels()));
 
     const types::global_dof_index fine_dofs = dof.n_dofs(level);
     const types::global_dof_index coarse_dofs = dof.n_dofs(level-1);
+    (void)fine_dofs;
+    (void)coarse_dofs;
 
     // Matrix maps from fine level to coarse level
 
@@ -1090,6 +1099,7 @@ namespace MGTools
       = *std::max_element (target_block.begin(),
                            target_block.end());
     const unsigned int n_target_blocks = max_block + 1;
+    (void)n_target_blocks;
 
     for (unsigned int l=0; l<n_levels; ++l)
       AssertDimension (dofs_per_block[l].size(), n_target_blocks);
@@ -1183,6 +1193,7 @@ namespace MGTools
 
     const unsigned int n_levels = dof.get_tria().n_global_levels();
 
+    (void)n_levels;
 
 
     const unsigned int n_components = DoFTools::n_components(dof);
index 82c86887def382ffbb2ea93f227fd0cd61055d16..84a3eb43d0eef3767b5add8d571cb0378b888bc6 100644 (file)
@@ -106,6 +106,7 @@ void MGTransferPrebuilt<VECTOR>::restrict_and_add (
 {
   Assert ((from_level >= 1) && (from_level<=prolongation_matrices.size()),
           ExcIndexRange (from_level, 1, prolongation_matrices.size()+1));
+  (void)from_level;
 
   prolongation_matrices[from_level-1]->Tvmult_add (dst, src);
 }
index 39b4a7b82075ebb9aeb0cdc02680cf366b1459b5..61d129d7e5c1b46838126affe06076b8b3007bd2 100644 (file)
@@ -483,6 +483,7 @@ namespace internal
                                  dealii::hp::FEFaceValues<DH::dimension, DH::space_dimension> &fe_face_values_neighbor)
     {
       const unsigned int dim = DH::dimension;
+      (void)dim;
 
       const typename DH::face_iterator face = cell->face(face_no);
       const unsigned int n_solution_vectors = solutions.size();
@@ -559,8 +560,10 @@ namespace internal
                                    dealii::hp::FESubfaceValues<DH::dimension, DH::space_dimension> &fe_subface_values)
     {
       const unsigned int dim = DH::dimension;
+      (void)dim;
 
       const typename DH::cell_iterator neighbor = cell->neighbor(face_no);
+      (void)neighbor;
       const unsigned int n_solution_vectors = solutions.size();
       const typename DH::face_iterator
       face=cell->face(face_no);
@@ -924,6 +927,7 @@ estimate (const Mapping<dim, spacedim>                  &mapping,
 #endif
 
   const unsigned int n_components = dof_handler.get_fe().n_components();
+  (void)n_components;
 
   // sanity checks
   Assert (solutions.size() > 0,
index ba96eb5799dfba11ed175c7c4b7fbfad8a12cc5d..f31179555da6f9dd74ea5cd143ff13122ff305cd 100644 (file)
@@ -580,6 +580,7 @@ namespace MatrixCreator
                                VectorType *right_hand_side)
     {
       const unsigned int dofs_per_cell = data.dof_indices.size();
+      (void)dofs_per_cell;
 
       Assert (data.cell_matrix.m() == dofs_per_cell,
               ExcInternalError());
@@ -2130,6 +2131,7 @@ namespace MatrixTools
     for (; dof != endd; ++dof)
       {
         Assert (dof->first < n_dofs, ExcInternalError());
+        (void)n_dofs;
 
         // get global index and index
         // in the block in which this
@@ -2323,6 +2325,7 @@ namespace MatrixTools
                              PETScVector      &right_hand_side,
                              const bool        eliminate_columns)
       {
+        (void)eliminate_columns;
         Assert (eliminate_columns == false, ExcNotImplemented());
 
         Assert (matrix.n() == right_hand_side.size(),
@@ -2537,6 +2540,7 @@ namespace MatrixTools
                              const bool           eliminate_columns)
       {
         Assert (eliminate_columns == false, ExcNotImplemented());
+        (void)eliminate_columns;
 
         Assert (matrix.n() == right_hand_side.size(),
                 ExcDimensionMismatch(matrix.n(), right_hand_side.size()));
index 0253fa61226d4a140a68b53bc7df4cb71a4edb9d..3ed95f67157bf3b28f309b5b9aa6b294c25a9d41 100644 (file)
@@ -514,6 +514,7 @@ void PointValueHistory<dim>
   typename std::map <std::string, ComponentMask>::iterator mask = component_mask.find(vector_name);
   Assert (mask != component_mask.end(), ExcMessage("vector_name not in class"));
   unsigned int n_stored = mask->second.n_selected_components();
+  (void)n_stored;
   Assert (component_names.size() == n_stored, ExcDimensionMismatch (component_names.size(), n_stored));
 
   names->second = component_names;
index f0b1cdfc4e66db9d4b42c7ae67ae6649690ab971..91d1bfaeb932342122c1aaef6b8fae7ba50a7f62 100644 (file)
@@ -243,6 +243,7 @@ prepare_for_coarsening_and_refinement(const std::vector<VECTOR> &all_in)
   clear();
 
   const unsigned int n_active_cells = dof_handler->get_tria().n_active_cells();
+  (void)n_active_cells;
   n_dofs_old = dof_handler->n_dofs();
 
   for (unsigned int i=0; i<in_size; ++i)
index d71cdce185f2318a34cdb731129a20d7e2d6aa5c..810ce32c5303a1530609c0b7a266c6de968f7774 100644 (file)
@@ -68,6 +68,7 @@ namespace OpenCASCADE
   project_to_manifold (const std::vector<Point<spacedim> > &surrounding_points,
                        const Point<spacedim> &candidate) const
   {
+    (void)surrounding_points;
 #ifdef DEBUG
     for (unsigned int i=0; i<surrounding_points.size(); ++i)
       Assert(closest_point(sh, surrounding_points[i], tolerance)
@@ -97,6 +98,7 @@ namespace OpenCASCADE
   project_to_manifold (const std::vector<Point<spacedim> > &surrounding_points,
                        const Point<spacedim> &candidate) const
   {
+    (void)surrounding_points;
 #ifdef DEBUG
     for (unsigned int i=0; i<surrounding_points.size(); ++i)
       Assert(closest_point(sh, surrounding_points[i],tolerance)
index 1d0d88710b0d620274d4d4ce311f7434cf5857ba..98f0b973c098245ed21dd1fee01eadd4bd7ec8af 100644 (file)
@@ -551,6 +551,7 @@ namespace OpenCASCADE
     // something is wrong
     std_cxx11::tuple<unsigned int, unsigned int, unsigned int> numbers =
       count_elements(out_shape);
+    (void)numbers;
 
     Assert(std_cxx11::get<0>(numbers) > 0,
            ExcMessage("Could not find normal: the shape containing the closest point has 0 faces."));

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.