]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Comment-out some unused function arguments. 18495/head
authorDavid Wells <drwells@email.unc.edu>
Fri, 23 May 2025 16:39:41 +0000 (12:39 -0400)
committerDavid Wells <drwells@email.unc.edu>
Fri, 23 May 2025 19:00:27 +0000 (15:00 -0400)
include/deal.II/lac/la_parallel_vector.templates.h
include/deal.II/lac/precondition.h
include/deal.II/lac/read_write_vector.templates.h
include/deal.II/lac/sparse_matrix_tools.h
include/deal.II/lac/trilinos_solver.h
include/deal.II/matrix_free/hanging_nodes_internal.h
include/deal.II/matrix_free/vector_access_internal.h
include/deal.II/numerics/data_out_dof_data.templates.h
include/deal.II/numerics/vector_tools_project.templates.h

index 5b7f6ff0516853d7178dac287ad2ec7171b49bd5..218c92987fad7621a861e074e438f8a9ae4a1238 100644 (file)
@@ -334,11 +334,9 @@ namespace LinearAlgebra
           types::global_dof_index      &allocated_size,
           ::dealii::MemorySpace::MemorySpaceData<Number,
                                                  ::dealii::MemorySpace::Default>
-                        &data,
-          const MPI_Comm comm_sm)
+            &data,
+          const MPI_Comm /*comm_sm*/)
         {
-          (void)comm_sm;
-
           static_assert(
             std::is_same_v<Number, float> || std::is_same_v<Number, double>,
             "Number should be float or double for Default memory space");
index 75a4fb153fd7340960215bddc0129128e0fe58ee..e15784211abc6639dd55b85bc9615f898232fc21 100644 (file)
@@ -3699,10 +3699,9 @@ namespace internal
     template <typename MatrixType, typename PreconditionerType>
     inline void
     initialize_preconditioner(
-      const MatrixType                    &matrix,
+      const MatrixType & /*matrix*/,
       std::shared_ptr<PreconditionerType> &preconditioner)
     {
-      (void)matrix;
       (void)preconditioner;
       AssertThrow(preconditioner.get() != nullptr, ExcNotInitialized());
     }
index 0f0c52b22e0581cf278ccf33f7c086020f74ba5d..23b4259849bbeb5ceb51bd9cc0d5d3836a160732 100644 (file)
@@ -92,16 +92,11 @@ namespace LinearAlgebra
       static void
       import_elements(
         const std::shared_ptr<const ::dealii::Utilities::MPI::Partitioner>
-                                                         &communication_pattern,
-        const Number                                     *values,
-        const VectorOperation::values                     operation,
-        ::dealii::LinearAlgebra::ReadWriteVector<Number> &rw_vector)
+          & /*communication_pattern*/,
+        const Number * /*values*/,
+        const VectorOperation::values /*operation*/,
+        ::dealii::LinearAlgebra::ReadWriteVector<Number> & /*rw_vector*/)
       {
-        (void)communication_pattern;
-        (void)values;
-        (void)operation;
-        (void)rw_vector;
-
         static_assert(
           std::is_same_v<MemorySpace, ::dealii::MemorySpace::Host> ||
             std::is_same_v<MemorySpace, ::dealii::MemorySpace::Default>,
@@ -342,7 +337,6 @@ namespace LinearAlgebra
   {
     Assert(s == static_cast<Number>(0),
            ExcMessage("Only 0 can be assigned to a vector."));
-    (void)s;
 
     const size_type this_size = locally_owned_size();
     if (this_size > 0)
@@ -396,10 +390,8 @@ namespace LinearAlgebra
     const dealii::Vector<Number> &vec,
     VectorOperation::values       operation,
     const std::shared_ptr<const Utilities::MPI::CommunicationPatternBase>
-      &communication_pattern)
+      & /*communication_pattern*/)
   {
-    (void)communication_pattern;
-
     internal::import_serial_vector(vec, operation, *this);
   }
 
index bf0f0324a7a4763c7a6b84407547a5e4a552500b..9194063ec9c2b3c4a9751d2ac2ec1866cd41d1d5 100644 (file)
@@ -170,9 +170,8 @@ namespace SparseMatrixTools
               std::enable_if_t<!has_get_mpi_communicator<SparseMatrixType>,
                                SparseMatrixType> * = nullptr>
     MPI_Comm
-    get_mpi_communicator(const SparseMatrixType &sparse_matrix)
+    get_mpi_communicator(const SparseMatrixType & /*sparse_matrix*/)
     {
-      (void)sparse_matrix;
       return MPI_COMM_SELF;
     }
 
index a957fb4d47f1bb5c980ca23ea166b02420aad864..84ce0e506a1df1f603951ea49531feb9ca002a4f 100644 (file)
@@ -1047,10 +1047,9 @@ namespace TrilinosWrappers
        * Scale each element of the i-th vector in *this with alpha[i].
        */
       virtual void
-      MvScale(const std::vector<value_type> &alpha)
+      MvScale(const std::vector<value_type> & /*alpha*/)
       {
         AssertThrow(false, ExcNotImplemented());
-        (void)alpha;
       }
 
       /**
@@ -1115,12 +1114,10 @@ namespace TrilinosWrappers
        * Copy the vectors in A to a set of vectors in *this.
        */
       virtual void
-      SetBlock(const Belos::MultiVec<value_type> &A,
-               const std::vector<int>            &index)
+      SetBlock(const Belos::MultiVec<value_type> & /*A*/,
+               const std::vector<int> & /*index*/)
       {
         AssertThrow(false, ExcNotImplemented());
-        (void)A;
-        (void)index;
       }
 
       /**
@@ -1136,20 +1133,18 @@ namespace TrilinosWrappers
        * Replace each element of the vectors in *this with alpha.
        */
       virtual void
-      MvInit(const value_type alpha)
+      MvInit(const value_type /*alpha*/)
       {
         AssertThrow(false, ExcNotImplemented());
-        (void)alpha;
       }
 
       /**
        * Print *this multivector to the os output stream.
        */
       virtual void
-      MvPrint(std::ostream &os) const
+      MvPrint(std::ostream & /*os*/) const
       {
         AssertThrow(false, ExcNotImplemented());
-        (void)os;
       }
 
       /**
index 01652b5d5e1a9481b55fadf167d900f714b72c26..1411b956eb1a6e8d545e74db41e4afa549cbfc7d 100644 (file)
@@ -382,10 +382,8 @@ namespace internal
     template <int dim>
     inline void
     HangingNodes<dim>::setup_line_to_cell(
-      const Triangulation<dim> &triangulation)
-    {
-      (void)triangulation;
-    }
+      const Triangulation<dim> & /*triangulation*/)
+    {}
 
 
 
