From 1cf6caded52e7f5103207744292ce995c9155f1e Mon Sep 17 00:00:00 2001 From: Wolfgang Bangerth Date: Tue, 27 Jun 2017 19:38:45 -0600 Subject: [PATCH] Make coding style more uniform. --- examples/step-26/step-26.cc | 20 ++-- examples/step-34/step-34.cc | 4 +- include/deal.II/base/data_out_base.h | 14 +-- include/deal.II/base/function_lib.h | 20 ++-- include/deal.II/base/function_time.h | 2 +- .../deal.II/base/function_time.templates.h | 8 +- include/deal.II/base/memory_consumption.h | 4 +- include/deal.II/base/mg_level_object.h | 22 ++-- include/deal.II/base/point.h | 4 +- include/deal.II/base/polynomial_space.h | 4 +- include/deal.II/base/quadrature.h | 2 +- include/deal.II/base/quadrature_point_data.h | 28 ++--- include/deal.II/base/quadrature_selector.h | 2 +- include/deal.II/base/smartpointer.h | 2 +- include/deal.II/base/table.h | 2 +- include/deal.II/base/table_handler.h | 4 +- include/deal.II/base/tensor.h | 18 +-- include/deal.II/base/tensor_accessors.h | 30 ++--- include/deal.II/base/utilities.h | 8 +- include/deal.II/base/vectorization.h | 6 +- include/deal.II/dofs/dof_accessor.templates.h | 54 ++++----- include/deal.II/dofs/dof_faces.h | 8 +- include/deal.II/dofs/dof_handler.h | 8 +- include/deal.II/dofs/dof_tools.h | 12 +- include/deal.II/dofs/function_map.h | 2 +- include/deal.II/fe/fe_tools.h | 4 +- include/deal.II/fe/mapping_c1.h | 2 +- include/deal.II/fe/mapping_manifold.h | 2 +- include/deal.II/fe/mapping_q_generic.h | 8 +- include/deal.II/grid/cell_id.h | 4 +- include/deal.II/grid/grid_generator.h | 2 +- include/deal.II/grid/grid_reordering.h | 6 +- include/deal.II/grid/grid_tools.h | 28 ++--- include/deal.II/grid/tria.h | 6 +- include/deal.II/grid/tria_accessor.h | 4 +- include/deal.II/grid/tria_faces.h | 8 +- include/deal.II/grid/tria_levels.h | 2 +- include/deal.II/grid/tria_objects.h | 20 ++-- include/deal.II/hp/dof_faces.h | 8 +- include/deal.II/hp/dof_handler.h | 4 +- include/deal.II/hp/mapping_collection.h | 8 +- include/deal.II/integrators/advection.h | 2 +- include/deal.II/integrators/divergence.h | 10 +- include/deal.II/integrators/elasticity.h | 2 +- include/deal.II/integrators/grad_div.h | 2 +- include/deal.II/integrators/laplace.h | 6 +- include/deal.II/lac/block_linear_operator.h | 10 +- include/deal.II/lac/block_matrix_array.h | 2 +- include/deal.II/lac/block_sparse_matrix_ez.h | 2 +- include/deal.II/lac/block_vector.h | 2 +- include/deal.II/lac/chunk_sparse_matrix.h | 4 +- .../lac/chunk_sparse_matrix.templates.h | 2 +- include/deal.II/lac/constraint_matrix.h | 6 +- .../deal.II/lac/constraint_matrix.templates.h | 26 ++--- include/deal.II/lac/filtered_matrix.h | 14 +-- include/deal.II/lac/householder.h | 16 +-- include/deal.II/lac/lapack_full_matrix.h | 10 +- include/deal.II/lac/lapack_templates.h | 40 +++---- include/deal.II/lac/linear_operator.h | 6 +- include/deal.II/lac/matrix_block.h | 8 +- include/deal.II/lac/matrix_lib.h | 6 +- .../deal.II/lac/petsc_parallel_block_vector.h | 2 +- include/deal.II/lac/petsc_parallel_vector.h | 2 +- include/deal.II/lac/pointer_matrix.h | 72 ++++++------ include/deal.II/lac/precondition.h | 98 ++++++++-------- include/deal.II/lac/precondition_block.h | 42 +++---- .../lac/precondition_block.templates.h | 2 +- include/deal.II/lac/relaxation_block.h | 18 +-- include/deal.II/lac/solver.h | 6 +- include/deal.II/lac/solver_bicgstab.h | 22 ++-- include/deal.II/lac/solver_cg.h | 6 +- include/deal.II/lac/solver_gmres.h | 24 ++-- include/deal.II/lac/solver_minres.h | 16 +-- include/deal.II/lac/solver_qmrs.h | 22 ++-- include/deal.II/lac/solver_relaxation.h | 2 +- include/deal.II/lac/solver_richardson.h | 4 +- include/deal.II/lac/solver_selector.h | 4 +- include/deal.II/lac/sparse_decomposition.h | 2 +- .../lac/sparse_decomposition.templates.h | 10 +- include/deal.II/lac/sparse_matrix.templates.h | 2 +- include/deal.II/lac/sparse_matrix_ez.h | 10 +- include/deal.II/lac/sparse_vanka.h | 20 ++-- include/deal.II/lac/sparse_vanka.templates.h | 16 +-- include/deal.II/lac/tridiagonal_matrix.h | 12 +- .../lac/trilinos_block_sparse_matrix.h | 2 +- .../deal.II/lac/trilinos_linear_operator.h | 2 +- .../lac/trilinos_parallel_block_vector.h | 2 +- include/deal.II/lac/trilinos_solver.h | 4 +- include/deal.II/lac/trilinos_sparse_matrix.h | 18 +-- .../deal.II/lac/trilinos_sparsity_pattern.h | 10 +- include/deal.II/lac/trilinos_vector.h | 2 +- include/deal.II/lac/vector.h | 2 +- include/deal.II/lac/vector_memory.h | 6 +- include/deal.II/lac/vector_memory.templates.h | 10 +- include/deal.II/lac/vector_type_traits.h | 2 +- include/deal.II/lac/vector_view.h | 16 +-- include/deal.II/matrix_free/fe_evaluation.h | 20 ++-- .../deal.II/matrix_free/helper_functions.h | 2 +- .../matrix_free/mapping_info.templates.h | 2 +- include/deal.II/matrix_free/matrix_free.h | 42 +++---- include/deal.II/matrix_free/operators.h | 2 +- include/deal.II/meshworker/assembler.h | 12 +- include/deal.II/meshworker/dof_info.h | 12 +- include/deal.II/meshworker/functional.h | 8 +- include/deal.II/meshworker/integration_info.h | 10 +- .../meshworker/integration_info.templates.h | 14 +-- include/deal.II/meshworker/loop.h | 8 +- include/deal.II/meshworker/output.h | 6 +- include/deal.II/meshworker/simple.h | 14 +-- include/deal.II/meshworker/vector_selector.h | 2 +- include/deal.II/multigrid/mg_coarse.h | 62 +++++----- include/deal.II/multigrid/mg_smoother.h | 6 +- include/deal.II/multigrid/mg_transfer_block.h | 4 +- include/deal.II/multigrid/multigrid.h | 38 +++--- .../deal.II/numerics/dof_print_solver_step.h | 6 +- include/deal.II/numerics/matrix_tools.h | 6 +- include/deal.II/numerics/solution_transfer.h | 6 +- include/deal.II/numerics/vector_tools.h | 4 +- .../deal.II/numerics/vector_tools.templates.h | 30 ++--- include/deal.II/physics/transformations.h | 12 +- source/base/data_out_base.cc | 40 +++---- source/base/flow_function.cc | 40 +++---- source/base/function_lib.cc | 108 +++++++++--------- source/base/function_lib_cutoff.cc | 32 +++--- source/base/geometry_info.cc | 40 +++---- source/base/polynomials_nedelec.cc | 8 +- source/base/quadrature.cc | 8 +- source/base/quadrature_lib.cc | 8 +- source/base/tensor_product_polynomials.cc | 2 +- source/distributed/solution_transfer.cc | 28 ++--- source/distributed/tria.cc | 4 +- source/dofs/dof_handler.cc | 84 +++++++------- source/dofs/dof_tools.cc | 12 +- source/dofs/dof_tools_constraints.cc | 8 +- source/fe/fe_data.cc | 2 +- source/fe/fe_dgp_monomial.cc | 2 +- source/fe/fe_tools.cc | 16 +-- source/fe/mapping.cc | 2 +- source/fe/mapping_c1.cc | 6 +- source/fe/mapping_cartesian.cc | 36 +++--- source/fe/mapping_fe_field.cc | 68 +++++------ source/fe/mapping_manifold.cc | 46 ++++---- source/fe/mapping_q.cc | 40 +++---- source/fe/mapping_q1.cc | 6 +- source/fe/mapping_q1_eulerian.cc | 4 +- source/fe/mapping_q_eulerian.cc | 2 +- source/fe/mapping_q_generic.cc | 78 ++++++------- source/grid/grid_generator.cc | 18 +-- source/grid/grid_in.cc | 4 +- source/grid/grid_reordering.cc | 12 +- source/grid/grid_tools.cc | 42 +++---- source/grid/manifold.cc | 2 +- source/grid/tria.cc | 4 +- source/grid/tria_accessor.cc | 4 +- source/grid/tria_boundary_lib.cc | 28 ++--- source/grid/tria_objects.cc | 8 +- source/hp/dof_handler.cc | 46 ++++---- source/hp/mapping_collection.cc | 14 +-- source/lac/constraint_matrix.cc | 2 +- source/lac/tridiagonal_matrix.cc | 24 ++-- source/lac/trilinos_solver.cc | 6 +- source/lac/trilinos_sparsity_pattern.cc | 4 +- source/multigrid/mg_transfer_matrix_free.cc | 4 +- source/multigrid/mg_transfer_prebuilt.cc | 6 +- source/multigrid/multigrid.cc | 4 +- source/numerics/solution_transfer.cc | 22 ++-- source/opencascade/boundary_lib.cc | 8 +- tests/aniso/fe_tools.cc | 6 +- tests/aniso/solution_transfer.cc | 2 +- tests/base/anisotropic_1.cc | 2 +- tests/base/cell_data_storage_01.cc | 6 +- tests/base/cell_data_storage_02.cc | 4 +- tests/base/data_out_base.cc | 4 +- tests/base/data_out_base_dx.cc | 2 +- tests/base/data_out_base_eps.cc | 2 +- tests/base/data_out_base_gmv.cc | 2 +- tests/base/data_out_base_gnuplot.cc | 2 +- tests/base/data_out_base_gnuplot_labels.cc | 2 +- tests/base/data_out_base_gnuplot_labels_02.cc | 2 +- tests/base/data_out_base_povray.cc | 2 +- tests/base/data_out_base_tecplot.cc | 2 +- tests/base/data_out_base_tecplot_bin.cc | 2 +- tests/base/data_out_base_vtk.cc | 2 +- tests/base/data_out_base_vtk_cycle.cc | 2 +- tests/base/data_out_base_vtk_time.cc | 2 +- .../base/data_out_base_vtk_time_and_cycle.cc | 2 +- tests/base/data_out_base_vtu.cc | 2 +- .../data_out_base_vtu_compression_levels.cc | 2 +- tests/base/data_out_base_vtu_cycle.cc | 2 +- tests/base/data_out_base_vtu_time.cc | 2 +- .../base/data_out_base_vtu_time_and_cycle.cc | 2 +- tests/base/derivative_forms_01.cc | 2 +- tests/base/derivative_forms_02.cc | 2 +- tests/base/derivative_forms_03.cc | 2 +- tests/base/derivative_forms_04.cc | 2 +- tests/base/function_derivative.cc | 6 +- tests/base/functions.h | 10 +- tests/base/functions_04.cc | 2 +- tests/base/functions_09.cc | 8 +- tests/base/functions_constant_function_00.cc | 2 +- tests/base/functions_singularity.cc | 4 +- tests/base/functions_spherical_01.cc | 4 +- tests/base/functions_spherical_02.cc | 4 +- tests/base/geometry_info_8.cc | 4 +- tests/base/memory_consumption_02.cc | 4 +- tests/base/polynomial_test.cc | 2 +- tests/base/polynomials_tensor.cc | 6 +- tests/base/qprojector.cc | 6 +- tests/base/quadrature_chebyshev.cc | 4 +- tests/base/quadrature_point_data.cc | 6 +- tests/base/quadrature_point_data_02.cc | 6 +- tests/base/quadrature_point_data_03.cc | 6 +- tests/base/symmetric_tensor_36.cc | 30 ++--- tests/base/symmetric_tensor_37.cc | 6 +- tests/base/table_05.cc | 2 +- tests/base/work_stream_03.cc | 6 +- tests/base/work_stream_03_graph.cc | 6 +- tests/bits/deal_solver_04.cc | 2 +- tests/bits/deal_solver_05.cc | 2 +- tests/bits/error_estimator_01.cc | 2 +- tests/bits/error_estimator_02.cc | 2 +- tests/bits/fe_field_function_04.cc | 2 +- tests/bits/fe_field_function_04_vector.cc | 2 +- tests/bits/fe_field_function_05.cc | 2 +- tests/bits/fe_field_function_05_vector.cc | 2 +- tests/bits/fe_field_function_06_vector.cc | 2 +- tests/bits/fe_field_function_07_vector.cc | 2 +- tests/bits/fe_field_function_08_vector.cc | 2 +- tests/bits/fe_system.cc | 2 +- tests/bits/point_difference_01.cc | 4 +- tests/bits/point_difference_02.cc | 4 +- tests/bits/point_gradient_01.cc | 4 +- tests/bits/point_gradient_02.cc | 4 +- tests/bits/point_gradient_hp_01.cc | 4 +- tests/bits/point_gradient_hp_02.cc | 4 +- tests/bits/point_value_01.cc | 4 +- tests/bits/point_value_02.cc | 4 +- tests/bits/point_value_hp_01.cc | 4 +- tests/bits/point_value_hp_02.cc | 4 +- tests/bits/solution_transfer.cc | 2 +- tests/codim_one/bem.cc | 2 +- tests/codim_one/error_estimator_01.cc | 4 +- tests/codim_one/error_estimator_02.cc | 6 +- tests/codim_one/mapping_fe_field_01.cc | 2 +- tests/distributed_grids/2d_coarse_grid_01.cc | 2 +- tests/distributed_grids/2d_coarse_grid_02.cc | 2 +- tests/distributed_grids/2d_coarse_grid_03.cc | 2 +- tests/distributed_grids/2d_coarse_grid_04.cc | 2 +- .../distributed_grids/2d_coarse_grid_x_01.cc | 2 +- tests/distributed_grids/2d_coarsening_01.cc | 2 +- tests/distributed_grids/2d_coarsening_02.cc | 2 +- tests/distributed_grids/2d_coarsening_03.cc | 2 +- tests/distributed_grids/2d_coarsening_05.cc | 2 +- tests/distributed_grids/2d_dofhandler_01.cc | 2 +- tests/distributed_grids/2d_refinement_01.cc | 2 +- tests/distributed_grids/2d_refinement_02.cc | 2 +- tests/distributed_grids/2d_refinement_03.cc | 2 +- tests/distributed_grids/2d_refinement_04.cc | 2 +- tests/distributed_grids/2d_refinement_05.cc | 2 +- tests/distributed_grids/2d_refinement_06.cc | 2 +- tests/distributed_grids/2d_refinement_07.cc | 2 +- tests/distributed_grids/2d_refinement_10.cc | 12 +- tests/distributed_grids/3d_coarse_grid_01.cc | 2 +- tests/distributed_grids/3d_coarse_grid_02.cc | 2 +- tests/distributed_grids/3d_coarse_grid_03.cc | 2 +- tests/distributed_grids/3d_coarse_grid_04.cc | 2 +- tests/distributed_grids/3d_coarse_grid_05.cc | 2 +- tests/distributed_grids/3d_coarse_grid_06.cc | 2 +- .../distributed_grids/3d_coarse_grid_x_01.cc | 2 +- tests/distributed_grids/3d_coarsening_01.cc | 2 +- tests/distributed_grids/3d_coarsening_02.cc | 2 +- tests/distributed_grids/3d_coarsening_03.cc | 2 +- tests/distributed_grids/3d_coarsening_04.cc | 2 +- tests/distributed_grids/3d_coarsening_05.cc | 2 +- tests/distributed_grids/3d_refinement_01.cc | 2 +- tests/distributed_grids/3d_refinement_02.cc | 2 +- tests/distributed_grids/3d_refinement_03.cc | 2 +- tests/distributed_grids/3d_refinement_04.cc | 2 +- tests/distributed_grids/3d_refinement_05.cc | 2 +- tests/distributed_grids/3d_refinement_06.cc | 2 +- tests/distributed_grids/3d_refinement_07.cc | 2 +- tests/distributed_grids/3d_refinement_08.cc | 2 +- tests/distributed_grids/3d_refinement_09.cc | 2 +- tests/distributed_grids/3d_refinement_12.cc | 12 +- tests/distributed_grids/anisotropic.cc | 2 +- tests/distributed_grids/codim_01.cc | 2 +- tests/distributed_grids/copy_tria_01.cc | 2 +- .../count_dofs_per_block_01.cc | 2 +- .../count_dofs_per_component_01.cc | 2 +- .../dof_handler_number_cache.cc | 2 +- .../distributed_grids/solution_transfer_01.cc | 2 +- .../distributed_grids/solution_transfer_02.cc | 4 +- .../distributed_grids/solution_transfer_03.cc | 4 +- .../distributed_grids/solution_transfer_04.cc | 2 +- tests/distributed_grids/tria_settings_01.cc | 4 +- .../update_number_cache_01.cc | 2 +- tests/dofs/accessor_01.cc | 4 +- tests/dofs/block_info.cc | 2 +- tests/dofs/block_info_02.cc | 2 +- tests/dofs/count_dofs_on_patch.cc | 2 +- tests/dofs/dof_handler_number_cache.cc | 2 +- tests/dofs/dof_handler_number_cache_02.cc | 2 +- tests/dofs/dof_tools_21_b.cc | 2 +- tests/dofs/dof_tools_21_b_x.cc | 2 +- tests/dofs/dof_tools_21_b_x_q3.cc | 2 +- tests/dofs/dof_tools_21_b_y.cc | 2 +- tests/dofs/dof_tools_21_c.cc | 2 +- ...t_dofs_with_support_contained_within_01.cc | 2 +- ...t_dofs_with_support_contained_within_02.cc | 2 +- ...t_dofs_with_support_contained_within_03.cc | 6 +- ...t_dofs_with_support_contained_within_04.cc | 4 +- tests/dofs/get_dofs_on_patch.cc | 2 +- .../locally_relevant_dofs_per_subdomain_01.cc | 2 +- tests/dofs/range_based_for_tria.cc | 2 +- tests/fail/rt_4.cc | 2 +- tests/fail/vectors_boundary_rhs_hp_02.cc | 2 +- tests/fail/vectors_rhs_hp_02.cc | 2 +- tests/fe/abf_03.cc | 2 +- tests/fe/bdm_1.cc | 2 +- tests/fe/bdm_10.cc | 2 +- tests/fe/bdm_11.cc | 2 +- tests/fe/bdm_12.cc | 2 +- tests/fe/bdm_13.cc | 2 +- tests/fe/bdm_14.cc | 2 +- tests/fe/bdm_15.cc | 2 +- tests/fe/bdm_16.cc | 2 +- tests/fe/bdm_2.cc | 2 +- tests/fe/bdm_3.cc | 2 +- tests/fe/bdm_5.cc | 2 +- tests/fe/bdm_8.cc | 2 +- tests/fe/bdm_9.cc | 2 +- tests/fe/cell_similarity_01.cc | 2 +- tests/fe/cell_similarity_02.cc | 2 +- tests/fe/cell_similarity_03.cc | 2 +- tests/fe/cell_similarity_04.cc | 2 +- tests/fe/cell_similarity_05.cc | 2 +- tests/fe/cell_similarity_06.cc | 2 +- tests/fe/cell_similarity_07.cc | 2 +- tests/fe/cell_similarity_08.cc | 2 +- tests/fe/cell_similarity_09.cc | 2 +- tests/fe/cell_similarity_10.cc | 2 +- tests/fe/cell_similarity_11.cc | 2 +- tests/fe/cell_similarity_dgp_monomial_01.cc | 2 +- tests/fe/cell_similarity_dgp_monomial_02.cc | 2 +- tests/fe/cell_similarity_dgp_monomial_03.cc | 2 +- tests/fe/cell_similarity_dgp_monomial_04.cc | 2 +- tests/fe/cell_similarity_dgp_monomial_05.cc | 2 +- tests/fe/cell_similarity_dgp_monomial_06.cc | 2 +- tests/fe/cell_similarity_dgp_monomial_07.cc | 2 +- tests/fe/cell_similarity_dgp_monomial_08.cc | 2 +- tests/fe/cell_similarity_dgp_monomial_09.cc | 2 +- tests/fe/cell_similarity_dgp_monomial_10.cc | 2 +- .../cell_similarity_dgp_nonparametric_01.cc | 2 +- .../cell_similarity_dgp_nonparametric_02.cc | 2 +- .../cell_similarity_dgp_nonparametric_03.cc | 2 +- .../cell_similarity_dgp_nonparametric_04.cc | 2 +- .../cell_similarity_dgp_nonparametric_05.cc | 2 +- .../cell_similarity_dgp_nonparametric_06.cc | 2 +- .../cell_similarity_dgp_nonparametric_07.cc | 2 +- .../cell_similarity_dgp_nonparametric_08.cc | 2 +- .../cell_similarity_dgp_nonparametric_09.cc | 2 +- .../cell_similarity_dgp_nonparametric_10.cc | 2 +- tests/fe/copy_01.cc | 2 +- tests/fe/curl_curl_01.cc | 12 +- tests/fe/derivatives.cc | 6 +- tests/fe/derivatives_bernstein.cc | 4 +- tests/fe/derivatives_face.cc | 6 +- tests/fe/dgp_01.cc | 2 +- tests/fe/dgp_monomial_1.cc | 2 +- tests/fe/dgp_monomial_2.cc | 2 +- tests/fe/dgq_1.cc | 2 +- tests/fe/element_constant_modes.cc | 4 +- tests/fe/face_to_cell_q1_2d.cc | 2 +- tests/fe/face_to_cell_q2_2d.cc | 2 +- tests/fe/face_to_cell_q2xq2_2d.cc | 2 +- tests/fe/face_to_cell_q3_2d.cc | 2 +- tests/fe/face_to_cell_q3xq4_2d.cc | 2 +- tests/fe/face_to_cell_q4_2d.cc | 2 +- .../fe/fe_abf_gradient_divergence_theorem.cc | 6 +- tests/fe/fe_data_test.cc | 2 +- ...e_dgp_3rd_derivative_divergence_theorem.cc | 6 +- ...e_dgq_3rd_derivative_divergence_theorem.cc | 6 +- .../fe/fe_dgq_gradient_divergence_theorem.cc | 6 +- tests/fe/fe_dgq_hessian_divergence_theorem.cc | 6 +- tests/fe/fe_enriched_01.cc | 4 +- tests/fe/fe_enriched_02.cc | 4 +- tests/fe/fe_enriched_03.cc | 2 +- tests/fe/fe_enriched_04.cc | 4 +- tests/fe/fe_enriched_05.cc | 2 +- tests/fe/fe_enriched_06.cc | 2 +- tests/fe/fe_enriched_07.cc | 2 +- tests/fe/fe_enriched_08.cc | 4 +- tests/fe/fe_enriched_08a.cc | 2 +- tests/fe/fe_enriched_compare_to_fe_system.cc | 4 +- .../fe/fe_enriched_compare_to_fe_system_2.cc | 4 +- tests/fe/fe_enriched_step-36.cc | 8 +- tests/fe/fe_enriched_step-36b.cc | 8 +- tests/fe/fe_face_values_1d.cc | 6 +- .../fe_nedelec_gradient_divergence_theorem.cc | 6 +- .../fe_nedelec_hessian_divergence_theorem.cc | 6 +- tests/fe/fe_nothing.cc | 2 +- tests/fe/fe_project_2d.cc | 6 +- tests/fe/fe_project_3d.cc | 8 +- .../fe_q_3rd_derivative_divergence_theorem.cc | 6 +- tests/fe/fe_q_dg0.cc | 2 +- tests/fe/fe_q_gradient_divergence_theorem.cc | 6 +- tests/fe/fe_q_hessian_divergence_theorem.cc | 6 +- ...hical_3rd_derivative_divergence_theorem.cc | 6 +- tests/fe/fe_rt_gradient_divergence_theorem.cc | 6 +- tests/fe/fe_rt_hessian_divergence_theorem.cc | 6 +- tests/fe/fe_series_02.cc | 6 +- tests/fe/fe_series_04.cc | 6 +- tests/fe/fe_series_05.cc | 8 +- ...ystem_3rd_derivative_divergence_theorem.cc | 6 +- tests/fe/fe_tools.cc | 10 +- tests/fe/fe_tools_block_renumbering.cc | 4 +- tests/fe/fe_tools_test.cc | 2 +- tests/fe/fe_values_no_mapping.cc | 2 +- tests/fe/fe_values_view_01.cc | 4 +- tests/fe/fe_values_view_02.cc | 4 +- tests/fe/fe_values_view_03.cc | 4 +- tests/fe/fe_values_view_04.cc | 4 +- tests/fe/fe_values_view_05.cc | 4 +- tests/fe/fe_values_view_06.cc | 4 +- tests/fe/fe_values_view_07.cc | 4 +- tests/fe/fe_values_view_08.cc | 4 +- tests/fe/fe_values_view_09.cc | 4 +- tests/fe/fe_values_view_10.cc | 4 +- tests/fe/fe_values_view_10_single_01.cc | 4 +- tests/fe/fe_values_view_10_single_02.cc | 4 +- tests/fe/fe_values_view_10_single_03.cc | 4 +- tests/fe/fe_values_view_11.cc | 4 +- tests/fe/fe_values_view_12.cc | 4 +- tests/fe/fe_values_view_13.cc | 4 +- tests/fe/fe_values_view_14.cc | 4 +- tests/fe/fe_values_view_15.cc | 4 +- tests/fe/fe_values_view_16.cc | 4 +- tests/fe/fe_values_view_17.cc | 4 +- tests/fe/fe_values_view_18.cc | 4 +- tests/fe/fe_values_view_19.cc | 4 +- tests/fe/fe_values_view_20.cc | 4 +- tests/fe/fe_values_view_23.cc | 4 +- tests/fe/fe_values_view_23_nonsymmetric.cc | 4 +- tests/fe/fe_values_view_24.cc | 4 +- tests/fe/fe_values_view_24_nonsymmetric.cc | 4 +- tests/fe/fe_values_view_25.cc | 4 +- tests/fe/fe_values_view_25_nonsymmetric.cc | 4 +- tests/fe/fe_values_view_26.cc | 4 +- tests/fe/fe_values_view_27.cc | 4 +- tests/fe/fe_values_view_28.cc | 4 +- tests/fe/fe_values_view_29.cc | 4 +- tests/fe/fe_values_view_30.cc | 12 +- tests/fe/fe_values_view_invalid_01.cc | 4 +- tests/fe/fe_values_view_invalid_02.cc | 4 +- tests/fe/fe_values_view_invalid_03.cc | 4 +- .../fe_values_view_invalid_03_nonsymmetric.cc | 4 +- tests/fe/function.cc | 4 +- tests/fe/interpolate_common.h | 2 +- tests/fe/jacobians.cc | 2 +- tests/fe/jacobians_face.cc | 2 +- tests/fe/jacobians_face_cartesian.cc | 2 +- tests/fe/jacobians_face_fe_field.cc | 2 +- tests/fe/nedelec.cc | 2 +- tests/fe/nedelec_2.cc | 2 +- tests/fe/nedelec_3.cc | 2 +- tests/fe/nedelec_non_rect_2d.cc | 20 ++-- tests/fe/nedelec_non_rect_face.cc | 8 +- tests/fe/p1nc_01.cc | 2 +- tests/fe/p1nc_02.cc | 4 +- tests/fe/p1nc_03.cc | 4 +- tests/fe/p1nc_04.cc | 4 +- tests/fe/p1nc_05.cc | 2 +- tests/fe/p1nc_06.cc | 4 +- tests/fe/p1nc_07.cc | 4 +- tests/fe/p1nc_08.cc | 4 +- tests/fe/q_1.cc | 2 +- tests/fe/q_2.cc | 2 +- tests/fe/q_3.cc | 2 +- tests/fe/q_4.cc | 2 +- tests/fe/rt_1.cc | 2 +- tests/fe/rt_10.cc | 2 +- tests/fe/rt_11.cc | 2 +- tests/fe/rt_12.cc | 2 +- tests/fe/rt_13.cc | 2 +- tests/fe/rt_14.cc | 2 +- tests/fe/rt_15.cc | 2 +- tests/fe/rt_2.cc | 2 +- tests/fe/rt_3.cc | 2 +- tests/fe/rt_5.cc | 2 +- tests/fe/rt_7.cc | 2 +- tests/fe/rt_8.cc | 2 +- tests/fe/rt_9.cc | 2 +- tests/fe/rt_covariant.cc | 4 +- tests/fe/rt_hessian.cc | 4 +- tests/fe/rtdiff.cc | 2 +- tests/fe/rtn_2.cc | 2 +- tests/fe/rtn_3.cc | 2 +- tests/fe/shapes.h | 8 +- tests/fe/shapes_bernstein.cc | 2 +- tests/fe/shapes_dgp.cc | 2 +- tests/fe/shapes_dgp_monomial.cc | 2 +- tests/fe/shapes_dgp_nonparametric.cc | 2 +- tests/fe/shapes_dgq.cc | 2 +- tests/fe/shapes_faceq.cc | 2 +- tests/fe/shapes_nedelec.cc | 2 +- tests/fe/shapes_q.cc | 2 +- tests/fe/shapes_q_bubbles.cc | 2 +- tests/fe/shapes_q_dg0.cc | 2 +- tests/fe/shapes_q_hierarchical.cc | 2 +- tests/fe/shapes_q_iso_q1.cc | 2 +- tests/fe/shapes_system.cc | 2 +- tests/fe/shapes_system_02.cc | 2 +- tests/fe/shapes_traceq.cc | 2 +- tests/fe/system_01.cc | 2 +- tests/fe/system_02.cc | 2 +- tests/fe/system_index.cc | 4 +- tests/fe/transfer.cc | 2 +- .../grid/build_triangulation_from_patch_01.cc | 2 +- .../grid/build_triangulation_from_patch_02.cc | 2 +- .../grid/build_triangulation_from_patch_03.cc | 2 +- .../grid/build_triangulation_from_patch_04.cc | 2 +- tests/grid/coarsening_02.cc | 2 +- tests/grid/coarsening_02_1d.cc | 2 +- tests/grid/coarsening_03.cc | 2 +- tests/grid/enclosing_sphere_01.cc | 8 +- tests/grid/extent_in_direction.cc | 2 +- tests/grid/filtered_iterator_05.cc | 2 +- .../get_cells_at_coarsest_common_level_01.cc | 2 +- .../get_cells_at_coarsest_common_level_02.cc | 2 +- .../get_cells_at_coarsest_common_level_03.cc | 2 +- tests/grid/get_dof_to_support_patch_map_01.cc | 2 +- tests/grid/get_finest_common_cells_01.cc | 2 +- tests/grid/get_finest_common_cells_02.cc | 2 +- tests/grid/get_finest_common_cells_03.cc | 2 +- tests/grid/get_patch_around_cell_01.cc | 2 +- tests/grid/grid_generator_01.cc | 2 +- tests/grid/grid_generator_01a.cc | 2 +- tests/grid/grid_generator_01b.cc | 2 +- tests/grid/grid_generator_02.cc | 2 +- tests/grid/grid_generator_03.cc | 2 +- tests/grid/grid_generator_04.cc | 2 +- tests/grid/grid_generator_05.cc | 2 +- tests/grid/grid_generator_06.cc | 2 +- tests/grid/grid_generator_07.cc | 2 +- tests/grid/grid_generator_08.cc | 2 +- tests/grid/grid_generator_09.cc | 2 +- tests/grid/grid_generator_hyper_sphere.cc | 2 +- tests/grid/grid_hyper_shell.cc | 2 +- tests/grid/grid_hyper_shell_02.cc | 2 +- tests/grid/grid_hyper_shell_03.cc | 2 +- tests/grid/grid_hyper_shell_04.cc | 2 +- tests/grid/grid_hyper_shell_05.cc | 2 +- tests/grid/grid_hyper_shell_06.cc | 2 +- tests/grid/grid_in.cc | 2 +- tests/grid/grid_in_msh.cc | 2 +- tests/grid/grid_in_msh_03.cc | 2 +- tests/grid/grid_in_msh_version_1.cc | 2 +- tests/grid/grid_in_msh_version_2.cc | 2 +- tests/grid/grid_in_unv_2d.cc | 2 +- tests/grid/grid_in_unv_3d.cc | 2 +- tests/grid/grid_in_unv_3d_02.cc | 2 +- tests/grid/grid_in_vtk_2d.cc | 2 +- tests/grid/grid_in_vtk_3d.cc | 2 +- tests/grid/grid_in_vtk_3d_02.cc | 2 +- tests/grid/grid_in_vtk_3d_03.cc | 2 +- tests/grid/grid_in_vtk_3d_04.cc | 2 +- tests/grid/grid_out_per_processor_vtu_01.cc | 4 +- tests/grid/grid_out_per_processor_vtu_02.cc | 4 +- tests/grid/grid_out_vtk_02.cc | 4 +- tests/grid/grid_output_input.cc | 2 +- tests/grid/grid_parallelepiped.cc | 2 +- tests/grid/grid_parallelepiped_02.cc | 2 +- tests/grid/grid_parallelepiped_03.cc | 2 +- tests/grid/grid_parallelepiped_04.cc | 2 +- tests/grid/grid_parallelepiped_05.cc | 2 +- tests/grid/grid_tools_05.cc | 2 +- tests/grid/grid_tools_06.cc | 2 +- ...ls_active_cell_layer_within_distance_01.cc | 2 +- ...ls_active_cell_layer_within_distance_02.cc | 2 +- tests/grid/grid_tools_bounding_box_01.cc | 2 +- tests/grid/grid_tools_halo_layer_01.cc | 2 +- tests/grid/grid_tools_transform_01.cc | 6 +- tests/grid/have_same_coarse_mesh_01.cc | 2 +- tests/grid/have_same_coarse_mesh_02.cc | 2 +- tests/grid/have_same_coarse_mesh_03.cc | 2 +- tests/grid/measure_et_al.cc | 8 +- tests/grid/measure_et_al_02.cc | 8 +- tests/grid/merge_triangulations_02.cc | 2 +- tests/grid/merge_triangulations_03.cc | 2 +- tests/grid/recursively_set_material_id.cc | 2 +- tests/grid/tria_signals_01.cc | 8 +- tests/grid/twisted_parallelepiped_01.cc | 2 +- tests/grid/twisted_parallelepiped_02.cc | 2 +- tests/grid/user_data_01.cc | 8 +- tests/hp/dof_handler_number_cache.cc | 2 +- .../hp/hp_constraints_neither_dominate_01.cc | 2 +- .../hp/hp_constraints_neither_dominate_02.cc | 2 +- tests/hp/hp_q_hierarchical_constraints.cc | 2 +- tests/hp/matrices.cc | 2 +- tests/hp/matrices_hp.cc | 2 +- tests/hp/n_boundary_dofs.cc | 2 +- tests/hp/project_01.cc | 2 +- tests/hp/project_01_curved_boundary.cc | 2 +- tests/hp/project_02.cc | 2 +- tests/hp/solution_transfer.cc | 2 +- tests/hp/solution_transfer_12.cc | 2 +- tests/hp/step-27.cc | 2 +- tests/hp/vectors_boundary_rhs_01.cc | 2 +- tests/hp/vectors_boundary_rhs_02.cc | 2 +- tests/hp/vectors_boundary_rhs_03.cc | 2 +- tests/hp/vectors_boundary_rhs_hp_01.cc | 2 +- tests/hp/vectors_boundary_rhs_hp_03.cc | 2 +- tests/hp/vectors_rhs_01.cc | 2 +- tests/hp/vectors_rhs_02.cc | 2 +- tests/hp/vectors_rhs_03.cc | 2 +- tests/hp/vectors_rhs_hp_01.cc | 2 +- tests/hp/vectors_rhs_hp_03.cc | 2 +- .../assembler_simple_system_inhom_01.cc | 12 +- tests/integrators/cells_and_faces_01.cc | 2 +- tests/integrators/functional_01.cc | 2 +- tests/integrators/mesh_worker_01.cc | 2 +- tests/integrators/mesh_worker_02.cc | 2 +- tests/integrators/mesh_worker_03.cc | 2 +- tests/integrators/mesh_worker_matrix_01.cc | 2 +- tests/lac/filtered_matrix.cc | 2 +- tests/lac/filtered_matrix_01.cc | 2 +- tests/lac/filtered_matrix_02.cc | 2 +- tests/lac/filtered_matrix_03.cc | 2 +- tests/lac/filtered_matrix_04.cc | 2 +- tests/lac/filtered_matrix_05.cc | 2 +- tests/lac/gmres_eigenvalues.cc | 2 +- tests/lac/identity_matrix_01.cc | 2 +- tests/lac/identity_matrix_02.cc | 2 +- tests/lac/identity_matrix_03.cc | 2 +- tests/lac/identity_matrix_04.cc | 2 +- tests/lac/identity_matrix_05.cc | 2 +- tests/lac/identity_matrix_06.cc | 2 +- tests/lac/linear_operator_05.cc | 30 ++--- tests/lac/linear_operator_08.cc | 12 +- tests/lac/linear_operator_10.cc | 8 +- tests/lac/linear_operator_10a.cc | 8 +- tests/lac/linear_operator_13.cc | 2 +- tests/lac/linear_operator_14.cc | 2 +- tests/lac/matrices_02.cc | 2 +- tests/lac/pointer_matrix_01.cc | 2 +- tests/lac/pointer_matrix_02.cc | 2 +- tests/lac/pointer_matrix_03.cc | 2 +- tests/lac/pointer_matrix_04.cc | 2 +- tests/lac/pointer_matrix_05.cc | 2 +- tests/lac/pointer_matrix_06.cc | 2 +- tests/lac/pointer_matrix_07.cc | 2 +- tests/lac/pointer_matrix_08.cc | 2 +- tests/lac/pointer_matrix_09.cc | 2 +- tests/lac/pointer_matrix_10.cc | 2 +- tests/lac/quickmatrix.h | 6 +- tests/lac/solver.cc | 4 +- tests/lac/solver_02.cc | 2 +- tests/lac/solver_control_01.cc | 2 +- tests/lac/solver_control_02.cc | 2 +- tests/lac/solver_control_03.cc | 2 +- tests/lac/solver_control_04.cc | 2 +- tests/lac/solver_memorytest.cc | 2 +- tests/lac/solver_monitor.cc | 2 +- tests/lac/solver_monitor_disconnect.cc | 2 +- tests/lac/solver_relaxation_01.cc | 2 +- tests/lac/solver_relaxation_02.cc | 2 +- tests/lac/solver_relaxation_03.cc | 2 +- tests/lac/solver_relaxation_04.cc | 2 +- tests/lac/solver_signals.cc | 8 +- tests/lac/sparse_matrices.cc | 2 +- tests/lac/tridiagonal_matrix.cc | 14 +-- tests/lac/tridiagonal_matrix_sym.cc | 8 +- tests/lac/vector_memory.cc | 4 +- tests/lac/vector_view.cc | 2 +- tests/lac/vector_view_01.cc | 2 +- tests/lac/vector_view_02.cc | 2 +- tests/lac/vector_view_03.cc | 2 +- tests/lac/vector_view_04.cc | 2 +- tests/lac/vector_view_05.cc | 2 +- tests/lapack/solver_cg.cc | 6 +- .../copy_boundary_to_manifold_id_01.cc | 2 +- .../copy_material_to_manifold_id_01.cc | 2 +- tests/manifold/polar_manifold_06.cc | 2 +- tests/manifold/set_all_manifold_ids_01.cc | 2 +- tests/manifold/set_all_manifold_ids_02.cc | 2 +- .../fe_face_values_1d_mapping_cartesian.cc | 6 +- .../mappings/fe_face_values_1d_mapping_q2.cc | 6 +- tests/mappings/mapping.cc | 22 ++-- tests/mappings/mapping_fe_field_01.cc | 2 +- .../mapping_fe_field_real_to_unit_b1.cc | 2 +- ...mapping_fe_field_real_to_unit_b2_curved.cc | 2 +- .../mapping_fe_field_real_to_unit_b2_mask.cc | 2 +- ...mapping_fe_field_real_to_unit_b3_curved.cc | 2 +- ...mapping_fe_field_real_to_unit_b4_curved.cc | 2 +- ...mapping_fe_field_real_to_unit_b5_curved.cc | 2 +- .../mapping_fe_field_real_to_unit_q1.cc | 2 +- ...mapping_fe_field_real_to_unit_q2_curved.cc | 2 +- .../mapping_fe_field_real_to_unit_q2_mask.cc | 2 +- ...mapping_fe_field_real_to_unit_q3_curved.cc | 2 +- ...mapping_fe_field_real_to_unit_q4_curved.cc | 2 +- ...mapping_fe_field_real_to_unit_q5_curved.cc | 2 +- tests/mappings/mapping_manifold_01.cc | 2 +- tests/mappings/mapping_manifold_02.cc | 2 +- tests/mappings/mapping_manifold_03.cc | 2 +- tests/mappings/mapping_manifold_04.cc | 2 +- tests/mappings/mapping_manifold_05.cc | 2 +- tests/mappings/mapping_manifold_06.cc | 2 +- tests/mappings/mapping_manifold_07.cc | 2 +- tests/mappings/mapping_q1_eulerian.cc | 4 +- tests/mappings/mapping_q_convergence.cc | 8 +- tests/mappings/mapping_q_manifold_01.cc | 16 +-- tests/mappings/mapping_q_manifold_02.cc | 8 +- tests/mappings/mapping_real_to_unit_02.cc | 2 +- tests/mappings/mapping_real_to_unit_q1.cc | 2 +- .../mapping_real_to_unit_q1_singular.cc | 2 +- .../mapping_real_to_unit_q4_curved.cc | 2 +- .../mapping_real_to_unit_q4_curved_codim.cc | 2 +- .../mapping_real_to_unit_q4_straight.cc | 2 +- tests/matrix_free/parallel_multigrid.cc | 2 +- tests/matrix_free/parallel_multigrid_02.cc | 2 +- .../parallel_multigrid_adaptive_01.cc | 2 +- .../parallel_multigrid_adaptive_02.cc | 2 +- .../parallel_multigrid_adaptive_03.cc | 2 +- .../parallel_multigrid_adaptive_04.cc | 2 +- .../parallel_multigrid_adaptive_05.cc | 2 +- tests/matrix_free/parallel_multigrid_mf.cc | 2 +- tests/meshworker/codim_01.cc | 4 +- tests/mpi/attach_data_01.cc | 6 +- tests/mpi/cell_weights_01.cc | 2 +- .../mpi/cell_weights_01_back_and_forth_01.cc | 2 +- .../mpi/cell_weights_01_back_and_forth_02.cc | 2 +- tests/mpi/cell_weights_02.cc | 2 +- tests/mpi/cell_weights_03.cc | 2 +- tests/mpi/cell_weights_04.cc | 2 +- tests/mpi/cell_weights_05.cc | 2 +- tests/mpi/cell_weights_06.cc | 2 +- tests/mpi/codim_01.cc | 2 +- tests/mpi/communicate_moved_vertices_01.cc | 2 +- tests/mpi/communicate_moved_vertices_02.cc | 2 +- tests/mpi/compute_mean_value.cc | 2 +- tests/mpi/condense_01.cc | 2 +- tests/mpi/constraint_matrix_trilinos_bug.cc | 2 +- tests/mpi/count_dofs_per_block_01.cc | 2 +- tests/mpi/count_dofs_per_block_02.cc | 2 +- tests/mpi/count_dofs_per_component_01.cc | 2 +- tests/mpi/crash_01.cc | 2 +- tests/mpi/crash_02.cc | 2 +- tests/mpi/crash_03.cc | 2 +- tests/mpi/crash_04.cc | 2 +- tests/mpi/crash_05.cc | 2 +- tests/mpi/crash_06.cc | 2 +- tests/mpi/cuthill_mckee_01.cc | 2 +- tests/mpi/distribute_flux_sparsity_pattern.cc | 12 +- tests/mpi/dof_handler_number_cache.cc | 2 +- tests/mpi/extract_boundary_dofs.cc | 2 +- tests/mpi/extract_constant_modes_01.cc | 2 +- tests/mpi/extract_constant_modes_02.cc | 2 +- tests/mpi/extract_locally_active_dofs.cc | 2 +- tests/mpi/fe_field_function_01.cc | 2 +- tests/mpi/fe_field_function_02.cc | 2 +- tests/mpi/fe_field_function_03.cc | 2 +- tests/mpi/find_active_cell_around_point_01.cc | 2 +- tests/mpi/has_active_dofs_01.cc | 2 +- tests/mpi/has_active_dofs_02.cc | 2 +- tests/mpi/has_hanging_nodes.cc | 2 +- tests/mpi/integrate_difference.cc | 2 +- tests/mpi/interpolate_01.cc | 2 +- tests/mpi/interpolate_02.cc | 2 +- tests/mpi/interpolate_03.cc | 2 +- tests/mpi/interpolate_04.cc | 2 +- tests/mpi/interpolate_to_different_mesh_01.cc | 6 +- tests/mpi/is_locally_owned.cc | 2 +- tests/mpi/make_zero_boundary_values.cc | 2 +- tests/mpi/map_dofs_to_support_points.cc | 2 +- tests/mpi/mesh_worker_01.cc | 8 +- tests/mpi/mesh_worker_02.cc | 8 +- tests/mpi/mesh_worker_03.cc | 8 +- tests/mpi/mesh_worker_04.cc | 8 +- tests/mpi/mesh_worker_05.cc | 8 +- tests/mpi/mesh_worker_matrix_01.cc | 2 +- tests/mpi/mg_01.cc | 4 +- tests/mpi/mg_02.cc | 2 +- tests/mpi/mg_03.cc | 4 +- tests/mpi/mg_04.cc | 4 +- tests/mpi/mg_05.cc | 4 +- tests/mpi/mg_06.cc | 4 +- tests/mpi/no_flux_constraints.cc | 2 +- tests/mpi/no_flux_constraints_02.cc | 2 +- tests/mpi/no_flux_constraints_03.cc | 2 +- tests/mpi/normal_flux_constraints.cc | 2 +- tests/mpi/p4est_2d_coarse_01.cc | 2 +- tests/mpi/p4est_2d_constraintmatrix_01.cc | 2 +- tests/mpi/p4est_2d_constraintmatrix_02.cc | 2 +- tests/mpi/p4est_2d_constraintmatrix_03.cc | 4 +- tests/mpi/p4est_2d_constraintmatrix_04.cc | 4 +- tests/mpi/p4est_2d_constraintmatrix_05.cc | 2 +- tests/mpi/p4est_2d_dofhandler_01.cc | 2 +- tests/mpi/p4est_2d_dofhandler_02.cc | 2 +- tests/mpi/p4est_2d_dofhandler_03.cc | 2 +- tests/mpi/p4est_2d_dofhandler_04.cc | 2 +- tests/mpi/p4est_2d_dofhandler_05.cc | 2 +- tests/mpi/p4est_2d_ghost_01.cc | 2 +- tests/mpi/p4est_2d_ghost_02.cc | 2 +- tests/mpi/p4est_2d_refine_01.cc | 2 +- tests/mpi/p4est_2d_refine_02.cc | 2 +- tests/mpi/p4est_2d_refine_03.cc | 2 +- tests/mpi/p4est_2d_renumber_01.cc | 2 +- tests/mpi/p4est_2d_renumber_02.cc | 2 +- tests/mpi/p4est_2d_simple.cc | 2 +- tests/mpi/p4est_3d_constraintmatrix_01.cc | 2 +- tests/mpi/p4est_3d_constraintmatrix_02.cc | 2 +- tests/mpi/p4est_3d_constraintmatrix_03.cc | 4 +- tests/mpi/p4est_3d_ghost_01.cc | 2 +- tests/mpi/p4est_3d_refine_01.cc | 2 +- tests/mpi/p4est_3d_refine_02.cc | 2 +- tests/mpi/p4est_3d_refine_03.cc | 2 +- tests/mpi/p4est_3d_refine_04.cc | 2 +- tests/mpi/p4est_data_out_01.cc | 2 +- tests/mpi/p4est_get_subdomain_association.cc | 2 +- tests/mpi/p4est_max_refine.cc | 2 +- tests/mpi/p4est_save_01.cc | 2 +- tests/mpi/p4est_save_02.cc | 2 +- tests/mpi/p4est_save_03.cc | 2 +- tests/mpi/p4est_save_04.cc | 2 +- tests/mpi/parallel_vtu_01.cc | 2 +- tests/mpi/periodicity_04.cc | 2 +- tests/mpi/petsc_03.cc | 2 +- tests/mpi/point_value_01.cc | 2 +- tests/mpi/renumber_cuthill_mckee.cc | 2 +- tests/mpi/renumber_cuthill_mckee_02.cc | 2 +- tests/mpi/renumber_z_order_01.cc | 2 +- tests/mpi/renumber_z_order_02.cc | 2 +- tests/mpi/repartition_01.cc | 2 +- tests/mpi/repartition_02.cc | 6 +- tests/mpi/repartition_03.cc | 4 +- tests/mpi/solution_transfer_01.cc | 2 +- tests/mpi/tria_01.cc | 2 +- tests/mpi/tria_copy_triangulation.cc | 2 +- tests/mpi/tria_signals_01.cc | 8 +- tests/mpi/tria_signals_02.cc | 4 +- tests/mpi/tria_signals_03.cc | 4 +- tests/mpi/tria_signals_04.cc | 4 +- tests/mpi/tria_signals_05.cc | 4 +- tests/mpi/tria_signals_06.cc | 4 +- tests/multigrid/mg_coarse_01.cc | 2 +- tests/multigrid/mg_output_dirichlet.cc | 2 +- tests/multigrid/mg_output_neumann.cc | 2 +- tests/multigrid/smoother_block.cc | 28 ++--- tests/multigrid/transfer_02.cc | 2 +- tests/multigrid/transfer_03.cc | 2 +- .../multigrid/transfer_system_adaptive_01.cc | 2 +- .../multigrid/transfer_system_adaptive_02.cc | 2 +- .../multigrid/transfer_system_adaptive_03.cc | 2 +- .../multigrid/transfer_system_adaptive_04.cc | 2 +- .../multigrid/transfer_system_adaptive_05.cc | 2 +- .../multigrid/transfer_system_adaptive_06.cc | 2 +- .../multigrid/transfer_system_adaptive_07.cc | 2 +- .../multigrid/transfer_system_adaptive_08.cc | 2 +- .../multigrid/transfer_system_adaptive_09.cc | 2 +- tests/numerics/boundaries.cc | 2 +- tests/numerics/data_out_08.cc | 2 +- tests/numerics/derivative_approximation_02.cc | 2 +- tests/numerics/derivative_approximation_03.cc | 2 +- tests/numerics/error_estimator.cc | 2 +- tests/numerics/error_estimator_02.cc | 44 +++---- tests/numerics/no_flux_01.cc | 4 +- tests/numerics/no_flux_02.cc | 4 +- tests/numerics/no_flux_03.cc | 4 +- tests/numerics/no_flux_04.cc | 4 +- tests/numerics/no_flux_05.cc | 4 +- tests/numerics/no_flux_06.cc | 2 +- tests/numerics/no_flux_07.cc | 4 +- tests/numerics/no_flux_hp_01.cc | 4 +- tests/numerics/no_flux_hp_02.cc | 4 +- tests/numerics/no_flux_hp_03.cc | 4 +- tests/numerics/no_flux_hp_04.cc | 4 +- tests/numerics/no_flux_hp_05.cc | 4 +- tests/numerics/normal_flux_01.cc | 4 +- tests/numerics/normal_flux_02.cc | 4 +- tests/numerics/normal_flux_03.cc | 4 +- tests/numerics/normal_flux_hp_01.cc | 4 +- tests/numerics/normal_flux_inhom_01.cc | 4 +- tests/numerics/project_01.cc | 2 +- tests/numerics/project_01_curved_boundary.cc | 2 +- tests/numerics/project_02.cc | 2 +- tests/numerics/project_boundary_01.cc | 2 +- tests/numerics/project_boundary_rt_01.cc | 12 +- tests/numerics/tangential_flux_inhom_01.cc | 4 +- tests/numerics/vectors_boundary_rhs_01.cc | 2 +- tests/numerics/vectors_boundary_rhs_02.cc | 2 +- tests/numerics/vectors_boundary_rhs_03.cc | 2 +- tests/numerics/vectors_point_source_01.cc | 2 +- tests/numerics/vectors_rhs_01.cc | 2 +- tests/numerics/vectors_rhs_03.cc | 2 +- tests/petsc/64.cc | 2 +- tests/petsc/deal_solver_01.cc | 2 +- tests/petsc/deal_solver_02.cc | 2 +- tests/petsc/deal_solver_03.cc | 2 +- tests/petsc/deal_solver_04.cc | 2 +- tests/petsc/deal_solver_05.cc | 2 +- tests/petsc/solver_03.cc | 2 +- tests/petsc/solver_03_mf.cc | 2 +- .../petsc/solver_03_precondition_boomeramg.cc | 2 +- ...ver_03_precondition_boomeramg_symmetric.cc | 2 +- .../petsc/solver_03_precondition_eisenstat.cc | 2 +- tests/petsc/solver_03_precondition_icc.cc | 2 +- tests/petsc/solver_03_precondition_ilu.cc | 2 +- tests/petsc/solver_03_precondition_lu.cc | 2 +- .../petsc/solver_03_precondition_parasails.cc | 2 +- tests/petsc/solver_03_precondition_sor.cc | 2 +- tests/petsc/solver_03_precondition_ssor.cc | 2 +- tests/petsc/solver_04.cc | 2 +- tests/petsc/solver_05.cc | 2 +- tests/petsc/solver_06.cc | 2 +- tests/petsc/solver_07.cc | 2 +- tests/petsc/solver_08.cc | 2 +- tests/petsc/solver_09.cc | 2 +- tests/petsc/solver_10.cc | 2 +- tests/petsc/solver_12.cc | 2 +- tests/petsc/solver_13.cc | 2 +- .../parallel_sparse_matrix_01.cc | 2 +- tests/petsc_complex/solver_real_03.cc | 2 +- tests/petsc_complex/solver_real_03_mf.cc | 2 +- tests/petsc_complex/solver_real_04.cc | 2 +- tests/physics/elasticity-kinematics_01.cc | 2 +- .../physics/elasticity-standard_tensors_01.cc | 6 +- tests/quick_tests/p4est.cc | 2 +- tests/sharedtria/copy_tria_01.cc | 2 +- tests/sharedtria/dof_01.cc | 2 +- tests/sharedtria/dof_02.cc | 2 +- tests/sharedtria/dof_03.cc | 2 +- tests/sharedtria/dof_04.cc | 2 +- tests/sharedtria/tria_01.cc | 2 +- tests/sharedtria/tria_02.cc | 2 +- tests/sharedtria/tria_custom_refine01.cc | 2 +- tests/sharedtria/tria_custom_refine02.cc | 2 +- tests/sharedtria/tria_load_01.cc | 2 +- tests/sharedtria/tria_multigrid_01.cc | 2 +- tests/sharedtria/tria_multigrid_02.cc | 2 +- tests/sharedtria/tria_zorder_01.cc | 2 +- tests/sharedtria/tria_zorder_02.cc | 2 +- tests/slepc/solve_01.cc | 2 +- tests/slepc/solve_04.cc | 2 +- tests/slepc/testmatrix.h | 6 +- tests/testmatrix.h | 8 +- tests/tests.h | 4 +- tests/trilinos/64.cc | 2 +- tests/trilinos/deal_solver_01.cc | 2 +- tests/trilinos/deal_solver_02.cc | 2 +- tests/trilinos/deal_solver_03.cc | 2 +- tests/trilinos/deal_solver_04.cc | 2 +- tests/trilinos/deal_solver_05.cc | 2 +- tests/trilinos/deal_solver_06.cc | 2 +- tests/trilinos/elide_zeros.cc | 12 +- tests/trilinos/solver_03.cc | 2 +- tests/trilinos/solver_05.cc | 2 +- tests/trilinos/solver_07.cc | 2 +- tests/trilinos/solver_control_01.cc | 2 +- tests/trilinos/solver_control_02.cc | 2 +- tests/trilinos/solver_control_03.cc | 2 +- tests/trilinos/sparse_matrix_mmult_01.cc | 2 +- 961 files changed, 2416 insertions(+), 2416 deletions(-) diff --git a/examples/step-26/step-26.cc b/examples/step-26/step-26.cc index a8aa054a29..41a9d30436 100644 --- a/examples/step-26/step-26.cc +++ b/examples/step-26/step-26.cc @@ -76,7 +76,7 @@ namespace Step26 // that the refine_mesh function takes arguments for the // minimal and maximal mesh refinement level. The purpose of this is // discussed in the introduction. - template + template class HeatEquation { public: @@ -122,7 +122,7 @@ namespace Step26 // right hand side is chosen as discussed at the end of the // introduction. For boundary values, we choose zero values, but this is // easily changed below. - template + template class RightHandSide : public Function { public: @@ -141,7 +141,7 @@ namespace Step26 - template + template double RightHandSide::value (const Point &p, const unsigned int component) const { @@ -172,7 +172,7 @@ namespace Step26 - template + template class BoundaryValues : public Function { public: @@ -182,7 +182,7 @@ namespace Step26 - template + template double BoundaryValues::value (const Point &/*p*/, const unsigned int component) const { @@ -201,7 +201,7 @@ namespace Step26 // on the right hand side was set to 0.2 above, so we resolve each // period with 100 time steps) and chooses the Crank Nicolson method // by setting $\theta=1/2$. - template + template HeatEquation::HeatEquation () : fe(1), @@ -226,7 +226,7 @@ namespace Step26 // that defaults to an empty object). This is because we are going to // condense the constraints in run() after combining the matrices for the // current time-step. - template + template void HeatEquation::setup_system() { dof_handler.distribute_dofs(fe); @@ -273,7 +273,7 @@ namespace Step26 // // The next function is the one that solves the actual linear system // for a single time step. There is nothing surprising here: - template + template void HeatEquation::solve_time_step() { SolverControl solver_control(1000, 1e-8 * system_rhs.l2_norm()); @@ -296,7 +296,7 @@ namespace Step26 // @sect4{HeatEquation::output_results} // // Neither is there anything new in generating graphical output: - template + template void HeatEquation::output_results() const { DataOut data_out; @@ -440,7 +440,7 @@ namespace Step26 // as here. Instead of trying to justify the occurrence here, // let's first look at the code and we'll come back to the issue // at the end of function. - template + template void HeatEquation::run() { const unsigned int initial_global_refinement = 2; diff --git a/examples/step-34/step-34.cc b/examples/step-34/step-34.cc index af57be39f4..e6b66e28c5 100644 --- a/examples/step-34/step-34.cc +++ b/examples/step-34/step-34.cc @@ -869,7 +869,7 @@ namespace Step34 // as an argument is the index of the unit support point where the // singularity is located. - template<> + template <> const Quadrature<2> &BEMProblem<3>::get_singular_quadrature( const DoFHandler<2,3>::active_cell_iterator &, const unsigned int index) const @@ -887,7 +887,7 @@ namespace Step34 } - template<> + template <> const Quadrature<1> &BEMProblem<2>::get_singular_quadrature( const DoFHandler<1,2>::active_cell_iterator &cell, const unsigned int index) const diff --git a/include/deal.II/base/data_out_base.h b/include/deal.II/base/data_out_base.h index 6feeee4741..b7a2aee1b2 100644 --- a/include/deal.II/base/data_out_base.h +++ b/include/deal.II/base/data_out_base.h @@ -375,7 +375,7 @@ namespace DataOutBase * * @ingroup output */ - template + template struct OutputFlagsBase { /** @@ -406,17 +406,17 @@ namespace DataOutBase }; - template + template void OutputFlagsBase::declare_parameters (ParameterHandler &) {} - template + template void OutputFlagsBase::parse_parameters (const ParameterHandler &) {} - template + template std::size_t OutputFlagsBase::memory_consumption () const { return sizeof(FlagsType); @@ -1207,13 +1207,13 @@ namespace DataOutBase * the point already exists and we are filtering redundant values, the * provided index will internally refer to another recorded point. */ - template + template void write_point(const unsigned int &index, const Point &p); /** * Record a deal.II cell in the internal reordered format. */ - template + template void write_cell(unsigned int index, unsigned int start, unsigned int d1, unsigned int d2, unsigned int d3); /** @@ -2482,7 +2482,7 @@ public: * Set the flags to be used for output. This method expects flags * to be a member of one of the child classes of OutputFlagsBase. */ - template + template void set_flags (const FlagType &flags); diff --git a/include/deal.II/base/function_lib.h b/include/deal.II/base/function_lib.h index 0274ef1713..46859929ff 100644 --- a/include/deal.II/base/function_lib.h +++ b/include/deal.II/base/function_lib.h @@ -48,7 +48,7 @@ namespace Functions * @ingroup functions * @author: Guido Kanschat, 1999 */ - template + template class SquareFunction : public Function { public: @@ -82,7 +82,7 @@ namespace Functions * @ingroup functions * @author: Guido Kanschat, 2000 */ - template + template class Q1WedgeFunction : public Function { public: @@ -137,7 +137,7 @@ namespace Functions * @ingroup functions * @author: Guido Kanschat, 1999 */ - template + template class PillowFunction : public Function { public: @@ -199,7 +199,7 @@ namespace Functions * @ingroup functions * @author Guido Kanschat, 1999 */ - template + template class CosineFunction : public Function { public: @@ -260,7 +260,7 @@ namespace Functions * @ingroup functions * @author Guido Kanschat, 2010 */ - template + template class CosineGradFunction : public Function { public: @@ -302,7 +302,7 @@ namespace Functions * @ingroup functions * @author Guido Kanschat, 1999 */ - template + template class ExpFunction : public Function { public: @@ -527,7 +527,7 @@ namespace Functions * @ingroup functions * @author: Guido Kanschat, 2000 */ - template + template class JumpFunction : public Function { public: @@ -888,7 +888,7 @@ namespace Functions * @ingroup functions * @author Guido Kanschat, 2001, 2002 */ - template + template class CutOffFunctionLinfty : public CutOffFunctionBase { public: @@ -933,7 +933,7 @@ namespace Functions * @ingroup functions * @author Guido Kanschat, 2001, 2002 */ - template + template class CutOffFunctionW1 : public CutOffFunctionBase { public: @@ -980,7 +980,7 @@ namespace Functions * @ingroup functions * @author Guido Kanschat, 2001, 2002 */ - template + template class CutOffFunctionCinfty : public CutOffFunctionBase { public: diff --git a/include/deal.II/base/function_time.h b/include/deal.II/base/function_time.h index 1c80ddd2ca..7829fde73f 100644 --- a/include/deal.II/base/function_time.h +++ b/include/deal.II/base/function_time.h @@ -111,7 +111,7 @@ private: #ifndef DOXYGEN -template +template inline Number FunctionTime::get_time () const { diff --git a/include/deal.II/base/function_time.templates.h b/include/deal.II/base/function_time.templates.h index 5ec72ad4c5..6c42d87f4f 100644 --- a/include/deal.II/base/function_time.templates.h +++ b/include/deal.II/base/function_time.templates.h @@ -21,7 +21,7 @@ DEAL_II_NAMESPACE_OPEN -template +template FunctionTime::FunctionTime(const Number initial_time) : time(initial_time) @@ -29,13 +29,13 @@ FunctionTime::FunctionTime(const Number initial_time) -template +template FunctionTime::~FunctionTime() {} -template +template void FunctionTime::set_time (const Number new_time) { @@ -43,7 +43,7 @@ FunctionTime::set_time (const Number new_time) } -template +template void FunctionTime::advance_time (const Number delta_t) { diff --git a/include/deal.II/base/memory_consumption.h b/include/deal.II/base/memory_consumption.h index 94d3ee412c..e22d428a99 100644 --- a/include/deal.II/base/memory_consumption.h +++ b/include/deal.II/base/memory_consumption.h @@ -237,7 +237,7 @@ namespace MemoryConsumption * @note This returns the size of the pointer, not the size of the object * pointed to. */ - template + template inline std::size_t memory_consumption (const T *const); @@ -388,7 +388,7 @@ namespace MemoryConsumption - template + template inline std::size_t memory_consumption(const T *const) diff --git a/include/deal.II/base/mg_level_object.h b/include/deal.II/base/mg_level_object.h index 1f8d689af7..cf632d0a58 100644 --- a/include/deal.II/base/mg_level_object.h +++ b/include/deal.II/base/mg_level_object.h @@ -43,7 +43,7 @@ DEAL_II_NAMESPACE_OPEN * @ingroup data * @author Wolfgang Bangerth, Guido Kanschat, 1999, 2005, 2010 */ -template +template class MGLevelObject : public Subscriptor { public: @@ -157,7 +157,7 @@ private: /* ------------------------------------------------------------------- */ -template +template MGLevelObject::MGLevelObject(const unsigned int min, const unsigned int max) : @@ -167,7 +167,7 @@ MGLevelObject::MGLevelObject(const unsigned int min, } -template +template Object & MGLevelObject::operator[] (const unsigned int i) { @@ -177,7 +177,7 @@ MGLevelObject::operator[] (const unsigned int i) } -template +template const Object & MGLevelObject::operator[] (const unsigned int i) const { @@ -187,7 +187,7 @@ MGLevelObject::operator[] (const unsigned int i) const } -template +template void MGLevelObject::resize (const unsigned int new_minlevel, const unsigned int new_maxlevel) @@ -205,7 +205,7 @@ MGLevelObject::resize (const unsigned int new_minlevel, } -template +template MGLevelObject & MGLevelObject::operator = (const double d) { @@ -216,7 +216,7 @@ MGLevelObject::operator = (const double d) } -template +template void MGLevelObject::clear () // DEPRECATED { @@ -225,7 +225,7 @@ MGLevelObject::clear () // DEPRECATED } -template +template void MGLevelObject::clear_elements () { @@ -235,7 +235,7 @@ MGLevelObject::clear_elements () } -template +template unsigned int MGLevelObject::min_level () const { @@ -243,7 +243,7 @@ MGLevelObject::min_level () const } -template +template unsigned int MGLevelObject::max_level () const { @@ -251,7 +251,7 @@ MGLevelObject::max_level () const } -template +template std::size_t MGLevelObject::memory_consumption () const { diff --git a/include/deal.II/base/point.h b/include/deal.II/base/point.h index 8b20afef3b..2e96652a7b 100644 --- a/include/deal.II/base/point.h +++ b/include/deal.II/base/point.h @@ -430,7 +430,7 @@ Point::operator - () const template -template +template inline Point::type>::type> Point::operator * (const OtherNumber factor) const @@ -444,7 +444,7 @@ Point::operator * (const OtherNumber factor) const template -template +template inline Point::type>::type> Point::operator / (const OtherNumber factor) const diff --git a/include/deal.II/base/polynomial_space.h b/include/deal.II/base/polynomial_space.h index a8964e8fbc..5ce23ebd8e 100644 --- a/include/deal.II/base/polynomial_space.h +++ b/include/deal.II/base/polynomial_space.h @@ -280,7 +280,7 @@ PolynomialSpace::PolynomialSpace (const std::vector &pols) } -template +template inline unsigned int PolynomialSpace::n() const @@ -290,7 +290,7 @@ PolynomialSpace::n() const -template +template inline unsigned int PolynomialSpace::degree() const diff --git a/include/deal.II/base/quadrature.h b/include/deal.II/base/quadrature.h index 46daf6715e..f1869b6c12 100644 --- a/include/deal.II/base/quadrature.h +++ b/include/deal.II/base/quadrature.h @@ -325,7 +325,7 @@ private: // ------------------- inline and template functions ---------------- -template +template inline unsigned int Quadrature::size () const diff --git a/include/deal.II/base/quadrature_point_data.h b/include/deal.II/base/quadrature_point_data.h index cb1299d8e2..715150f097 100644 --- a/include/deal.II/base/quadrature_point_data.h +++ b/include/deal.II/base/quadrature_point_data.h @@ -86,7 +86,7 @@ public: * @pre The type @p T needs to either equal @p DataType, or be a class derived * from @p DataType. @p T needs to be default constructible. */ - template + template void initialize(const CellIteratorType &cell, const unsigned int number_of_data_points_per_cell); @@ -95,7 +95,7 @@ public: * until, but not including, @p cell_end for all locally owned cells, i.e. * for which `cell->is_locally_owned()==true` . */ - template + template void initialize(const CellIteratorType &cell_start, const CellIteratorType &cell_end, const unsigned int number_of_data_points_per_cell); @@ -126,7 +126,7 @@ public: * * @pre The type @p T needs to match the class provided to initialize() . */ - template + template std::vector > get_data(const CellIteratorType &cell); /** @@ -139,7 +139,7 @@ public: * * @pre The type @p T needs to match the class provided to initialize() . */ - template + template std::vector > get_data(const CellIteratorType &cell) const; private: @@ -496,7 +496,7 @@ CellDataStorage:: template -template +template void CellDataStorage::initialize(const CellIteratorType &cell, const unsigned int n_q_points) { @@ -517,7 +517,7 @@ void CellDataStorage::initialize(const CellIteratorTy template -template +template void CellDataStorage::initialize(const CellIteratorType &cell_start, const CellIteratorType &cell_end, const unsigned int number) @@ -623,7 +623,7 @@ CellDataStorage::get_data(const CellIteratorType &cel * whereas the second index represents different values stored at each * quadrature point in the DataType class. */ -template +template void pack_cell_data (const CellIteratorType &cell, const CellDataStorage *data_storage, @@ -656,7 +656,7 @@ void pack_cell_data /* * the opposite of the pack function above. */ -template +template void unpack_to_cell_data (const CellIteratorType &cell, const FullMatrix &values_at_qp, @@ -688,7 +688,7 @@ namespace parallel { namespace distributed { - template + template ContinuousQuadratureDataTransfer::ContinuousQuadratureDataTransfer (const FiniteElement &projection_fe_, const Quadrature &lhs_quadrature, @@ -720,13 +720,13 @@ namespace parallel - template + template ContinuousQuadratureDataTransfer::~ContinuousQuadratureDataTransfer() {} - template + template void ContinuousQuadratureDataTransfer::prepare_for_coarsening_and_refinement (parallel::distributed::Triangulation &tr_, CellDataStorage &data_storage_) @@ -767,7 +767,7 @@ namespace parallel - template + template void ContinuousQuadratureDataTransfer::interpolate () { triangulation->notify_ready_to_unpack(offset, @@ -784,7 +784,7 @@ namespace parallel - template + template void ContinuousQuadratureDataTransfer::pack_function (const typename parallel::distributed::Triangulation::cell_iterator &cell, const typename parallel::distributed::Triangulation::CellStatus /*status*/, @@ -802,7 +802,7 @@ namespace parallel - template + template void ContinuousQuadratureDataTransfer:: unpack_function (const typename parallel::distributed::Triangulation::cell_iterator &cell, const typename parallel::distributed::Triangulation::CellStatus status, diff --git a/include/deal.II/base/quadrature_selector.h b/include/deal.II/base/quadrature_selector.h index 025dc07f14..3316963106 100644 --- a/include/deal.II/base/quadrature_selector.h +++ b/include/deal.II/base/quadrature_selector.h @@ -36,7 +36,7 @@ DEAL_II_NAMESPACE_OPEN * @ingroup Quadrature * @author Ralf Schulz, 2003 */ -template +template class QuadratureSelector : public Quadrature { public: diff --git a/include/deal.II/base/smartpointer.h b/include/deal.II/base/smartpointer.h index 4c8e5fadfa..4be387daad 100644 --- a/include/deal.II/base/smartpointer.h +++ b/include/deal.II/base/smartpointer.h @@ -59,7 +59,7 @@ DEAL_II_NAMESPACE_OPEN * @ingroup memory * @author Guido Kanschat, Wolfgang Bangerth, 1998 - 2009 */ -template +template class SmartPointer { public: diff --git a/include/deal.II/base/table.h b/include/deal.II/base/table.h index 17289b48f2..f8fef1f735 100644 --- a/include/deal.II/base/table.h +++ b/include/deal.II/base/table.h @@ -471,7 +471,7 @@ public: * This function requires that the type T2 is convertible to * T. */ - template + template TableBase &operator = (const TableBase &src); /** diff --git a/include/deal.II/base/table_handler.h b/include/deal.II/base/table_handler.h index cc79e2c0fa..79d68ae21a 100644 --- a/include/deal.II/base/table_handler.h +++ b/include/deal.II/base/table_handler.h @@ -600,7 +600,7 @@ protected: */ template void save(Archive &ar, const unsigned int version) const; - template + template void load(Archive &ar, const unsigned int version); BOOST_SERIALIZATION_SPLIT_MEMBER() @@ -908,7 +908,7 @@ TableHandler::Column::save(Archive &ar, const unsigned int /*version*/) const -template +template void TableHandler::Column::load(Archive &ar, const unsigned int /*version*/) { diff --git a/include/deal.II/base/tensor.h b/include/deal.II/base/tensor.h index 58748bae72..a34599104e 100644 --- a/include/deal.II/base/tensor.h +++ b/include/deal.II/base/tensor.h @@ -181,25 +181,25 @@ public: /** * Test for equality of two tensors. */ - template + template bool operator == (const Tensor<0,dim,OtherNumber> &rhs) const; /** * Test for inequality of two tensors. */ - template + template bool operator != (const Tensor<0,dim,OtherNumber> &rhs) const; /** * Add another scalar */ - template + template Tensor<0,dim,Number> &operator += (const Tensor<0,dim,OtherNumber> &rhs); /** * Subtract another scalar. */ - template + template Tensor<0,dim,Number> &operator -= (const Tensor<0,dim,OtherNumber> &rhs); /** @@ -207,13 +207,13 @@ public: * * @ingroup CUDAWrappers */ - template + template DEAL_II_CUDA_HOST_DEV Tensor<0,dim,Number> &operator *= (const OtherNumber factor); /** * Divide the scalar by factor. */ - template + template Tensor<0,dim,Number> &operator /= (const OtherNumber factor); /** @@ -1619,9 +1619,9 @@ scalar_product (const Tensor &left, * @relates Tensor * @author Matthias Maier, 2015, Jean-Paul Pelteret 2017 */ -template class TensorT1, - template class TensorT2, - template class TensorT3, +template