From cd10662b285087acaab1589b02b12b68a1160dbb Mon Sep 17 00:00:00 2001 From: David Wells Date: Thu, 3 May 2018 20:26:57 -0400 Subject: [PATCH] Remove extra semicolons. --- include/deal.II/base/thread_management.h | 2 +- .../deal.II/lac/constraint_matrix.templates.h | 2 +- .../deal.II/lac/vector_operations_internal.h | 4 +- include/deal.II/matrix_free/matrix_free.h | 2 +- include/deal.II/numerics/solution_transfer.h | 6 +-- source/grid/grid_generator.cc | 38 +++++++++---------- source/matrix_free/task_info.cc | 11 ++++-- 7 files changed, 34 insertions(+), 31 deletions(-) diff --git a/include/deal.II/base/thread_management.h b/include/deal.II/base/thread_management.h index 325c488fdc..1f76292b0a 100644 --- a/include/deal.II/base/thread_management.h +++ b/include/deal.II/base/thread_management.h @@ -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 () {} }; /** diff --git a/include/deal.II/lac/constraint_matrix.templates.h b/include/deal.II/lac/constraint_matrix.templates.h index d9cfc0503c..781173d749 100644 --- a/include/deal.II/lac/constraint_matrix.templates.h +++ b/include/deal.II/lac/constraint_matrix.templates.h @@ -974,7 +974,7 @@ namespace internals bool operator < (const Distributing &in) const { return global_row &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 diff --git a/include/deal.II/matrix_free/matrix_free.h b/include/deal.II/matrix_free/matrix_free.h index f6519b45d6..ed36ce5772 100644 --- a/include/deal.II/matrix_free/matrix_free.h +++ b/include/deal.II/matrix_free/matrix_free.h @@ -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. diff --git a/include/deal.II/numerics/solution_transfer.h b/include/deal.II/numerics/solution_transfer.h index b70a510bab..e983ccb79d 100644 --- a/include/deal.II/numerics/solution_transfer.h +++ b/include/deal.II/numerics/solution_transfer.h @@ -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 *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 > *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 *indices_ptr; diff --git a/source/grid/grid_generator.cc b/source/grid/grid_generator.cc index d7730847e9..cd8471e8a6 100644 --- a/source/grid/grid_generator.cc +++ b/source/grid/grid_generator.cc @@ -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 >(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 >(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 >(std::begin(vertices), std::end(vertices)), @@ -2366,7 +2366,7 @@ namespace GridGenerator vertices[i] += center; vertices[i+N] += center; - }; + } std::vector > 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 >(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 >(std::begin(vertices), std::end(vertices)), @@ -2624,7 +2624,7 @@ namespace GridGenerator vertices[i] += center; vertices[i+N+1] += center; - }; + } std::vector > 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 > 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 >(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 >(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 >(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 >(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 >(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 >(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 >(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 > vertices_3d; vertices_3d.reserve (2*N_r*(N_z+1)); diff --git a/source/matrix_free/task_info.cc b/source/matrix_free/task_info.cc index aac1c06235..478e950254 100644 --- a/source/matrix_free/task_info.cc +++ b/source/matrix_free/task_info.cc @@ -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 &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 () { -- 2.39.5