index f32dc005211c4205b27f652c66e2b6a4b0eecdc5..2458f92e55605cb2913336470c4ee72c7fac2703 100644 (file)
@@ -175,14 +175,10 @@ namespace internal
                              VectorType> * = nullptr>
   inline void
   check_vector_compatibility(
-    const VectorType                                   &vec,
-    const MatrixFree<dim, Number, VectorizedArrayType> &matrix_free,
-    const internal::MatrixFreeFunctions::DoFInfo       &dof_info)
+    const VectorType &vec,
+    const MatrixFree<dim, Number, VectorizedArrayType> & /*matrix_free*/,
+    const internal::MatrixFreeFunctions::DoFInfo &dof_info)
   {
-    (void)vec;
-    (void)matrix_free;
-    (void)dof_info;
-
     AssertDimension(vec.size(), dof_info.vector_partitioner->size());
   }
 
index 8bdf2d79be2a7b9e40088e59678c26da30f4b572..cf36b7f2bcd3946171f9932b1de6fd3d6bf7f1ae 100644 (file)
@@ -93,10 +93,8 @@ namespace internal
      */
     template <int dim>
     inline std::vector<Point<dim>>
-    generate_simplex_evaluation_points(const unsigned int n_subdivisions)
+    generate_simplex_evaluation_points(const unsigned int /*n_subdivisions*/)
     {
-      (void)n_subdivisions;
-
       DEAL_II_NOT_IMPLEMENTED();
 
       return {};
@@ -1636,13 +1634,11 @@ namespace internal
     template <int dim, int spacedim, typename ScalarType>
     double
     MGDataEntry<dim, spacedim, ScalarType>::get_cell_data_value(
-      const unsigned int       cell_number,
-      const ComponentExtractor extract_component) const
+      const unsigned int /*cell_number*/,
+      const ComponentExtractor /*extract_component*/) const
     {
       DEAL_II_NOT_IMPLEMENTED();
 
-      (void)cell_number;
-      (void)extract_component;
       return 0.0;
     }
 
index d457c692b44c794b3b85cdcda206ae4cfa239652..fbc2d09daa4e7df18b71cab54bd6d6f421163615 100644 (file)
@@ -170,14 +170,11 @@ namespace VectorTools
                                                  &function,
       LinearAlgebra::distributed::Vector<Number> &work_result,
       const bool                                  enforce_zero_boundary,
-      const Quadrature<dim - 1>                  &q_boundary,
-      const bool                                  project_to_boundary_first)
+      const Quadrature<dim - 1> & /*q_boundary*/,
+      const bool project_to_boundary_first)
     {
       Assert(project_to_boundary_first == false, ExcNotImplemented());
       Assert(enforce_zero_boundary == false, ExcNotImplemented());
-      (void)enforce_zero_boundary;
-      (void)project_to_boundary_first;
-      (void)q_boundary;
 
       AssertDimension(dof.get_fe_collection().size(), 1);
       AssertDimension(dof.get_fe(0).n_components(), function.n_components);

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.