]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Fix a bunch of warnings 832/head
authorMatthias Maier <tamiko@43-1.org>
Sat, 18 Apr 2015 13:23:53 +0000 (15:23 +0200)
committerMatthias Maier <tamiko@43-1.org>
Sat, 18 Apr 2015 13:40:39 +0000 (15:40 +0200)
These are harmless code modifications to make a variety of compilers happy.

include/deal.II/base/config.h.in
include/deal.II/lac/petsc_matrix_base.h
include/deal.II/lac/trilinos_vector.h
source/grid/grid_refinement.cc
source/grid/grid_tools.cc
source/lac/trilinos_precondition.cc

index 793f3d8893a5d6caf12e7720c9927e919d24db27..e36ffbed1216cb6eb28abf5bf79e0a8f39f87d8f 100644 (file)
 
 #ifdef DEAL_II_COMPILER_HAS_DIAGNOSTIC_PRAGMA
 
-#  define DEAL_II_DISABLE_EXTRA_DIAGNOSTICS                \
-_Pragma("GCC diagnostic push")                             \
-_Pragma("GCC diagnostic ignored \"-Wpragmas\"")            \
-_Pragma("GCC diagnostic ignored \"-Wextra\"")              \
-_Pragma("GCC diagnostic ignored \"-Woverloaded-virtual\"") \
-_Pragma("GCC diagnostic ignored \"-Wunused-function\"")    \
-_Pragma("GCC diagnostic ignored \"-Wunused-parameter\"")   \
-_Pragma("GCC diagnostic ignored \"-Wunused-variable\"")    \
+#  define DEAL_II_DISABLE_EXTRA_DIAGNOSTICS                      \
+_Pragma("GCC diagnostic push")                                   \
+_Pragma("GCC diagnostic ignored \"-Wpragmas\"")                  \
+_Pragma("GCC diagnostic ignored \"-Wextra\"")                    \
+_Pragma("GCC diagnostic ignored \"-Woverloaded-virtual\"")       \
+_Pragma("GCC diagnostic ignored \"-Wunused-function\"")          \
+_Pragma("GCC diagnostic ignored \"-Wunused-parameter\"")         \
+_Pragma("GCC diagnostic ignored \"-Wunused-variable\"")          \
+_Pragma("GCC diagnostic ignored \"-Wunused-but-set-parameter\"") \
 _Pragma("GCC diagnostic warning \"-Wpragmas\"")
 
-#  define DEAL_II_ENABLE_EXTRA_DIAGNOSTICS                 \
+#  define DEAL_II_ENABLE_EXTRA_DIAGNOSTICS                       \
 _Pragma("GCC diagnostic pop")
 
 #else
