From aacdd9811ae25645729be7ddf50d5c9bfba0044a Mon Sep 17 00:00:00 2001 From: Wolfgang Bangerth Date: Tue, 14 Aug 2018 09:22:30 -0600 Subject: [PATCH] Indent correctly. --- include/deal.II/dofs/dof_tools.h | 13 ++++----- include/deal.II/grid/grid_generator.h | 11 ++++---- include/deal.II/grid/grid_tools.h | 37 ++++++++++++------------- include/deal.II/multigrid/mg_tools.h | 6 ++-- include/deal.II/numerics/matrix_tools.h | 16 +++++------ include/deal.II/numerics/vector_tools.h | 11 ++++---- 6 files changed, 44 insertions(+), 50 deletions(-) diff --git a/include/deal.II/dofs/dof_tools.h b/include/deal.II/dofs/dof_tools.h index 3bad1c8312..908244c760 100644 --- a/include/deal.II/dofs/dof_tools.h +++ b/include/deal.II/dofs/dof_tools.h @@ -1943,12 +1943,11 @@ namespace DoFTools */ template void - make_cell_patches( - SparsityPattern & block_list, - const DoFHandler &dof_handler, - const unsigned int level, - const std::vector & selected_dofs = {}, - const types::global_dof_index offset = 0); + make_cell_patches(SparsityPattern & block_list, + const DoFHandler &dof_handler, + const unsigned int level, + const std::vector & 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 &dofs_per_component, const bool vector_valued_once = false, - std::vector target_component = {}); + std::vector target_component = {}); /** * Count the degrees of freedom in each block. This function is similar to diff --git a/include/deal.II/grid/grid_generator.h b/include/deal.II/grid/grid_generator.h index 1d087408ed..c27491d3fc 100644 --- a/include/deal.II/grid/grid_generator.h +++ b/include/deal.II/grid/grid_generator.h @@ -484,12 +484,11 @@ namespace GridGenerator */ template void - subdivided_parallelepiped( - Triangulation & tria, - const Point & origin, - const std::array, dim> &edges, - const std::vector &subdivisions = {}, - const bool colorize = false); + subdivided_parallelepiped(Triangulation & tria, + const Point & origin, + const std::array, dim> &edges, + const std::vector &subdivisions = {}, + const bool colorize = false); /** * Hypercube with a layer of hypercubes around it. The first two parameters diff --git a/include/deal.II/grid/grid_tools.h b/include/deal.II/grid/grid_tools.h index 32b2a1c789..44adc18cc7 100644 --- a/include/deal.II/grid/grid_tools.h +++ b/include/deal.II/grid/grid_tools.h @@ -889,10 +889,9 @@ namespace GridTools */ template class MeshType, int spacedim> unsigned int - find_closest_vertex( - const MeshType &mesh, - const Point & p, - const std::vector & marked_vertices = {}); + find_closest_vertex(const MeshType &mesh, + const Point & p, + const std::vector & marked_vertices = {}); /** * Find and return the index of the used vertex (or marked vertex) in a @@ -921,11 +920,10 @@ namespace GridTools */ template class MeshType, int spacedim> unsigned int - find_closest_vertex( - const Mapping & mapping, - const MeshType &mesh, - const Point & p, - const std::vector & marked_vertices = {}); + find_closest_vertex(const Mapping & mapping, + const MeshType &mesh, + const Point & p, + const std::vector & marked_vertices = {}); /** @@ -992,13 +990,13 @@ namespace GridTools # ifndef _MSC_VER typename MeshType::active_cell_iterator # else - typename dealii::internal:: - ActiveCellIterator>::type + typename dealii::internal::ActiveCellIterator>::type # endif - find_active_cell_around_point( - const MeshType &mesh, - const Point & p, - const std::vector & marked_vertices = {}); + find_active_cell_around_point(const MeshType &mesh, + const Point & p, + const std::vector &marked_vertices = {}); /** * Find and return an iterator to the active cell that surrounds a given @@ -1094,11 +1092,10 @@ namespace GridTools ActiveCellIterator>::type, Point> # endif - find_active_cell_around_point( - const Mapping & mapping, - const MeshType &mesh, - const Point & p, - const std::vector & marked_vertices = {}); + find_active_cell_around_point(const Mapping & mapping, + const MeshType &mesh, + const Point & p, + const std::vector &marked_vertices = {}); /** * A version of the previous function that exploits an already existing diff --git a/include/deal.II/multigrid/mg_tools.h b/include/deal.II/multigrid/mg_tools.h index 0d19320aca..6ce52178c5 100644 --- a/include/deal.II/multigrid/mg_tools.h +++ b/include/deal.II/multigrid/mg_tools.h @@ -169,7 +169,7 @@ namespace MGTools count_dofs_per_block( const DoFHandlerType & dof_handler, std::vector> &dofs_per_block, - std::vector target_block = {}); + std::vector target_block = {}); /** * Count the dofs component-wise on each level. @@ -183,8 +183,8 @@ namespace MGTools count_dofs_per_component( const DoFHandler & mg_dof, std::vector> &result, - const bool only_once = false, - std::vector target_component = {}); + const bool only_once = false, + std::vector target_component = {}); /** * Generate a list of those degrees of freedom at the boundary of the domain diff --git a/include/deal.II/numerics/matrix_tools.h b/include/deal.II/numerics/matrix_tools.h index e7e7f1d3b9..8aae306fe0 100644 --- a/include/deal.II/numerics/matrix_tools.h +++ b/include/deal.II/numerics/matrix_tools.h @@ -410,8 +410,8 @@ namespace MatrixCreator & boundary_functions, Vector & rhs_vector, std::vector & dof_to_boundary_mapping, - const Function *const weight = 0, - std::vector component_mapping = {}); + const Function *const weight = 0, + std::vector component_mapping = {}); /** @@ -428,8 +428,8 @@ namespace MatrixCreator & boundary_functions, Vector & rhs_vector, std::vector & dof_to_boundary_mapping, - const Function *const a = nullptr, - std::vector component_mapping = {}); + const Function *const a = nullptr, + std::vector component_mapping = {}); /** * Same function as above, but for hp objects. @@ -445,8 +445,8 @@ namespace MatrixCreator & boundary_functions, Vector & rhs_vector, std::vector & dof_to_boundary_mapping, - const Function *const a = nullptr, - std::vector component_mapping = {}); + const Function *const a = nullptr, + std::vector component_mapping = {}); /** * Same function as above, but for hp objects. @@ -461,8 +461,8 @@ namespace MatrixCreator & boundary_functions, Vector & rhs_vector, std::vector & dof_to_boundary_mapping, - const Function *const a = nullptr, - std::vector component_mapping = {}); + const Function *const a = nullptr, + std::vector component_mapping = {}); /** * Assemble the Laplace matrix. If no coefficient is given (i.e., if the diff --git a/include/deal.II/numerics/vector_tools.h b/include/deal.II/numerics/vector_tools.h index 8625c536ce..4da7e52069 100644 --- a/include/deal.II/numerics/vector_tools.h +++ b/include/deal.II/numerics/vector_tools.h @@ -1356,7 +1356,7 @@ namespace VectorTools & boundary_functions, const Quadrature & q, std::map &boundary_values, - std::vector component_mapping = {}); + std::vector component_mapping = {}); /** * Call the project_boundary_values() function, see above, with @@ -1370,7 +1370,7 @@ namespace VectorTools & boundary_function, const Quadrature & q, std::map &boundary_values, - std::vector component_mapping = {}); + std::vector component_mapping = {}); /** * Same as above, but for objects of type hp::DoFHandler @@ -1384,7 +1384,7 @@ namespace VectorTools & boundary_functions, const hp::QCollection & q, std::map &boundary_values, - std::vector component_mapping = {}); + std::vector component_mapping = {}); /** * Call the project_boundary_values() function, see above, with @@ -1398,7 +1398,7 @@ namespace VectorTools & boundary_function, const hp::QCollection & q, std::map &boundary_values, - std::vector component_mapping = {}); + std::vector component_mapping = {}); /** * Project a function to the boundary of the domain, using the given @@ -3054,8 +3054,7 @@ namespace VectorTools */ template void - subtract_mean_value(VectorType & v, - const std::vector &p_select = {}); + subtract_mean_value(VectorType &v, const std::vector &p_select = {}); /** -- 2.39.5