]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Remove extra semicolons.
authorDavid Wells <wellsd2@rpi.edu>
Fri, 4 May 2018 00:26:57 +0000 (20:26 -0400)
committerDavid Wells <wellsd2@rpi.edu>
Fri, 4 May 2018 00:26:57 +0000 (20:26 -0400)
include/deal.II/base/thread_management.h
include/deal.II/lac/constraint_matrix.templates.h
include/deal.II/lac/vector_operations_internal.h
include/deal.II/matrix_free/matrix_free.h
include/deal.II/numerics/solution_transfer.h
source/grid/grid_generator.cc
source/matrix_free/task_info.cc

index 325c488fdc75b3410fc2d6bc6b7169b38a75da5e..1f76292b0a5a0a17a76b8ef600ef1fbae07b7a8e 100644 (file)
@@ -106,7 +106,7 @@ namespace Threads
        * of course does nothing. We still don't declare it as 'default' to avoid
        * warnings about objects of this class being unused.
        */
-      ~ScopedLock () {};
+      ~ScopedLock () {}
     };
 
     /**
index d9cfc0503c0fd582491d93d2995f75a5866fa191..781173d7492d15385a425a12d667d3bd3911b249 100644 (file)
@@ -974,7 +974,7 @@ namespace internals
     bool operator < (const Distributing &in) const
     {
       return global_row<in.global_row;
-    };
+    }
 
     size_type global_row;
     size_type local_row;
index 4c07dadf32501594814b966cab6bb9e3454ad982..b1999069c97ee526794711218c0e3b716413a873 100644 (file)
@@ -140,7 +140,7 @@ namespace internal
         n_chunks = (vec_size + chunk_size - 1) / chunk_size;
         AssertIndexRange((n_chunks-1)*chunk_size, vec_size);
         AssertIndexRange(vec_size, n_chunks*chunk_size+1);
-      };
+      }
 
       void operator() (const tbb::blocked_range<size_type> &range) const
       {
@@ -1235,7 +1235,7 @@ namespace internal
           }
         else
           array_ptr = &small_array[0];
-      };
+      }
 
       /**
        * An operator used by TBB to work on a given @p range of chunks
index f6519b45d67ab61d10e2da603e66b6070da70274..ed36ce57725bc5fd278069f23e2c07cc84b7f82a 100644 (file)
@@ -220,7 +220,7 @@ public:
       overlap_communication_computation(overlap_communication_computation),
       hold_all_faces_to_owned_cells(hold_all_faces_to_owned_cells),
       cell_vectorization_categories_strict(cell_vectorization_categories_strict)
-    {};
+    {}
 
     /**
      * Set the scheme for task parallelism. There are four options available.
index b70a510bab4972f044c19c76356bb2ebc9d6a9c6..e983ccb79df29a5790f159e4fbadfcd6acf9a655 100644 (file)
@@ -480,18 +480,18 @@ private:
    */
   struct Pointerstruct
   {
-    Pointerstruct() : indices_ptr(nullptr), dof_values_ptr(nullptr), active_fe_index(0) {};
+    Pointerstruct() : indices_ptr(nullptr), dof_values_ptr(nullptr), active_fe_index(0) {}
     Pointerstruct(std::vector<types::global_dof_index> *indices_ptr_in,
                   const unsigned int active_fe_index_in = 0)
       :
       indices_ptr(indices_ptr_in),
       dof_values_ptr (nullptr),
-      active_fe_index(active_fe_index_in) {};
+      active_fe_index(active_fe_index_in) {}
     Pointerstruct(std::vector<Vector<typename VectorType::value_type> > *dof_values_ptr_in,
                   const unsigned int active_fe_index_in = 0) :
       indices_ptr (nullptr),
       dof_values_ptr(dof_values_ptr_in),
-      active_fe_index(active_fe_index_in) {};
+      active_fe_index(active_fe_index_in) {}
     std::size_t memory_consumption () const;
 
     std::vector<types::global_dof_index>    *indices_ptr;
index d7730847e99af561affe18044da8aacb29759057..cd8471e8a62225e011a6931860f9aab3c76ed551 100644 (file)
@@ -2159,7 +2159,7 @@ namespace GridGenerator
         for (unsigned int j=0; j<4; ++j)
           cells[i].vertices[j] = cell_vertices[i][j];
         cells[i].material_id = 0;
-      };
+      }
     tria.create_triangulation (
       std::vector<Point<2> >(std::begin(vertices), std::end(vertices)),
       cells,
@@ -2243,7 +2243,7 @@ namespace GridGenerator
         for (unsigned int j=0; j<4; ++j)
           cells[i].vertices[j] = cell_vertices[i][j];
         cells[i].material_id = 0;
-      };
+      }
 
     tria.create_triangulation (
       std::vector<Point<2> >(std::begin(vertices), std::end(vertices)),
@@ -2309,7 +2309,7 @@ namespace GridGenerator
           cells[i].vertices[j] = cell_vertices[i][j];
         cells[i].material_id = 0;
         cells[i].manifold_id = i==2 ? 1 : numbers::flat_manifold_id;
-      };
+      }
 
     tria.create_triangulation (
       std::vector<Point<2> >(std::begin(vertices), std::end(vertices)),
@@ -2366,7 +2366,7 @@ namespace GridGenerator
 
         vertices[i]   += center;
         vertices[i+N] += center;
-      };
+      }
 
     std::vector<CellData<2> > cells (N, CellData<2>());
 