index 7c0546cc99ef5bcc9ef42f6c9e67d780f394342b..6bcbacbc5add87e85cb335af52ad9d9c4063121f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2014 by the deal.II authors
+// Copyright (C) 2004 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
@@ -1226,6 +1226,8 @@ namespace PETScWrappers
                    const PetscScalar  *values,
                    const bool         elide_zero_values)
   {
+    (void)elide_zero_values;
+
     prepare_action(VectorOperation::insert);
 
     const PetscInt petsc_i = row;
@@ -1234,8 +1236,7 @@ namespace PETScWrappers
     PetscScalar const *col_value_ptr;
     int n_columns;
 
-    // If we don't elide zeros, the pointers
-    // are already available...
+    // If we don't elide zeros, the pointers are already available...
 #ifndef PETSC_USE_64BIT_INDICES
     if (elide_zero_values == false)
       {
@@ -1246,8 +1247,8 @@ namespace PETScWrappers
     else
 #endif
       {
-        // Otherwise, extract nonzero values in
-        // each row and get the respective index.
+        // Otherwise, extract nonzero values in each row and get the
+        // respective index.
         if (column_indices.size() < n_cols)
           {
             column_indices.resize(n_cols);
@@ -1291,16 +1292,11 @@ namespace PETScWrappers
 
     if (value == PetscScalar())
       {
-        // we have to do checkings on Insert/Add
-        // in any case
-        // to be consistent with the MPI
-        // communication model (see the comments
-        // in the documentation of
-        // TrilinosWrappers::Vector), but we can
-        // save some work if the addend is
-        // zero. However, these actions are done
-        // in case we pass on to the other
-        // function.
+        // we have to do checkings on Insert/Add in any case to be
+        // consistent with the MPI communication model (see the comments in
+        // the documentation of TrilinosWrappers::Vector), but we can save
+        // some work if the addend is zero. However, these actions are done
+        // in case we pass on to the other function.
         prepare_action(VectorOperation::add);
 
         return;
@@ -1368,10 +1364,12 @@ namespace PETScWrappers
   MatrixBase::add (const size_type    row,
                    const size_type    n_cols,
                    const size_type   *col_indices,
-                   const PetscScalar  *values,
+                   const PetscScalar *values,
                    const bool         elide_zero_values,
                    const bool          /*col_indices_are_sorted*/)
   {
+    (void)elide_zero_values;
+
     prepare_action(VectorOperation::add);
 
     const PetscInt petsc_i = row;
@@ -1380,8 +1378,7 @@ namespace PETScWrappers
     PetscScalar const *col_value_ptr;
     int n_columns;
 
-    // If we don't elide zeros, the pointers
-    // are already available...
+    // If we don't elide zeros, the pointers are already available...
 #ifndef PETSC_USE_64BIT_INDICES
     if (elide_zero_values == false)
       {
@@ -1392,8 +1389,8 @@ namespace PETScWrappers
     else
 #endif
       {
-        // Otherwise, extract nonzero values in
-        // each row and get the respective index.
+        // Otherwise, extract nonzero values in each row and get the
+        // respective index.
         if (column_indices.size() < n_cols)
           {
             column_indices.resize(n_cols);
index 9d7c076279edec35fd62b23fa09b078fe0930576..a9ad0a6b1a7916ed8a88c64e4891eb570f723c3f 100644 (file)
@@ -54,6 +54,7 @@ namespace TrilinosWrappers
     // define a helper function that queries the global ID of local ID of
     // an Epetra_BlockMap object  by calling either the 32- or 64-bit
     // function necessary.
+    inline
     int gid(const Epetra_BlockMap &map, int i)
     {
       return map.GID(i);
@@ -62,6 +63,7 @@ namespace TrilinosWrappers
     // define a helper function that queries the global ID of local ID of
     // an Epetra_BlockMap object  by calling either the 32- or 64-bit
     // function necessary.
+    inline
     long long int gid(const Epetra_BlockMap &map, int i)
     {
       return map.GID64(i);
index c8b44a438a7e5ebaa6ec99e1d74388b9815d72fb..8d987eca95612751210a2e94cc6e5846e51ad5fd 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2014 by the deal.II authors
+// Copyright (C) 2000 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
@@ -61,6 +61,7 @@ namespace
 
 
 #ifdef DEAL_II_WITH_PETSC
+    inline
     PetscScalar
     max_element (const PETScWrappers::Vector &criteria)
     {
@@ -74,6 +75,7 @@ namespace
     }
 
 
+    inline
     PetscScalar
     min_element (const PETScWrappers::Vector &criteria)
     {
@@ -89,6 +91,7 @@ namespace
 
 
 #ifdef DEAL_II_WITH_TRILINOS
+    inline
     TrilinosScalar
     max_element (const TrilinosWrappers::Vector &criteria)
     {
@@ -98,6 +101,7 @@ namespace
     }
 
 
+    inline
     TrilinosScalar
     min_element (const TrilinosWrappers::Vector &criteria)
     {
index e78afd109da25ac48cbefd0fd1d6b404de2efc1b..56568a97e0e5f4a0bf23d285693cfb69294bc1c3 100644 (file)
@@ -58,9 +58,8 @@ DEAL_II_NAMESPACE_OPEN
 namespace GridTools
 {
 
-// This anonymous namespace contains utility functions to extract the
-// triangulation from any container such as DoFHandler
-// and the like
+  // This anonymous namespace contains utility functions to extract the
+  // triangulation from any container such as DoFHandler and the like
   namespace
   {
     template<int dim, int spacedim>
@@ -113,36 +112,25 @@ namespace GridTools
   double
   diameter (const Triangulation<dim, spacedim> &tria)
   {
-    // we can't deal with distributed meshes
-    // since we don't have all vertices
-    // locally. there is one exception,
-    // however: if the mesh has never been
-    // refined. the way to test this is not to
-    // ask tria.n_levels()==1, since this is
-    // something that can happen on one
-    // processor without being true on
-    // all. however, we can ask for the global
-    // number of active cells and use that
-#ifdef DEAL_II_WITH_P4EST
+    // we can't deal with distributed meshes since we don't have all
+    // vertices locally. there is one exception, however: if the mesh has
+    // never been refined. the way to test this is not to ask
+    // tria.n_levels()==1, since this is something that can happen on one
+    // processor without being true on all. however, we can ask for the
+    // global number of active cells and use that
+#if defined(DEAL_II_WITH_P4EST) && defined(DEBUG)
     if (const parallel::distributed::Triangulation<dim,spacedim> *p_tria
         = dynamic_cast<const parallel::distributed::Triangulation<dim,spacedim>*>(&tria))
       Assert (p_tria->n_global_active_cells() == tria.n_cells(0),
               ExcNotImplemented());
 #endif
 
-    // the algorithm used simply
-    // traverses all cells and picks
-    // out the boundary vertices. it
-    // may or may not be faster to
-    // simply get all vectors, don't
-    // mark boundary vertices, and
-    // compute the distances thereof,
-    // but at least as the mesh is
-    // refined, it seems better to
-    // first mark boundary nodes, as
-    // marking is O(N) in the number of
-    // cells/vertices, while computing
-    // the maximal distance is O(N*N)
+    // the algorithm used simply traverses all cells and picks out the
+    // boundary vertices. it may or may not be faster to simply get all
+    // vectors, don't mark boundary vertices, and compute the distances
+    // thereof, but at least as the mesh is refined, it seems better to
+    // first mark boundary nodes, as marking is O(N) in the number of
+    // cells/vertices, while computing the maximal distance is O(N*N)
     const std::vector<Point<spacedim> > &vertices = tria.get_vertices ();
     std::vector<bool> boundary_vertices (vertices.size(), false);
 
@@ -156,11 +144,8 @@ namespace GridTools
           for (unsigned int i=0; i<GeometryInfo<dim>::vertices_per_face; ++i)
             boundary_vertices[cell->face(face)->vertex_index(i)] = true;
 
-    // now traverse the list of
-    // boundary vertices and check
-    // distances. since distances are
-    // symmetric, we only have to check
-    // one half
+    // now traverse the list of boundary vertices and check distances.
+    // since distances are symmetric, we only have to check one half
     double max_distance_sqr = 0;
     std::vector<bool>::const_iterator pi = boundary_vertices.begin();
     const unsigned int N = boundary_vertices.size();
index 76c6c94bcd877a85162688d78f0c27d905eef4ec..b5e0bc6a1352990a0a114bdc161a5630c0629e41 100644 (file)
@@ -822,7 +822,6 @@ 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,
@@ -831,6 +830,8 @@ namespace TrilinosWrappers
                 static_cast<size_type>(global_length(distributed_constant_modes)),
                 ExcDimensionMismatch(n_rows,
                                      global_length(distributed_constant_modes)));
+
+        (void)n_relevant_rows;
         (void)global_length;
 
         // Reshape null space as a contiguous vector of doubles so that
@@ -1076,6 +1077,9 @@ namespace TrilinosWrappers
                 ExcDimensionMismatch(n_rows,
                                      global_length(distributed_constant_modes)));
 
+        (void)n_relevant_rows;
+        (void)global_length;
+
         // Reshape null space as a contiguous vector of doubles so that
         // Trilinos can read from it.
         for (size_type d=0; d<constant_modes_dimension; ++d)

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.