]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Make some formatting more consistent. 6598/head
authorWolfgang Bangerth <bangerth@colostate.edu>
Tue, 15 May 2018 11:05:39 +0000 (19:05 +0800)
committerWolfgang Bangerth <bangerth@colostate.edu>
Tue, 15 May 2018 11:05:39 +0000 (19:05 +0800)
26 files changed:
include/deal.II/base/patterns.h
include/deal.II/base/table.h
include/deal.II/differentiation/ad/ad_number_traits.h
include/deal.II/differentiation/ad/adolc_number_types.h
include/deal.II/differentiation/ad/adolc_product_types.h
include/deal.II/matrix_free/evaluation_kernels.h
include/deal.II/matrix_free/fe_evaluation.h
include/deal.II/matrix_free/mapping_info.templates.h
include/deal.II/matrix_free/matrix_free.h
include/deal.II/matrix_free/matrix_free.templates.h
include/deal.II/matrix_free/shape_info.templates.h
include/deal.II/numerics/kdtree.h
source/fe/fe_face.cc
source/grid/grid_tools.cc
source/lac/sparsity_tools.cc
source/matrix_free/task_info.cc
source/multigrid/mg_transfer_matrix_free.cc
source/sundials/kinsol.cc
tests/lapack/full_matrix_27.cc
tests/matrix_free/multigrid_dg_periodic.cc
tests/matrix_free/multigrid_dg_sip_02.cc
tests/quick_tests/sundials-ida.cc
tests/sundials/harmonic_oscillator_01.cc
tests/zoltan/zoltan_02.cc
tests/zoltan/zoltan_03.cc
tests/zoltan/zoltan_04.cc

