]> https://gitweb.dealii.org/ - dealii.git/commit
Change some indentation oddities. 4470/head
authorWolfgang Bangerth <bangerth@colostate.edu>
Fri, 2 Jun 2017 16:32:36 +0000 (10:32 -0600)
committerWolfgang Bangerth <bangerth@colostate.edu>
Fri, 2 Jun 2017 16:32:36 +0000 (10:32 -0600)
commitd512e44e92c9a4d79f9af81ba0c1971a3c047f34
treee2380c8196f628a504752b080e0c6fee7ba2e747
parent0eab0bf9869c8294cba2eecf499c56bf1971ee16
Change some indentation oddities.

The majority of these are related to space before comma. I did all of
this by first running astyle 3.0.1 to see what it changes, and then
running astyle 2.04 as usual again. 3.0.1 fixes up a few oddities
that 2.04 doesn't undo, and most of these are probably worthwhile
keeping.

There are some corner cases where we had purposefully aligned commas
with leading spaces, and one could consider not making this change,
or updating it by hand. But I don't feel strongly enough about
this to really go to lengths here.
76 files changed:
examples/step-24/step-24.cc
examples/step-45/step-45.cc
examples/step-47/step-47.cc
include/deal.II/base/tensor_deprecated.h
include/deal.II/dofs/dof_accessor.templates.h
include/deal.II/fe/fe_poly_face.templates.h
include/deal.II/grid/tria.h
include/deal.II/grid/tria_accessor.templates.h
include/deal.II/lac/block_sparsity_pattern.h
include/deal.II/lac/diagonal_matrix.h
include/deal.II/lac/la_vector.templates.h
include/deal.II/lac/solver_gmres.h
include/deal.II/matrix_free/evaluation_kernels.h
include/deal.II/matrix_free/matrix_free.h
include/deal.II/meshworker/assembler.h
include/deal.II/numerics/vector_tools.templates.h
include/deal.II/physics/transformations.h
source/base/tensor_product_polynomials.cc
source/base/tensor_product_polynomials_bubbles.cc
source/base/tensor_product_polynomials_const.cc
source/dofs/dof_tools_constraints.inst.in
source/fe/fe.cc
source/fe/fe_dgp.cc
source/fe/fe_dgp_monomial.cc
source/fe/fe_dgp_nonparametric.cc
source/fe/fe_dgq.cc
source/fe/fe_face.cc
source/fe/fe_nothing.cc
source/fe/fe_p1nc.cc
source/fe/fe_poly_tensor.cc
source/fe/fe_q_base.cc
source/fe/fe_system.cc
source/fe/fe_tools.inst.in
source/fe/fe_values.cc
source/fe/mapping_fe_field.cc
source/fe/mapping_q.cc
source/fe/mapping_q1_eulerian.cc
source/fe/mapping_q_eulerian.cc
source/grid/grid_generator.cc
source/grid/grid_tools.cc
source/grid/grid_tools.inst.in
source/grid/tria.cc
source/lac/constraint_matrix.cc
source/lac/petsc_parallel_sparse_matrix.cc
source/lac/petsc_precondition.cc
source/lac/sparsity_pattern.cc
source/lac/trilinos_sparse_matrix.cc
source/numerics/error_estimator.inst.in
source/numerics/error_estimator_1d.inst.in
source/opencascade/utilities.cc
tests/base/product_type_04.cc
tests/base/product_type_04_symmetric.cc
tests/dofs/interpolate_q_system_02.cc
tests/dofs/interpolate_q_system_mask_02.cc
tests/fe/fe_enriched_compare_to_fe_system.cc
tests/fe/fe_enriched_compare_to_fe_system_2.cc
tests/full_matrix/full_matrix_56.cc
tests/gla/vec_03.cc
tests/grid/build_triangulation_from_patch_01.cc
tests/grid/build_triangulation_from_patch_02.cc
tests/grid/build_triangulation_from_patch_03.cc
tests/grid/build_triangulation_from_patch_04.cc
tests/grid/get_cells_at_coarsest_common_level_02.cc
tests/grid/grid_test.cc
tests/hp/fe_nothing_18.cc
tests/integrators/advection_01.cc
tests/lac/constraints.cc
tests/lac/schur_complement_05.cc
tests/matrix_free/create_mesh.h
tests/matrix_free/matrix_vector_stokes.cc
tests/matrix_free/matrix_vector_stokes_qdg0.cc
tests/mpi/muelu_periodicity.cc
tests/mpi/periodic_neighbor_01.cc
tests/mpi/periodicity_02.cc
tests/mpi/periodicity_03.cc
tests/trilinos/trilinos_sparsity_pattern_02.cc

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.