]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Indent correctly. 7060/head
authorWolfgang Bangerth <bangerth@colostate.edu>
Tue, 14 Aug 2018 15:22:30 +0000 (09:22 -0600)
committerWolfgang Bangerth <bangerth@colostate.edu>
Tue, 14 Aug 2018 15:22:30 +0000 (09:22 -0600)
include/deal.II/dofs/dof_tools.h
include/deal.II/grid/grid_generator.h
include/deal.II/grid/grid_tools.h
include/deal.II/multigrid/mg_tools.h
include/deal.II/numerics/matrix_tools.h
include/deal.II/numerics/vector_tools.h

index 3bad1c8312accef4ad719a3c779bb8f588116716..908244c760f5f99e7c3d4efc8eb8e980672fa755 100644 (file)
@@ -1943,12 +1943,11 @@ namespace DoFTools
    */
   template <int dim, int spacedim>
   void
-  make_cell_patches(
-    SparsityPattern &                block_list,
-    const DoFHandler<dim, spacedim> &dof_handler,
-    const unsigned int               level,
-    const std::vector<bool> &        selected_dofs = {},
-    const types::global_dof_index    offset        = 0);
+  make_cell_patches(SparsityPattern &                block_list,
+                    const DoFHandler<dim, spacedim> &dof_handler,
+                    const unsigned int               level,
+                    const std::vector<bool> &        selected_dofs = {},
+                    const types::global_dof_index    offset        = 0);
 
   /**
    * Create an incidence matrix that for every vertex on a given level of a
@@ -2156,7 +2155,7 @@ namespace DoFTools
     const DoFHandlerType &                dof_handler,
     std::vector<types::global_dof_index> &dofs_per_component,
     const bool                            vector_valued_once = false,
-    std::vector<unsigned int> target_component = {});
+    std::vector<unsigned int>             target_component   = {});
 
   /**
    * Count the degrees of freedom in each block. This function is similar to
index 1d087408ed725903e2f9f7263052684cb9c45db6..c27491d3fc8d0d264d401810c821b6e1f4133347 100644 (file)
@@ -484,12 +484,11 @@ namespace GridGenerator
    */
   template <int dim, int spacedim>
   void
-  subdivided_parallelepiped(
-    Triangulation<dim, spacedim> &              tria,
-    const Point<spacedim> &                     origin,
-    const std::array<Tensor<1, spacedim>, dim> &edges,
-    const std::vector<unsigned int> &subdivisions = {},
-    const bool                       colorize     = false);
+  subdivided_parallelepiped(Triangulation<dim, spacedim> &              tria,
+                            const Point<spacedim> &                     origin,
+                            const std::array<Tensor<1, spacedim>, dim> &edges,
+                            const std::vector<unsigned int> &subdivisions = {},
+                            const bool                       colorize = false);
 
   /**
    * Hypercube with a layer of hypercubes around it. The first two parameters
index 32b2a1c789850849191dde3d3c053719c49445e9..44adc18cc72386ed4a867861cf7abee35eb439bc 100644 (file)
@@ -889,10 +889,9 @@ namespace GridTools
    */
   template <int dim, template <int, int> class MeshType, int spacedim>
   unsigned int
-  find_closest_vertex(
-    const MeshType<dim, spacedim> &mesh,
-    const Point<spacedim> &        p,
-    const std::vector<bool> &      marked_vertices = {});
+  find_closest_vertex(const MeshType<dim, spacedim> &mesh,
+                      const Point<spacedim> &        p,
+                      const std::vector<bool> &      marked_vertices = {});
 
   /**
    * Find and return the index of the used vertex (or marked vertex) in a
@@ -921,11 +920,10 @@ namespace GridTools
    */
   template <int dim, template <int, int> class MeshType, int spacedim>
   unsigned int
