]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Remove some unnecessary semicolons.
authorDavid Wells <drwells@email.unc.edu>
Fri, 28 Sep 2018 18:55:48 +0000 (14:55 -0400)
committerDavid Wells <drwells@email.unc.edu>
Fri, 28 Sep 2018 19:37:19 +0000 (15:37 -0400)
include/deal.II/lac/sparse_vanka.templates.h
source/dofs/dof_tools_constraints.cc

index 030899d631fa7d8695812f4ace80c13c0aaa6aae..6f5f9cfdd1efd16052795616213f17ccb5965d14 100644 (file)
@@ -148,8 +148,8 @@ SparseVanka<number>::compute_inverses()
           ++thread;
 
           c = 0;
-        };
-    };
+        }
+    }
   blocking[n_threads - 1].second = matrix->m();
 
   using FunPtr =
@@ -292,7 +292,7 @@ SparseVanka<number>::apply_preconditioner(
           {
             inverses[row] = &local_matrix;
             inverses[row]->reinit(row_length, row_length);
-          };
+          }
 
         b.reinit(row_length);
         x.reinit(row_length);
@@ -491,10 +491,10 @@ SparseBlockVanka<number>::compute_dof_masks(
               ++block;
 
               c = 0;
-            };
-        };
+            }
+        }
       intervals[n_blocks - 1].second = M.m();
-    };
+    }
 
   // now transfer the knowledge on
   // the splitting points into the
@@ -511,7 +511,7 @@ SparseBlockVanka<number>::compute_dof_masks(
                         intervals[block].second - intervals[block].first,
                         true);
           break;
-        };
+        }
 
       case adaptive:
         {
@@ -556,7 +556,7 @@ SparseBlockVanka<number>::compute_dof_masks(
                 const size_type row_length = structure.row_length(row);
                 for (size_type i = 0; i < row_length; ++i)
                   ++access_count[block_number][structure.column_number(row, i)];
-              };
+              }
 
           // now we know that block @p i
           // wants to write to DoF @p j
@@ -591,16 +591,16 @@ SparseBlockVanka<number>::compute_dof_masks(
                     {
                       max_accesses     = access_count[block][row];
                       max_access_block = block;
-                    };
+                    }
                 dof_masks[max_access_block][row] = true;
-              };
+              }
 
           break;
-        };
+        }
 
       default:
         Assert(false, ExcInternalError());
-    };
+    }
 }
 
 
index f00260accaaa5ffdc8c1e82eadc7807182ac4e72..8f5a2af38f3998dbdd5e5175fbfe137b78666b2a 100644 (file)
@@ -3048,7 +3048,7 @@ namespace DoFTools
               {
                 parameter_dofs[local_coarse_dof](fine_dof) = 1.;
                 break;
-              };
+              }
 
 
         // find out how many DoFs there are on the grids belonging to the
@@ -3074,12 +3074,12 @@ namespace DoFTools
                     if (fine_fe.system_to_component_index(i).first ==
                         fine_component)
                       dof_is_interesting[local_dof_indices[i]] = true;
-                };
+                }
 
             n_parameters_on_fine_grid = std::count(dof_is_interesting.begin(),
                                                    dof_is_interesting.end(),
                                                    true);
-          };
+          }
 
 
         // set up the weights mapping
@@ -3112,12 +3112,12 @@ namespace DoFTools
                       {
                         weight_mapping[local_dof_indices[i]] = next_free_index;
                         ++next_free_index;
-                      };
-                };
+                      }
+                }
 
             Assert(next_free_index == n_parameters_on_fine_grid,
                    ExcInternalError());
-          };
+          }
 
 
         // for each cell on the parameter grid: find out which degrees of
@@ -3158,7 +3158,7 @@ namespace DoFTools
             Assert((std::fabs(sum - 1) < 1.e-12) ||
                      ((coarse_fe.n_components() > 1) && (sum == 0)),
                    ExcInternalError());
-          };
+          }
 #endif
 
 
@@ -3281,7 +3281,7 @@ namespace DoFTools
           // consistency check: if this is no parameter dof on the coarse grid,
           // then the respective row must be empty!
           Assert(weights[parameter_dof].size() == 0, ExcInternalError());
-        };
+        }
 
 
 
@@ -3341,10 +3341,10 @@ namespace DoFTools
                 weights[row].find(col);
               if ((j != weights[row].end()) && (j->second != 0))
                 constraint_line.emplace_back(representants[row], j->second);
-            };
+            }
 
           constraints.add_entries(global_dof, constraint_line);
-        };
+        }
   }
 
 
@@ -3419,8 +3419,8 @@ namespace DoFTools
                    ExcInternalError());
 
             inverse_weight_mapping[parameter_dof] = i;
-          };
-      };
+          }
+      }
 
     // next copy over weights array and replace respective numbers
     const types::global_dof_index n_rows = weight_mapping.size();
@@ -3439,8 +3439,8 @@ namespace DoFTools
             Assert(p < n_rows, ExcInternalError());
 
             transfer_representation[p][i] = j->second;
-          };
-      };
+          }
+      }
   }
 
 

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.