index d6e03cea5717490632d46cd42d40c4dc4c93000e..5e7063b81bc09ef5141977819bc4681626f1189f 100644 (file)
@@ -1492,8 +1492,8 @@ namespace Patterns
 
     namespace internal
     {
-      const std::array<std::string, 4> default_list_separator {{","  ,  ";"  ,  "|"  ,   "%"}};
-      const std::array<std::string, 4> default_map_separator {{":"  ,  "="  ,  "@"  ,   "#"}};
+      const std::array<std::string, 4> default_list_separator {{",",  ";",  "|",   "%"}};
+      const std::array<std::string, 4> default_map_separator {{":",  "=",  "@",   "#"}};
 
       //specialize a type for all of the STL containers and maps
       template <typename T>       struct is_list_compatible : std::false_type {};
index 85f1a38bef4fb871ef0c172fe3bdc8693ad973c2..7e423dd41ddab0a91245e4250273976711c4f968 100644 (file)
@@ -1633,7 +1633,7 @@ namespace TransposeTableIterators
      * Move assignment operator. This assigns a new value to the table entry at the
      * current row and column coordinates.
      */
-    const Accessor<T, false> &operator = (T&&) const;
+    const Accessor<T, false> &operator = (T &&) const;
 
     /**
      * Since we overload value() we have to explicitly use the base class
index 302923c741eb6c62614f691981c94a6f2cdbe3d1..467850f99d15f444c382bf641389c37656079b1e 100644 (file)
@@ -351,8 +351,8 @@ namespace Differentiation
         template<typename ADNumberType>
         static void
         independent_variable(const ScalarType   &in,
-                             const unsigned int ,
-                             const unsigned int ,
+                             const unsigned int,
+                             const unsigned int,
                              ADNumberType       &out)
         {
           out = in;
@@ -386,8 +386,8 @@ namespace Differentiation
         template<typename ScalarType>
         static void
         independent_variable(const ScalarType   &in,
-                             const unsigned int ,
-                             const unsigned int ,
+                             const unsigned int,
+                             const unsigned int,
                              ADNumberType       &out)
         {
           AssertThrow(false, ExcMessage("Marking for complex numbers has not yet been implemented."));
index 73779a71497b36ef3e0b5e68c4623d1f7caffa0d..33b2f397d37e5f0e447134ba1208104c88f079ea 100644 (file)
@@ -161,8 +161,8 @@ namespace Differentiation
          */
         static void
         independent_variable(const scalar_type  &in,
-                             const unsigned int ,
-                             const unsigned int ,
+                             const unsigned int,
+                             const unsigned int,
                              ADNumberType       &out)
         {
           out <<= in;
@@ -200,7 +200,7 @@ namespace Differentiation
         static void
         independent_variable(const scalar_type  &in,
                              const unsigned int  index,
-                             const unsigned int  ,
+                             const unsigned int,
                              ADNumberType       &out)
         {
           // It is important that the tapeless variables have their values set
index 4f5a343af27b05fc5d9b77dbc9c05b20ba9fab9d..c47d972593c2741fd8006ccbe4deedbe66d8678d 100644 (file)
@@ -110,7 +110,7 @@ namespace internal
   /* --- Complex double --- */
 
   template <>
-  struct ProductTypeImpl<std::complex<double> ,std::complex<adouble> >
+  struct ProductTypeImpl<std::complex<double>,std::complex<adouble> >
   {
     typedef std::complex<adouble> type;
   };
@@ -128,7 +128,7 @@ namespace internal
   };
 
   template <>
-  struct ProductTypeImpl<std::complex<adub> ,std::complex<adouble> >
+  struct ProductTypeImpl<std::complex<adub>,std::complex<adouble> >
   {
     typedef std::complex<adouble> type;
   };
@@ -142,7 +142,7 @@ namespace internal
   /* --- Complex float --- */
 
   template <>
-  struct ProductTypeImpl<std::complex<float> ,std::complex<adouble> >
+  struct ProductTypeImpl<std::complex<float>,std::complex<adouble> >
   {
     typedef std::complex<adouble> type;
   };
index 2090672dbb437c7c701bfe0c88fb229856564348..cca81827a324ef462a5484aac172e053420c9f65 100644 (file)
@@ -1010,7 +1010,7 @@ namespace internal
               Number        *gradients_quad,
               Number        *hessians_quad,
               Number *,
-              const bool     ,
+              const bool,
               const bool     evaluate_gradients,
               const bool     evaluate_hessians)
   {
index dac475894d93b6479d5c3f35e614ac245519b485..0786ccd5c8bfea7e3d8ac54fc08d94f27a5aabb7 100644 (file)
@@ -4022,7 +4022,7 @@ FEEvaluationBase<dim,n_components_,Number,is_face>
                                                       *src[comp], values_dofs[comp],
                                                       vector_selector);
       else
-        operation.process_dofs_vectorized_transpose(data->dofs_per_component_on_cell*
+        operation.process_dofs_vectorized_transpose(data->dofs_per_component_on_cell *
                                                     n_components,
                                                     dof_indices, *src[0],
                                                     &values_dofs[0][0],
index e27f3730edf7f85ddcc13f4332ea77ed22a647d7..91329cce057622f737cd087c48ae8db293ab0588 100644 (file)
@@ -1740,7 +1740,7 @@ namespace internal
 
           if (update_flags & update_quadrature_points)
             face_data_by_cells[my_q].quadrature_points.
-            resize_fast(cell_type.size()*GeometryInfo<dim>::faces_per_cell*
+            resize_fast(cell_type.size()*GeometryInfo<dim>::faces_per_cell *
                         face_data_by_cells[my_q].descriptor[0].n_q_points);
         }
 
index f1799b534f36f3250196cee377f38131791bd745..dc8ce0b82734267d74231a1237408d034e92b785 100644 (file)
@@ -2880,7 +2880,7 @@ namespace internal
 
   template <int dim, typename VectorStruct, typename Number>
   void update_ghost_values_start_block (const VectorStruct &,
-                                        const unsigned int ,
+                                        const unsigned int,
                                         std::integral_constant<bool,false>,
                                         VectorDataExchange<dim,Number> &)
   {}
@@ -2891,19 +2891,19 @@ namespace internal
   {}
   template <int dim, typename VectorStruct, typename Number>
   void update_ghost_values_finish_block (const VectorStruct &,
-                                         const unsigned int ,
+                                         const unsigned int,
                                          std::integral_constant<bool,false>,
                                          VectorDataExchange<dim,Number> &)
   {}
   template <int dim, typename VectorStruct, typename Number>
   void compress_start_block (const VectorStruct &,
-                             const unsigned int ,
+                             const unsigned int,
                              std::integral_constant<bool,false>,
                              VectorDataExchange<dim,Number> &)
   {}
   template <int dim, typename VectorStruct, typename Number>
   void compress_finish_block (const VectorStruct &,
-                              const unsigned int ,
+                              const unsigned int,
                               std::integral_constant<bool,false>,
                               VectorDataExchange<dim,Number> &)
   {}
index 7bda30fd676cf5b0bb7fb2a301c6ad4b7b545328..5a53486862cceba2d28803441baef613e8b4343a 100644 (file)
@@ -1331,7 +1331,7 @@ void MatrixFree<dim,Number>::initialize_indices
                        face_info.faces[f].cells_interior[v] != numbers::invalid_unsigned_int; ++v)
                     {
                       AssertIndexRange(face_info.faces[f].cells_interior[v],
-                                       n_macro_cells_before*
+                                       n_macro_cells_before *
                                        VectorizedArray<Number>::n_array_elements);
                       if (dof_info[no].index_storage_variants[internal::MatrixFreeFunctions::DoFInfo::dof_access_face_exterior][f] >=
                           internal::MatrixFreeFunctions::DoFInfo::IndexStorageVariants::contiguous
index 56d1bc3cb3c1ceb43f6545f3cba600b30540ce6f..60913fff8bcd3ba9f07abff95ae8f0b078981497 100644 (file)
@@ -385,7 +385,7 @@ namespace internal
         for (unsigned int j=0; j<n_q_points_1d; ++j)
           if (std::abs(get_first_array_element(shape_values[i*n_q_points_1d+j] -
                                                shape_values[(n_dofs_1d-i)*n_q_points_1d-j-1])) >
-              std::max(zero_tol, zero_tol*
+              std::max(zero_tol, zero_tol *
                        std::abs(get_first_array_element(shape_values[i*n_q_points_1d+j]))))
             return false;
 
index 988b2fb533128c1406a40b767495436451bc8d43..96267a67b8a11387f36e1266a7d6c4bc0f606069 100644 (file)
@@ -157,7 +157,7 @@ public:
    * A typedef for the actual KDTree object.
    */
   typedef
-  typename nanoflann::KDTreeSingleIndexAdaptor<nanoflann::L2_Simple_Adaptor<double, PointCloudAdaptor> ,
+  typename nanoflann::KDTreeSingleIndexAdaptor<nanoflann::L2_Simple_Adaptor<double, PointCloudAdaptor>,
            PointCloudAdaptor, dim, unsigned int>
            NanoFlannKDTree;
 
index c76fe501ac39ee6da79e150954fee9042f411b03..35dafb80f2deac1c61204b516846586403391c23 100644 (file)
@@ -84,7 +84,7 @@ FE_FaceQ<dim,spacedim>::FE_FaceQ (const unsigned int degree)
 
   // initialize unit support points (this makes it possible to assign initial
   // values to FE_FaceQ)
-  this->unit_support_points.resize(GeometryInfo<dim>::faces_per_cell*
+  this->unit_support_points.resize(GeometryInfo<dim>::faces_per_cell *
                                    this->unit_face_support_points.size());
   const unsigned int n_face_dofs = this->unit_face_support_points.size();
   for (unsigned int i=0; i<n_face_dofs; ++i)
index 84110a56bda855e1041356f12c3d4edd010ebebd..025e8b63b6318358af60b47ffe7606d60f578ad6 100644 (file)
@@ -1611,7 +1611,7 @@ next_cell:
                                  const Point<spacedim>                                                          &p,
                                  const std::vector<std::set<typename MeshType<dim,spacedim>::active_cell_iterator > > &vertex_to_cells,
                                  const std::vector<std::vector<Tensor<1,spacedim> > >                            &vertex_to_cell_centers,
-                                 const typename MeshType<dim, spacedim>::active_cell_iterator                    &cell_hint ,
+                                 const typename MeshType<dim, spacedim>::active_cell_iterator                    &cell_hint,
                                  const std::vector<bool>                                                         &marked_vertices)
   {
     std::pair<typename MeshType<dim, spacedim>::active_cell_iterator, Point<dim> > cell_and_position;
@@ -1631,7 +1631,7 @@ next_cell:
         // invalid cell, then query for the closest global vertex
         if (current_cell.state() == IteratorState::valid)
           {
-            const unsigned int closest_vertex = find_closest_vertex_of_cell<dim,spacedim>(current_cell , p);
+            const unsigned int closest_vertex = find_closest_vertex_of_cell<dim,spacedim>(current_cell, p);
             vertex_to_point = p - current_cell ->vertex(closest_vertex);
             closest_vertex_index = current_cell ->vertex_index(closest_vertex);
           }
@@ -4404,7 +4404,7 @@ next_cell:
     const auto &other_owned_idx = std::get<1>(guessed_points);
     std::map<
     unsigned int,
-             std::pair< std::vector<Point<spacedim>> , std::vector<unsigned int > > >
+             std::pair< std::vector<Point<spacedim>>, std::vector<unsigned int > > >
              other_owned_pts;
 
     for (const auto &indices: other_owned_idx)
index 5bba13cd7620db789371164e62b10b5c4fd3bd1c..084e548dd576143ac5994af4b0f47870f903e8d6 100644 (file)
@@ -173,8 +173,8 @@ namespace SparsityTools
       SparsityPattern *graph = reinterpret_cast<SparsityPattern *>(data);
       *ierr = ZOLTAN_OK;
 
-      Assert( globalID != nullptr , ExcInternalError() );
-      Assert( localID != nullptr , ExcInternalError() );
+      Assert( globalID != nullptr, ExcInternalError() );
+      Assert( localID != nullptr, ExcInternalError() );
 
       //set global degrees of freedom
       auto n_dofs = graph->n_rows();
@@ -196,7 +196,7 @@ namespace SparsityTools
 
       *ierr = ZOLTAN_OK;
 
-      Assert ( numEdges != nullptr , ExcInternalError() );
+      Assert ( numEdges != nullptr, ExcInternalError() );
 
       for (int i=0; i<num_obj; ++i)
         {
@@ -230,8 +230,8 @@ namespace SparsityTools
             //Ignore diagonal entries. Not needed for partitioning.
             if ( i != col->column() )
               {
-                Assert( nextNborGID != nullptr , ExcInternalError() );
-                Assert( nextNborProc != nullptr , ExcInternalError() );
+                Assert( nextNborGID != nullptr, ExcInternalError() );
+                Assert( nextNborProc != nullptr, ExcInternalError() );
 
                 *nextNborGID++ = col->column();
                 *nextNborProc++ = 0;    //All the vertices on processor 0
@@ -326,7 +326,7 @@ namespace SparsityTools
       (void)rc;
 
       //check for error code in partitioner
-      Assert( rc == ZOLTAN_OK , ExcInternalError() );
+      Assert( rc == ZOLTAN_OK, ExcInternalError() );
 
       //By default, all indices belong to part 0. After zoltan partition
       //some are migrated to different part ID, which is stored in export_to_part array.
@@ -440,7 +440,7 @@ namespace SparsityTools
 
     (void) rc;
     //Check for error code
-    Assert (rc == ZOLTAN_OK ,
+    Assert (rc == ZOLTAN_OK,
             ExcInternalError());
 
     //Allocate and assign color indices
index 1abe3874a68ad7fb82e9dd14220380572ad8274d..8169b59a58f0730453d8fcf23545395096fd9a4b 100644 (file)
@@ -145,7 +145,7 @@ namespace internal
 
         tbb::task *execute () override
         {
-          tbb::empty_task *root = new( tbb::task::allocate_root() )tbb::empty_task;
+          tbb::empty_task *root = new ( tbb::task::allocate_root() )tbb::empty_task;
           const unsigned int evens = task_info.partition_evens[partition];
           const unsigned int odds  = task_info.partition_odds[partition];
           const unsigned int n_blocked_workers =
@@ -157,14 +157,14 @@ namespace internal
           root->set_ref_count(evens+1);
           for (unsigned int j=0; j<evens; j++)
             {
-              worker[j] = new(root->allocate_child())
+              worker[j] = new (root->allocate_child())
               CellWork(function, task_info.
                        partition_row_index[partition]+2*j,
                        task_info, false);
               if (j>0)
                 {
                   worker[j]->set_ref_count(2);
-                  blocked_worker[j-1]->dummy = new(worker[j]->allocate_child())
+                  blocked_worker[j-1]->dummy = new (worker[j]->allocate_child())
                   tbb::empty_task;
                   worker[j-1]->spawn(*blocked_worker[j-1]);
                 }
@@ -172,7 +172,7 @@ namespace internal
                 worker[j]->set_ref_count(1);
               if (j<evens-1)
                 {
-                  blocked_worker[j] = new(worker[j]->allocate_child())
+                  blocked_worker[j] = new (worker[j]->allocate_child())
                   CellWork(function, task_info.
                            partition_row_index
                            [partition] + 2*j+1, task_info, true);
@@ -181,7 +181,7 @@ namespace internal
                 {
                   if (odds==evens)
                     {
-                      worker[evens] = new(worker[j]->allocate_child())
+                      worker[evens] = new (worker[j]->allocate_child())
                       CellWork(function, task_info.
                                partition_row_index[partition]+2*j+1,
                                task_info, false);
@@ -189,7 +189,7 @@ namespace internal
                     }
                   else
                     {
-                      tbb::empty_task *child = new(worker[j]->allocate_child())
+                      tbb::empty_task *child = new (worker[j]->allocate_child())
                       tbb::empty_task();
                       worker[j]->spawn(*child);
                     }
@@ -332,23 +332,23 @@ namespace internal
           funct.zero_dst_vector_range(numbers::invalid_unsigned_int);
           if (scheme == partition_partition)
             {
-              tbb::empty_task *root = new( tbb::task::allocate_root() )
+              tbb::empty_task *root = new ( tbb::task::allocate_root() )
               tbb::empty_task;
               root->set_ref_count(evens+1);
               std::vector<partition::PartitionWork *> worker(n_workers);
               std::vector<partition::PartitionWork *>
               blocked_worker(n_blocked_workers);
               MPICommunication *worker_compr =
-                new(root->allocate_child())MPICommunication(funct, true);
+                new (root->allocate_child())MPICommunication(funct, true);
               worker_compr->set_ref_count(1);
               for (unsigned int j=0; j<evens; j++)
                 {
                   if (j>0)
                     {
-                      worker[j] = new(root->allocate_child())
+                      worker[j] = new (root->allocate_child())
                       partition::PartitionWork (funct,2*j,*this,false);
                       worker[j]->set_ref_count(2);
-                      blocked_worker[j-1]->dummy = new(worker[j]->allocate_child())
+                      blocked_worker[j-1]->dummy = new (worker[j]->allocate_child())
                       tbb::empty_task;
                       if (j>1)
                         worker[j-1]->spawn(*blocked_worker[j-1]);
@@ -357,7 +357,7 @@ namespace internal
                     }
                   else
                     {
-                      worker[j] = new(worker_compr->allocate_child())
+                      worker[j] = new (worker_compr->allocate_child())
                       partition::PartitionWork (funct,2*j,*this,false);
                       worker[j]->set_ref_count(2);
                       MPICommunication *worker_dist =
@@ -366,20 +366,20 @@ namespace internal
                     }
                   if (j<evens-1)
                     {
-                      blocked_worker[j] = new(worker[j]->allocate_child())
+                      blocked_worker[j] = new (worker[j]->allocate_child())
                       partition::PartitionWork(funct,2*j+1,*this,true);
                     }
                   else
                     {
                       if (odds==evens)
                         {
-                          worker[evens] = new(worker[j]->allocate_child())
+                          worker[evens] = new (worker[j]->allocate_child())
                           partition::PartitionWork(funct,2*j+1,*this,false);
                           worker[j]->spawn(*worker[evens]);
                         }
                       else
                         {
-                          tbb::empty_task *child = new(worker[j]->allocate_child())
+                          tbb::empty_task *child = new (worker[j]->allocate_child())
                           tbb::empty_task();
                           worker[j]->spawn(*child);
                         }
@@ -395,7 +395,7 @@ namespace internal
               // tree of partitions
               if (odds > 0)
                 {
-                  tbb::empty_task *root = new( tbb::task::allocate_root() ) tbb::empty_task;
+                  tbb::empty_task *root = new ( tbb::task::allocate_root() ) tbb::empty_task;
                   root->set_ref_count(evens+1);
                   const unsigned int n_blocked_workers = odds-(odds+evens+1)%2;
                   const unsigned int n_workers = cell_partition_data.size()-1-
@@ -412,10 +412,10 @@ namespace internal
                     {
                       const unsigned int spawn_index_new = worker_index;
                       if (part == 0)
-                        worker[worker_index] = new(worker_compr->allocate_child())
+                        worker[worker_index] = new (worker_compr->allocate_child())
                         color::PartitionWork(funct,slice_index,*this,false);
                       else
-                        worker[worker_index] = new(root->allocate_child())
+                        worker[worker_index] = new (root->allocate_child())
                         color::PartitionWork(funct,slice_index,*this,false);
                       slice_index++;
                       for (; slice_index<partition_row_index[part+1]; slice_index++)
@@ -453,13 +453,13 @@ namespace internal
                         {
                           if (part<partition_row_index.size()-2)
                             {
-                              blocked_worker[part/2] = new(worker[worker_index-1]->allocate_child())
+                              blocked_worker[part/2] = new (worker[worker_index-1]->allocate_child())
                               color::PartitionWork(funct,slice_index,*this,true);
                               slice_index++;
                               if (slice_index<partition_row_index[part+1])
                                 {
                                   blocked_worker[part/2]->set_ref_count(1);
-                                  worker[worker_index] = new(blocked_worker[part/2]->allocate_child())
+                                  worker[worker_index] = new (blocked_worker[part/2]->allocate_child())
                                   color::PartitionWork(funct,slice_index,*this,false);
                                   slice_index++;
                                 }
@@ -508,7 +508,7 @@ namespace internal
 
                   for (unsigned int color=0; color < partition_row_index[1]; ++color)
                     {
-                      tbb::empty_task *root = new( tbb::task::allocate_root() ) tbb::empty_task;
+                      tbb::empty_task *root = new ( tbb::task::allocate_root() ) tbb::empty_task;
                       root->set_ref_count(2);
                       color::PartitionWork *worker =
                         new (root->allocate_child())color::PartitionWork(funct,color,*this,false);
index 5977fdd783055e3c16ca89ed0a404d72b683d171..97bc0016bb87d68d742f35766a1dec75405a891f 100644 (file)
@@ -452,7 +452,7 @@ void MGTransferMatrixFree<dim,Number>
           const unsigned int shift = internal::MGTransfer::compute_shift_within_children<dim>
                                      (parent_child_connect[from_level-1][cell+v].second,
                                       fe_degree+1-element_is_continuous, fe_degree);
-          AssertIndexRange(parent_child_connect[from_level-1][cell+v].first*
+          AssertIndexRange(parent_child_connect[from_level-1][cell+v].first *
                            n_child_cell_dofs+n_child_cell_dofs-1,
                            level_dof_indices[from_level-1].size());
           const unsigned int *indices = &level_dof_indices[from_level-1][parent_child_connect[from_level-1][cell+v].first*n_child_cell_dofs+shift];
index 5661507f0d6dac8257c3bf75bfa29f63dec1c848..2bbc6563b42c65643ace6df9dc64fcae7b8d3c63 100644 (file)
@@ -230,7 +230,7 @@ namespace SUNDIALS
 
     kinsol_mem = KINCreate();
 
-    int status = KINInit(kinsol_mem, t_kinsol_function<VectorType> , solution);
+    int status = KINInit(kinsol_mem, t_kinsol_function<VectorType>, solution);
     (void) status;
     AssertKINSOL(status);
 
index 64e62d469bbf1e883cbcce8a8518a355061c300b..bacb977f44ffeb5c8aa2f1c2f98ccd8e3391142f 100644 (file)
@@ -56,7 +56,7 @@ test(const unsigned int size)
     for (unsigned int j = 0; j < size; ++j)
       {
         const NumberType diff = A(i,j) + a * v(i) * v(j) - B(i,j);
-        AssertThrow(std::abs(diff) < 1e-10 * std::abs(B(i,j)) ,
+        AssertThrow(std::abs(diff) < 1e-10 * std::abs(B(i,j)),
                     ExcMessage("diff="+ std::to_string(diff)));
       }
 
index 92adece7d9281c32a5bcdf509d61b8b44e31f22b..ca3551b33da220de74ea313c78072f6b7692f615 100644 (file)
@@ -422,7 +422,7 @@ public:
     coarse_matrix = &matrix;
   }
 
-  virtual void operator() (const unsigned int ,
+  virtual void operator() (const unsigned int,
                            parallel::distributed::Vector<double> &dst,
                            const parallel::distributed::Vector<double> &src) const
   {
index d4cd524236c42a4db34a9155ab5062ba871141fb..4bfbf876d2844bc63d50165b6758af56c6d904ff 100644 (file)
@@ -344,7 +344,7 @@ public:
     coarse_matrix = &matrix;
   }
 
-  virtual void operator() (const unsigned int   ,
+  virtual void operator() (const unsigned int,
                            parallel::distributed::Vector<double> &dst,
                            const parallel::distributed::Vector<double> &src) const
   {
index c2a1b42d0b961eb91336a78e42c7f6c71eee1ab7..09ab693458406e27ffe4129ec7790b2dd11a6c8a 100644 (file)
@@ -86,7 +86,7 @@ public:
       return 0;
     };
 
-    time_stepper.setup_jacobian = [&](const double ,
+    time_stepper.setup_jacobian = [&](const double,
                                       const VectorType &,
                                       const VectorType &,
                                       const double alpha) ->int
@@ -119,7 +119,7 @@ public:
       return 0;
     };
 
-    time_stepper.solver_should_restart = [](const double ,
+    time_stepper.solver_should_restart = [](const double,
                                             VectorType &,
                                             VectorType &) ->bool
     {
index cfdf6369b33ac3b938e4648ff138af089d94ac39..ed3605f5cb209463416a965966e70a24dceea370 100644 (file)
@@ -83,7 +83,7 @@ public:
       return 0;
     };
 
-    time_stepper.setup_jacobian = [&](const double ,
+    time_stepper.setup_jacobian = [&](const double,
                                       const VectorType &,
                                       const VectorType &,
                                       const double alpha) ->int
index 3b74f380e82cd220ca8ccaa3eecaf64384ba36f4..02e4ac423a3564cc10ca99550fcc39d1dd6267b1 100644 (file)
@@ -62,7 +62,7 @@ int main (int argc, char **argv)
   SparsityPattern sp_graph;
   sp_graph.copy_from(dynamic_sparse_graph);
 
-  Assert( num_indices == sp_graph.n_rows() , ExcInternalError() );
+  Assert( num_indices == sp_graph.n_rows(), ExcInternalError() );
 
   std::vector<unsigned int> color_indices;
   unsigned int num_colors;
index 4afcb00a83eb9465589902f449aaf7f8e2bef452..3e0422237b63c8d8c86e8c50a0e1f23ed9d2eb22 100644 (file)
@@ -63,7 +63,7 @@ int main (int argc, char **argv)
   SparsityPattern sp_graph;
   sp_graph.copy_from(dynamic_sparse_graph);
 
-  Assert( num_indices == sp_graph.n_rows() , ExcInternalError() );
+  Assert( num_indices == sp_graph.n_rows(), ExcInternalError() );
 
   std::vector<unsigned int> color_indices;
   unsigned int num_colors;
index 5cb73181bc6c906cbcfcb83e2ead84aab5965d37..e310875d59277860f13594290155f840099adab3 100644 (file)
@@ -56,7 +56,7 @@ int main (int argc, char **argv)
   SparsityPattern sp_graph;
   sp_graph.copy_from(dynamic_sparse_graph);
 
-  Assert( num_indices == sp_graph.n_rows() , ExcInternalError() );
+  Assert( num_indices == sp_graph.n_rows(), ExcInternalError() );
 
   std::vector<unsigned int> color_indices;
   unsigned int num_colors;

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.