-  find_closest_vertex(
-    const Mapping<dim, spacedim> & mapping,
-    const MeshType<dim, spacedim> &mesh,
-    const Point<spacedim> &        p,
-    const std::vector<bool> &      marked_vertices = {});
+  find_closest_vertex(const Mapping<dim, spacedim> & mapping,
+                      const MeshType<dim, spacedim> &mesh,
+                      const Point<spacedim> &        p,
+                      const std::vector<bool> &      marked_vertices = {});
 
 
   /**
@@ -992,13 +990,13 @@ namespace GridTools
 #  ifndef _MSC_VER
   typename MeshType<dim, spacedim>::active_cell_iterator
 #  else
-  typename dealii::internal::
-    ActiveCellIterator<dim, spacedim, MeshType<dim, spacedim>>::type
+  typename dealii::internal::ActiveCellIterator<dim,
+                                                spacedim,
+                                                MeshType<dim, spacedim>>::type
 #  endif
-  find_active_cell_around_point(
-    const MeshType<dim, spacedim> &mesh,
-    const Point<spacedim> &        p,
-    const std::vector<bool> &      marked_vertices = {});
+  find_active_cell_around_point(const MeshType<dim, spacedim> &mesh,
+                                const Point<spacedim> &        p,
+                                const std::vector<bool> &marked_vertices = {});
 
   /**
    * Find and return an iterator to the active cell that surrounds a given
@@ -1094,11 +1092,10 @@ namespace GridTools
               ActiveCellIterator<dim, spacedim, MeshType<dim, spacedim>>::type,
             Point<dim>>
 #  endif
-  find_active_cell_around_point(
-    const Mapping<dim, spacedim> & mapping,
-    const MeshType<dim, spacedim> &mesh,
-    const Point<spacedim> &        p,
-    const std::vector<bool> &      marked_vertices = {});
+  find_active_cell_around_point(const Mapping<dim, spacedim> & mapping,
+                                const MeshType<dim, spacedim> &mesh,
+                                const Point<spacedim> &        p,
+                                const std::vector<bool> &marked_vertices = {});
 
   /**
    * A version of the previous function that exploits an already existing
index 0d19320aca66ac1f2f66856a94e8c4f6b475a3e9..6ce52178c5d4e93d4ff12d183c23b5fb73988204 100644 (file)
@@ -169,7 +169,7 @@ namespace MGTools
   count_dofs_per_block(
     const DoFHandlerType &                             dof_handler,
     std::vector<std::vector<types::global_dof_index>> &dofs_per_block,
-    std::vector<unsigned int> target_block = {});
+    std::vector<unsigned int>                          target_block = {});
 
   /**
    * Count the dofs component-wise on each level.
@@ -183,8 +183,8 @@ namespace MGTools
   count_dofs_per_component(
     const DoFHandler<dim, spacedim> &                  mg_dof,
     std::vector<std::vector<types::global_dof_index>> &result,
-    const bool                                         only_once = false,
-    std::vector<unsigned int> target_component = {});
+    const bool                                         only_once        = false,
+    std::vector<unsigned int>                          target_component = {});
 
   /**
    * Generate a list of those degrees of freedom at the boundary of the domain
index e7e7f1d3b9f8e91fb4cf29661f2ff3196a09367f..8aae306fe03a75ceb10c5826e1446ea9a5942b3e 100644 (file)
@@ -410,8 +410,8 @@ namespace MatrixCreator
       &                                     boundary_functions,
     Vector<number> &                        rhs_vector,
     std::vector<types::global_dof_index> &  dof_to_boundary_mapping,
-    const Function<spacedim, number> *const weight = 0,
-    std::vector<unsigned int> component_mapping = {});
+    const Function<spacedim, number> *const weight            = 0,
+    std::vector<unsigned int>               component_mapping = {});
 
 
   /**
@@ -428,8 +428,8 @@ namespace MatrixCreator
       &                                     boundary_functions,
     Vector<number> &                        rhs_vector,
     std::vector<types::global_dof_index> &  dof_to_boundary_mapping,
-    const Function<spacedim, number> *const a   = nullptr,
-    std::vector<unsigned int> component_mapping = {});
+    const Function<spacedim, number> *const a                 = nullptr,
+    std::vector<unsigned int>               component_mapping = {});
 
   /**
    * Same function as above, but for hp objects.
@@ -445,8 +445,8 @@ namespace MatrixCreator
       &                                     boundary_functions,
     Vector<number> &                        rhs_vector,
     std::vector<types::global_dof_index> &  dof_to_boundary_mapping,
-    const Function<spacedim, number> *const a   = nullptr,
-    std::vector<unsigned int> component_mapping = {});
+    const Function<spacedim, number> *const a                 = nullptr,
+    std::vector<unsigned int>               component_mapping = {});
 
   /**
    * Same function as above, but for hp objects.
@@ -461,8 +461,8 @@ namespace MatrixCreator
       &                                     boundary_functions,
     Vector<number> &                        rhs_vector,
     std::vector<types::global_dof_index> &  dof_to_boundary_mapping,
-    const Function<spacedim, number> *const a   = nullptr,
-    std::vector<unsigned int> component_mapping = {});
+    const Function<spacedim, number> *const a                 = nullptr,
+    std::vector<unsigned int>               component_mapping = {});
 
   /**
    * Assemble the Laplace matrix. If no coefficient is given (i.e., if the
index 8625c536ce7a8bdeefb8ffac26bc2dc391e8334f..4da7e520699869ff8913ffed9515373411529292 100644 (file)
@@ -1356,7 +1356,7 @@ namespace VectorTools
       &                                        boundary_functions,
     const Quadrature<dim - 1> &                q,
     std::map<types::global_dof_index, number> &boundary_values,
-    std::vector<unsigned int> component_mapping = {});
+    std::vector<unsigned int>                  component_mapping = {});
 
   /**
    * Call the project_boundary_values() function, see above, with
@@ -1370,7 +1370,7 @@ namespace VectorTools
       &                                        boundary_function,
     const Quadrature<dim - 1> &                q,
     std::map<types::global_dof_index, number> &boundary_values,
-    std::vector<unsigned int> component_mapping = {});
+    std::vector<unsigned int>                  component_mapping = {});
 
   /**
    * Same as above, but for objects of type hp::DoFHandler
@@ -1384,7 +1384,7 @@ namespace VectorTools
       &                                        boundary_functions,
     const hp::QCollection<dim - 1> &           q,
     std::map<types::global_dof_index, number> &boundary_values,
-    std::vector<unsigned int> component_mapping = {});
+    std::vector<unsigned int>                  component_mapping = {});
 
   /**
    * Call the project_boundary_values() function, see above, with
@@ -1398,7 +1398,7 @@ namespace VectorTools
       &                                        boundary_function,
     const hp::QCollection<dim - 1> &           q,
     std::map<types::global_dof_index, number> &boundary_values,
-    std::vector<unsigned int> component_mapping = {});
+    std::vector<unsigned int>                  component_mapping = {});
 
   /**
    * Project a function to the boundary of the domain, using the given
@@ -3054,8 +3054,7 @@ namespace VectorTools
    */
   template <typename VectorType>
   void
-  subtract_mean_value(VectorType &             v,
-                      const std::vector<bool> &p_select = {});
+  subtract_mean_value(VectorType &v, const std::vector<bool> &p_select = {});
 
 
   /**

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.