@@ -2378,7 +2378,7 @@ namespace GridGenerator
         cells[i].vertices[3] = N+((i+1)%N);
 
         cells[i].material_id = 0;
-      };
+      }
 
     tria.create_triangulation (
       vertices, cells, SubCellData());
@@ -2472,7 +2472,7 @@ namespace GridGenerator
         for (unsigned int j=0; j<4; ++j)
           cells[i].vertices[j] = cell_vertices[i][j];
         cells[i].material_id = 0;
-      };
+      }
 
     tria.create_triangulation (
       std::vector<Point<dim> >(std::begin(vertices), std::end(vertices)),
@@ -2539,7 +2539,7 @@ namespace GridGenerator
         for (unsigned int j=0; j<4; ++j)
           cells[i].vertices[j] = cell_vertices[i][j];
         cells[i].material_id = 0;
-      };
+      }
 
     tria.create_triangulation (
       std::vector<Point<2> >(std::begin(vertices), std::end(vertices)),
@@ -2624,7 +2624,7 @@ namespace GridGenerator
 
         vertices[i]     += center;
         vertices[i+N+1] += center;
-      };
+      }
 
 
     std::vector<CellData<2> > cells (N, CellData<2>());
@@ -2637,7 +2637,7 @@ namespace GridGenerator
         cells[i].vertices[3] = N+1+((i+1)%(N+1));
 
         cells[i].material_id = 0;
-      };
+      }
 
     tria.create_triangulation (vertices, cells, SubCellData());
 
@@ -2706,7 +2706,7 @@ namespace GridGenerator
 
         vertices[i]     += center;
         vertices[i+N+1] += center;
-      };
+      }
 
 
     std::vector<CellData<2> > cells (N, CellData<2>());
@@ -2719,7 +2719,7 @@ namespace GridGenerator
         cells[i].vertices[3] = N+1+((i+1)%(N+1));
 
         cells[i].material_id = 0;
-      };
+      }
 
     tria.create_triangulation (vertices, cells, SubCellData());
 
@@ -2785,7 +2785,7 @@ namespace GridGenerator
         for (unsigned int j=0; j<8; ++j)
           cells[i].vertices[j] = cell_vertices[i][j];
         cells[i].material_id = 0;
-      };
+      }
     tria.create_triangulation (
       std::vector<Point<3> >(std::begin(vertices), std::end(vertices)),
       cells,
@@ -3012,7 +3012,7 @@ namespace GridGenerator
         for (unsigned int j=0; j<8; ++j)
           cells[i].vertices[j] = cell_vertices[i][j];
         cells[i].material_id = 0;
-      };
+      }
 
     tria.create_triangulation (
       std::vector<Point<3> >(std::begin(vertices), std::end(vertices)),
@@ -3084,7 +3084,7 @@ namespace GridGenerator
           cells[i].vertices[j] = cell_vertices[i][j];
         cells[i].material_id = 0;
         cells[i].manifold_id = i == 0 ? numbers::flat_manifold_id : 1;
-      };
+      }
 
     tria.create_triangulation (
       std::vector<Point<3> >(std::begin(vertices), std::end(vertices)),
@@ -3181,7 +3181,7 @@ namespace GridGenerator
         for (unsigned int j=0; j<8; ++j)
           cells[i].vertices[j] = cell_vertices[i][j];
         cells[i].material_id = 0;
-      };
+      }
 
     tria.create_triangulation (
       std::vector<Point<3> >(std::begin(vertices), std::end(vertices)),
@@ -3284,7 +3284,7 @@ namespace GridGenerator
         for (unsigned int j=0; j<8; ++j)
           cells[i].vertices[j] = cell_vertices[i][j];
         cells[i].material_id = 0;
-      };
+      }
 
     tria.create_triangulation (
       std::vector<Point<dim> >(std::begin(vertices), std::end(vertices)),
@@ -3391,7 +3391,7 @@ namespace GridGenerator
         for (unsigned int j=0; j<8; ++j)
           cells[i].vertices[j] = cell_vertices[i][j];
         cells[i].material_id = 0;
-      };
+      }
 
     tria.create_triangulation (
       std::vector<Point<3> >(std::begin(vertices), std::end(vertices)),
@@ -3739,7 +3739,7 @@ namespace GridGenerator
             for (unsigned int j=0; j<8; ++j)
               cells[i].vertices[j] = cell_vertices[i][j];
             cells[i].material_id = 0;
-          };
+          }
 
         tria.create_triangulation (
           std::vector<Point<3> >(std::begin(vertices), std::end(vertices)),
@@ -3901,7 +3901,7 @@ namespace GridGenerator
         vertices_2d[i] = Point<2>( std::cos(2*pi * i/N_r),
                                    std::sin(2*pi * i/N_r)) * outer_radius;
         vertices_2d[i+N_r] = vertices_2d[i] * (inner_radius/outer_radius);
-      };
+      }
 
     std::vector<Point<3> > vertices_3d;
     vertices_3d.reserve (2*N_r*(N_z+1));
index aac1c06235edba0122fd3378ef5d4420dbb76103..478e95025448f800d410a0bfb55ed1fecf6bdf94 100644 (file)
@@ -141,7 +141,8 @@ namespace internal
           partition (partition_in),
           task_info (task_info_in),
           is_blocked (is_blocked_in)
-        {};
+        {}
+
         tbb::task *execute ()
         {
           tbb::empty_task *root = new( tbb::task::allocate_root() )tbb::empty_task;
@@ -227,7 +228,8 @@ namespace internal
           worker (worker_in),
           task_info (task_info_in),
           partition (partition_in)
-        {};
+        {}
+
         void operator()(const tbb::blocked_range<unsigned int> &r) const
         {
           const unsigned int start_index = task_info.cell_partition_data[partition]
@@ -263,7 +265,8 @@ namespace internal
           partition (partition_in),
           task_info (task_info_in),
           is_blocked (is_blocked_in)
-        {};
+        {}
+
         tbb::task *execute ()
         {
           const unsigned int n_chunks = (task_info.cell_partition_data[partition+1]-
@@ -297,7 +300,7 @@ namespace internal
         :
         worker(worker_in),
         do_compress(do_compress)
-      {};
+      {}
 
       tbb::task *execute ()
       {

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.