]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Make coding style more uniform. 4555/head
authorWolfgang Bangerth <bangerth@colostate.edu>
Wed, 28 Jun 2017 01:38:45 +0000 (19:38 -0600)
committerWolfgang Bangerth <bangerth@colostate.edu>
Wed, 28 Jun 2017 01:38:45 +0000 (19:38 -0600)
961 files changed:
examples/step-26/step-26.cc
examples/step-34/step-34.cc
include/deal.II/base/data_out_base.h
include/deal.II/base/function_lib.h
include/deal.II/base/function_time.h
include/deal.II/base/function_time.templates.h
include/deal.II/base/memory_consumption.h
include/deal.II/base/mg_level_object.h
include/deal.II/base/point.h
include/deal.II/base/polynomial_space.h
include/deal.II/base/quadrature.h
include/deal.II/base/quadrature_point_data.h
include/deal.II/base/quadrature_selector.h
include/deal.II/base/smartpointer.h
include/deal.II/base/table.h
include/deal.II/base/table_handler.h
include/deal.II/base/tensor.h
include/deal.II/base/tensor_accessors.h
include/deal.II/base/utilities.h
include/deal.II/base/vectorization.h
include/deal.II/dofs/dof_accessor.templates.h
include/deal.II/dofs/dof_faces.h
include/deal.II/dofs/dof_handler.h
include/deal.II/dofs/dof_tools.h
include/deal.II/dofs/function_map.h
include/deal.II/fe/fe_tools.h
include/deal.II/fe/mapping_c1.h
include/deal.II/fe/mapping_manifold.h
include/deal.II/fe/mapping_q_generic.h
include/deal.II/grid/cell_id.h
include/deal.II/grid/grid_generator.h
include/deal.II/grid/grid_reordering.h
include/deal.II/grid/grid_tools.h
include/deal.II/grid/tria.h
include/deal.II/grid/tria_accessor.h
include/deal.II/grid/tria_faces.h
include/deal.II/grid/tria_levels.h
include/deal.II/grid/tria_objects.h
include/deal.II/hp/dof_faces.h
include/deal.II/hp/dof_handler.h
include/deal.II/hp/mapping_collection.h
include/deal.II/integrators/advection.h
include/deal.II/integrators/divergence.h
include/deal.II/integrators/elasticity.h
include/deal.II/integrators/grad_div.h
include/deal.II/integrators/laplace.h
include/deal.II/lac/block_linear_operator.h
include/deal.II/lac/block_matrix_array.h
include/deal.II/lac/block_sparse_matrix_ez.h
include/deal.II/lac/block_vector.h
include/deal.II/lac/chunk_sparse_matrix.h
include/deal.II/lac/chunk_sparse_matrix.templates.h
include/deal.II/lac/constraint_matrix.h
include/deal.II/lac/constraint_matrix.templates.h
include/deal.II/lac/filtered_matrix.h
include/deal.II/lac/householder.h
include/deal.II/lac/lapack_full_matrix.h
include/deal.II/lac/lapack_templates.h
include/deal.II/lac/linear_operator.h
include/deal.II/lac/matrix_block.h
include/deal.II/lac/matrix_lib.h
include/deal.II/lac/petsc_parallel_block_vector.h
include/deal.II/lac/petsc_parallel_vector.h
include/deal.II/lac/pointer_matrix.h
include/deal.II/lac/precondition.h
include/deal.II/lac/precondition_block.h
include/deal.II/lac/precondition_block.templates.h
include/deal.II/lac/relaxation_block.h
include/deal.II/lac/solver.h
include/deal.II/lac/solver_bicgstab.h
include/deal.II/lac/solver_cg.h
include/deal.II/lac/solver_gmres.h
include/deal.II/lac/solver_minres.h
include/deal.II/lac/solver_qmrs.h
include/deal.II/lac/solver_relaxation.h
include/deal.II/lac/solver_richardson.h
include/deal.II/lac/solver_selector.h
include/deal.II/lac/sparse_decomposition.h
include/deal.II/lac/sparse_decomposition.templates.h
include/deal.II/lac/sparse_matrix.templates.h
include/deal.II/lac/sparse_matrix_ez.h
include/deal.II/lac/sparse_vanka.h
include/deal.II/lac/sparse_vanka.templates.h
include/deal.II/lac/tridiagonal_matrix.h
include/deal.II/lac/trilinos_block_sparse_matrix.h
include/deal.II/lac/trilinos_linear_operator.h
include/deal.II/lac/trilinos_parallel_block_vector.h
include/deal.II/lac/trilinos_solver.h
include/deal.II/lac/trilinos_sparse_matrix.h
include/deal.II/lac/trilinos_sparsity_pattern.h
include/deal.II/lac/trilinos_vector.h
include/deal.II/lac/vector.h
include/deal.II/lac/vector_memory.h
include/deal.II/lac/vector_memory.templates.h
include/deal.II/lac/vector_type_traits.h
include/deal.II/lac/vector_view.h
include/deal.II/matrix_free/fe_evaluation.h
include/deal.II/matrix_free/helper_functions.h
include/deal.II/matrix_free/mapping_info.templates.h
include/deal.II/matrix_free/matrix_free.h
include/deal.II/matrix_free/operators.h
include/deal.II/meshworker/assembler.h
include/deal.II/meshworker/dof_info.h
include/deal.II/meshworker/functional.h
include/deal.II/meshworker/integration_info.h
include/deal.II/meshworker/integration_info.templates.h
include/deal.II/meshworker/loop.h
include/deal.II/meshworker/output.h
include/deal.II/meshworker/simple.h
include/deal.II/meshworker/vector_selector.h
include/deal.II/multigrid/mg_coarse.h
include/deal.II/multigrid/mg_smoother.h
include/deal.II/multigrid/mg_transfer_block.h
include/deal.II/multigrid/multigrid.h
include/deal.II/numerics/dof_print_solver_step.h
include/deal.II/numerics/matrix_tools.h
include/deal.II/numerics/solution_transfer.h
include/deal.II/numerics/vector_tools.h
include/deal.II/numerics/vector_tools.templates.h
include/deal.II/physics/transformations.h
source/base/data_out_base.cc
source/base/flow_function.cc
source/base/function_lib.cc
source/base/function_lib_cutoff.cc
source/base/geometry_info.cc
source/base/polynomials_nedelec.cc
source/base/quadrature.cc
source/base/quadrature_lib.cc
source/base/tensor_product_polynomials.cc
source/distributed/solution_transfer.cc
source/distributed/tria.cc
source/dofs/dof_handler.cc
source/dofs/dof_tools.cc
source/dofs/dof_tools_constraints.cc
source/fe/fe_data.cc
source/fe/fe_dgp_monomial.cc
source/fe/fe_tools.cc
source/fe/mapping.cc
source/fe/mapping_c1.cc
source/fe/mapping_cartesian.cc
source/fe/mapping_fe_field.cc
source/fe/mapping_manifold.cc
source/fe/mapping_q.cc
source/fe/mapping_q1.cc
source/fe/mapping_q1_eulerian.cc
source/fe/mapping_q_eulerian.cc
source/fe/mapping_q_generic.cc
source/grid/grid_generator.cc
source/grid/grid_in.cc
source/grid/grid_reordering.cc
source/grid/grid_tools.cc
source/grid/manifold.cc
source/grid/tria.cc
source/grid/tria_accessor.cc
source/grid/tria_boundary_lib.cc
source/grid/tria_objects.cc
source/hp/dof_handler.cc
source/hp/mapping_collection.cc
source/lac/constraint_matrix.cc
source/lac/tridiagonal_matrix.cc
source/lac/trilinos_solver.cc
source/lac/trilinos_sparsity_pattern.cc
source/multigrid/mg_transfer_matrix_free.cc
source/multigrid/mg_transfer_prebuilt.cc
source/multigrid/multigrid.cc
source/numerics/solution_transfer.cc
source/opencascade/boundary_lib.cc
tests/aniso/fe_tools.cc
tests/aniso/solution_transfer.cc
tests/base/anisotropic_1.cc
tests/base/cell_data_storage_01.cc
tests/base/cell_data_storage_02.cc
tests/base/data_out_base.cc
tests/base/data_out_base_dx.cc
tests/base/data_out_base_eps.cc
tests/base/data_out_base_gmv.cc
tests/base/data_out_base_gnuplot.cc
tests/base/data_out_base_gnuplot_labels.cc
tests/base/data_out_base_gnuplot_labels_02.cc
tests/base/data_out_base_povray.cc
tests/base/data_out_base_tecplot.cc
tests/base/data_out_base_tecplot_bin.cc
tests/base/data_out_base_vtk.cc
tests/base/data_out_base_vtk_cycle.cc
tests/base/data_out_base_vtk_time.cc
tests/base/data_out_base_vtk_time_and_cycle.cc
tests/base/data_out_base_vtu.cc
tests/base/data_out_base_vtu_compression_levels.cc
tests/base/data_out_base_vtu_cycle.cc
tests/base/data_out_base_vtu_time.cc
tests/base/data_out_base_vtu_time_and_cycle.cc
tests/base/derivative_forms_01.cc
tests/base/derivative_forms_02.cc
tests/base/derivative_forms_03.cc
tests/base/derivative_forms_04.cc
tests/base/function_derivative.cc
tests/base/functions.h
tests/base/functions_04.cc
tests/base/functions_09.cc
tests/base/functions_constant_function_00.cc
tests/base/functions_singularity.cc
tests/base/functions_spherical_01.cc
tests/base/functions_spherical_02.cc
tests/base/geometry_info_8.cc
tests/base/memory_consumption_02.cc
tests/base/polynomial_test.cc
tests/base/polynomials_tensor.cc
tests/base/qprojector.cc
tests/base/quadrature_chebyshev.cc
tests/base/quadrature_point_data.cc
tests/base/quadrature_point_data_02.cc
tests/base/quadrature_point_data_03.cc
tests/base/symmetric_tensor_36.cc
tests/base/symmetric_tensor_37.cc
tests/base/table_05.cc
tests/base/work_stream_03.cc
tests/base/work_stream_03_graph.cc
tests/bits/deal_solver_04.cc
tests/bits/deal_solver_05.cc
tests/bits/error_estimator_01.cc
tests/bits/error_estimator_02.cc
tests/bits/fe_field_function_04.cc
tests/bits/fe_field_function_04_vector.cc
tests/bits/fe_field_function_05.cc
tests/bits/fe_field_function_05_vector.cc
tests/bits/fe_field_function_06_vector.cc
tests/bits/fe_field_function_07_vector.cc
tests/bits/fe_field_function_08_vector.cc
tests/bits/fe_system.cc
tests/bits/point_difference_01.cc
tests/bits/point_difference_02.cc
tests/bits/point_gradient_01.cc
tests/bits/point_gradient_02.cc
tests/bits/point_gradient_hp_01.cc
tests/bits/point_gradient_hp_02.cc
tests/bits/point_value_01.cc
tests/bits/point_value_02.cc
tests/bits/point_value_hp_01.cc
tests/bits/point_value_hp_02.cc
tests/bits/solution_transfer.cc
tests/codim_one/bem.cc
tests/codim_one/error_estimator_01.cc
tests/codim_one/error_estimator_02.cc
tests/codim_one/mapping_fe_field_01.cc
tests/distributed_grids/2d_coarse_grid_01.cc
tests/distributed_grids/2d_coarse_grid_02.cc
tests/distributed_grids/2d_coarse_grid_03.cc
tests/distributed_grids/2d_coarse_grid_04.cc
tests/distributed_grids/2d_coarse_grid_x_01.cc
tests/distributed_grids/2d_coarsening_01.cc
tests/distributed_grids/2d_coarsening_02.cc
tests/distributed_grids/2d_coarsening_03.cc
tests/distributed_grids/2d_coarsening_05.cc
tests/distributed_grids/2d_dofhandler_01.cc
tests/distributed_grids/2d_refinement_01.cc
tests/distributed_grids/2d_refinement_02.cc
tests/distributed_grids/2d_refinement_03.cc
tests/distributed_grids/2d_refinement_04.cc
tests/distributed_grids/2d_refinement_05.cc
tests/distributed_grids/2d_refinement_06.cc
tests/distributed_grids/2d_refinement_07.cc
tests/distributed_grids/2d_refinement_10.cc
tests/distributed_grids/3d_coarse_grid_01.cc
tests/distributed_grids/3d_coarse_grid_02.cc
tests/distributed_grids/3d_coarse_grid_03.cc
tests/distributed_grids/3d_coarse_grid_04.cc
tests/distributed_grids/3d_coarse_grid_05.cc
tests/distributed_grids/3d_coarse_grid_06.cc
tests/distributed_grids/3d_coarse_grid_x_01.cc
tests/distributed_grids/3d_coarsening_01.cc
tests/distributed_grids/3d_coarsening_02.cc
tests/distributed_grids/3d_coarsening_03.cc
tests/distributed_grids/3d_coarsening_04.cc
tests/distributed_grids/3d_coarsening_05.cc
tests/distributed_grids/3d_refinement_01.cc
tests/distributed_grids/3d_refinement_02.cc
tests/distributed_grids/3d_refinement_03.cc
tests/distributed_grids/3d_refinement_04.cc
tests/distributed_grids/3d_refinement_05.cc
tests/distributed_grids/3d_refinement_06.cc
tests/distributed_grids/3d_refinement_07.cc
tests/distributed_grids/3d_refinement_08.cc
tests/distributed_grids/3d_refinement_09.cc
tests/distributed_grids/3d_refinement_12.cc
tests/distributed_grids/anisotropic.cc
tests/distributed_grids/codim_01.cc
tests/distributed_grids/copy_tria_01.cc
tests/distributed_grids/count_dofs_per_block_01.cc
tests/distributed_grids/count_dofs_per_component_01.cc
tests/distributed_grids/dof_handler_number_cache.cc
tests/distributed_grids/solution_transfer_01.cc
tests/distributed_grids/solution_transfer_02.cc
tests/distributed_grids/solution_transfer_03.cc
tests/distributed_grids/solution_transfer_04.cc
tests/distributed_grids/tria_settings_01.cc
tests/distributed_grids/update_number_cache_01.cc
tests/dofs/accessor_01.cc
tests/dofs/block_info.cc
tests/dofs/block_info_02.cc
tests/dofs/count_dofs_on_patch.cc
tests/dofs/dof_handler_number_cache.cc
tests/dofs/dof_handler_number_cache_02.cc
tests/dofs/dof_tools_21_b.cc
tests/dofs/dof_tools_21_b_x.cc
tests/dofs/dof_tools_21_b_x_q3.cc
tests/dofs/dof_tools_21_b_y.cc
tests/dofs/dof_tools_21_c.cc
tests/dofs/dof_tools_extract_dofs_with_support_contained_within_01.cc
tests/dofs/dof_tools_extract_dofs_with_support_contained_within_02.cc
tests/dofs/dof_tools_extract_dofs_with_support_contained_within_03.cc
tests/dofs/dof_tools_extract_dofs_with_support_contained_within_04.cc
tests/dofs/get_dofs_on_patch.cc
tests/dofs/locally_relevant_dofs_per_subdomain_01.cc
tests/dofs/range_based_for_tria.cc
tests/fail/rt_4.cc
tests/fail/vectors_boundary_rhs_hp_02.cc
tests/fail/vectors_rhs_hp_02.cc
tests/fe/abf_03.cc
tests/fe/bdm_1.cc
tests/fe/bdm_10.cc
tests/fe/bdm_11.cc
tests/fe/bdm_12.cc
tests/fe/bdm_13.cc
tests/fe/bdm_14.cc
tests/fe/bdm_15.cc
tests/fe/bdm_16.cc
tests/fe/bdm_2.cc
tests/fe/bdm_3.cc
tests/fe/bdm_5.cc
tests/fe/bdm_8.cc
tests/fe/bdm_9.cc
tests/fe/cell_similarity_01.cc
tests/fe/cell_similarity_02.cc
tests/fe/cell_similarity_03.cc
tests/fe/cell_similarity_04.cc
tests/fe/cell_similarity_05.cc
tests/fe/cell_similarity_06.cc
tests/fe/cell_similarity_07.cc
tests/fe/cell_similarity_08.cc
tests/fe/cell_similarity_09.cc
tests/fe/cell_similarity_10.cc
tests/fe/cell_similarity_11.cc
tests/fe/cell_similarity_dgp_monomial_01.cc
tests/fe/cell_similarity_dgp_monomial_02.cc
tests/fe/cell_similarity_dgp_monomial_03.cc
tests/fe/cell_similarity_dgp_monomial_04.cc
tests/fe/cell_similarity_dgp_monomial_05.cc
tests/fe/cell_similarity_dgp_monomial_06.cc
tests/fe/cell_similarity_dgp_monomial_07.cc
tests/fe/cell_similarity_dgp_monomial_08.cc
tests/fe/cell_similarity_dgp_monomial_09.cc
tests/fe/cell_similarity_dgp_monomial_10.cc
tests/fe/cell_similarity_dgp_nonparametric_01.cc
tests/fe/cell_similarity_dgp_nonparametric_02.cc
tests/fe/cell_similarity_dgp_nonparametric_03.cc
tests/fe/cell_similarity_dgp_nonparametric_04.cc
tests/fe/cell_similarity_dgp_nonparametric_05.cc
tests/fe/cell_similarity_dgp_nonparametric_06.cc
tests/fe/cell_similarity_dgp_nonparametric_07.cc
tests/fe/cell_similarity_dgp_nonparametric_08.cc
tests/fe/cell_similarity_dgp_nonparametric_09.cc
tests/fe/cell_similarity_dgp_nonparametric_10.cc
tests/fe/copy_01.cc
tests/fe/curl_curl_01.cc
tests/fe/derivatives.cc
tests/fe/derivatives_bernstein.cc
tests/fe/derivatives_face.cc
tests/fe/dgp_01.cc
tests/fe/dgp_monomial_1.cc
tests/fe/dgp_monomial_2.cc
tests/fe/dgq_1.cc
tests/fe/element_constant_modes.cc
tests/fe/face_to_cell_q1_2d.cc
tests/fe/face_to_cell_q2_2d.cc
tests/fe/face_to_cell_q2xq2_2d.cc
tests/fe/face_to_cell_q3_2d.cc
tests/fe/face_to_cell_q3xq4_2d.cc
tests/fe/face_to_cell_q4_2d.cc
tests/fe/fe_abf_gradient_divergence_theorem.cc
tests/fe/fe_data_test.cc
tests/fe/fe_dgp_3rd_derivative_divergence_theorem.cc
tests/fe/fe_dgq_3rd_derivative_divergence_theorem.cc
tests/fe/fe_dgq_gradient_divergence_theorem.cc
tests/fe/fe_dgq_hessian_divergence_theorem.cc
tests/fe/fe_enriched_01.cc
tests/fe/fe_enriched_02.cc
tests/fe/fe_enriched_03.cc
tests/fe/fe_enriched_04.cc
tests/fe/fe_enriched_05.cc
tests/fe/fe_enriched_06.cc
tests/fe/fe_enriched_07.cc
tests/fe/fe_enriched_08.cc
tests/fe/fe_enriched_08a.cc
tests/fe/fe_enriched_compare_to_fe_system.cc
tests/fe/fe_enriched_compare_to_fe_system_2.cc
tests/fe/fe_enriched_step-36.cc
tests/fe/fe_enriched_step-36b.cc
tests/fe/fe_face_values_1d.cc
tests/fe/fe_nedelec_gradient_divergence_theorem.cc
tests/fe/fe_nedelec_hessian_divergence_theorem.cc
tests/fe/fe_nothing.cc
tests/fe/fe_project_2d.cc
tests/fe/fe_project_3d.cc
tests/fe/fe_q_3rd_derivative_divergence_theorem.cc
tests/fe/fe_q_dg0.cc
tests/fe/fe_q_gradient_divergence_theorem.cc
tests/fe/fe_q_hessian_divergence_theorem.cc
tests/fe/fe_q_hierarchical_3rd_derivative_divergence_theorem.cc
tests/fe/fe_rt_gradient_divergence_theorem.cc
tests/fe/fe_rt_hessian_divergence_theorem.cc
tests/fe/fe_series_02.cc
tests/fe/fe_series_04.cc
tests/fe/fe_series_05.cc
tests/fe/fe_system_3rd_derivative_divergence_theorem.cc
tests/fe/fe_tools.cc
tests/fe/fe_tools_block_renumbering.cc
tests/fe/fe_tools_test.cc
tests/fe/fe_values_no_mapping.cc
tests/fe/fe_values_view_01.cc
tests/fe/fe_values_view_02.cc
tests/fe/fe_values_view_03.cc
tests/fe/fe_values_view_04.cc
tests/fe/fe_values_view_05.cc
tests/fe/fe_values_view_06.cc
tests/fe/fe_values_view_07.cc
tests/fe/fe_values_view_08.cc
tests/fe/fe_values_view_09.cc
tests/fe/fe_values_view_10.cc
tests/fe/fe_values_view_10_single_01.cc
tests/fe/fe_values_view_10_single_02.cc
tests/fe/fe_values_view_10_single_03.cc
tests/fe/fe_values_view_11.cc
tests/fe/fe_values_view_12.cc
tests/fe/fe_values_view_13.cc
tests/fe/fe_values_view_14.cc
tests/fe/fe_values_view_15.cc
tests/fe/fe_values_view_16.cc
tests/fe/fe_values_view_17.cc
tests/fe/fe_values_view_18.cc
tests/fe/fe_values_view_19.cc
tests/fe/fe_values_view_20.cc
tests/fe/fe_values_view_23.cc
tests/fe/fe_values_view_23_nonsymmetric.cc
tests/fe/fe_values_view_24.cc
tests/fe/fe_values_view_24_nonsymmetric.cc
tests/fe/fe_values_view_25.cc
tests/fe/fe_values_view_25_nonsymmetric.cc
tests/fe/fe_values_view_26.cc
tests/fe/fe_values_view_27.cc
tests/fe/fe_values_view_28.cc
tests/fe/fe_values_view_29.cc
tests/fe/fe_values_view_30.cc
tests/fe/fe_values_view_invalid_01.cc
tests/fe/fe_values_view_invalid_02.cc
tests/fe/fe_values_view_invalid_03.cc
tests/fe/fe_values_view_invalid_03_nonsymmetric.cc
tests/fe/function.cc
tests/fe/interpolate_common.h
tests/fe/jacobians.cc
tests/fe/jacobians_face.cc
tests/fe/jacobians_face_cartesian.cc
tests/fe/jacobians_face_fe_field.cc
tests/fe/nedelec.cc
tests/fe/nedelec_2.cc
tests/fe/nedelec_3.cc
tests/fe/nedelec_non_rect_2d.cc
tests/fe/nedelec_non_rect_face.cc
tests/fe/p1nc_01.cc
tests/fe/p1nc_02.cc
tests/fe/p1nc_03.cc
tests/fe/p1nc_04.cc
tests/fe/p1nc_05.cc
tests/fe/p1nc_06.cc
tests/fe/p1nc_07.cc
tests/fe/p1nc_08.cc
tests/fe/q_1.cc
tests/fe/q_2.cc
tests/fe/q_3.cc
tests/fe/q_4.cc
tests/fe/rt_1.cc
tests/fe/rt_10.cc
tests/fe/rt_11.cc
tests/fe/rt_12.cc
tests/fe/rt_13.cc
tests/fe/rt_14.cc
tests/fe/rt_15.cc
tests/fe/rt_2.cc
tests/fe/rt_3.cc
tests/fe/rt_5.cc
tests/fe/rt_7.cc
tests/fe/rt_8.cc
tests/fe/rt_9.cc
tests/fe/rt_covariant.cc
tests/fe/rt_hessian.cc
tests/fe/rtdiff.cc
tests/fe/rtn_2.cc
tests/fe/rtn_3.cc
tests/fe/shapes.h
tests/fe/shapes_bernstein.cc
tests/fe/shapes_dgp.cc
tests/fe/shapes_dgp_monomial.cc
tests/fe/shapes_dgp_nonparametric.cc
tests/fe/shapes_dgq.cc
tests/fe/shapes_faceq.cc
tests/fe/shapes_nedelec.cc
tests/fe/shapes_q.cc
tests/fe/shapes_q_bubbles.cc
tests/fe/shapes_q_dg0.cc
tests/fe/shapes_q_hierarchical.cc
tests/fe/shapes_q_iso_q1.cc
tests/fe/shapes_system.cc
tests/fe/shapes_system_02.cc
tests/fe/shapes_traceq.cc
tests/fe/system_01.cc
tests/fe/system_02.cc
tests/fe/system_index.cc
tests/fe/transfer.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/coarsening_02.cc
tests/grid/coarsening_02_1d.cc
tests/grid/coarsening_03.cc
tests/grid/enclosing_sphere_01.cc
tests/grid/extent_in_direction.cc
tests/grid/filtered_iterator_05.cc
tests/grid/get_cells_at_coarsest_common_level_01.cc
tests/grid/get_cells_at_coarsest_common_level_02.cc
tests/grid/get_cells_at_coarsest_common_level_03.cc
tests/grid/get_dof_to_support_patch_map_01.cc
tests/grid/get_finest_common_cells_01.cc
tests/grid/get_finest_common_cells_02.cc
tests/grid/get_finest_common_cells_03.cc
tests/grid/get_patch_around_cell_01.cc
tests/grid/grid_generator_01.cc
tests/grid/grid_generator_01a.cc
tests/grid/grid_generator_01b.cc
tests/grid/grid_generator_02.cc
tests/grid/grid_generator_03.cc
tests/grid/grid_generator_04.cc
tests/grid/grid_generator_05.cc
tests/grid/grid_generator_06.cc
tests/grid/grid_generator_07.cc
tests/grid/grid_generator_08.cc
tests/grid/grid_generator_09.cc
tests/grid/grid_generator_hyper_sphere.cc
tests/grid/grid_hyper_shell.cc
tests/grid/grid_hyper_shell_02.cc
tests/grid/grid_hyper_shell_03.cc
tests/grid/grid_hyper_shell_04.cc
tests/grid/grid_hyper_shell_05.cc
tests/grid/grid_hyper_shell_06.cc
tests/grid/grid_in.cc
tests/grid/grid_in_msh.cc
tests/grid/grid_in_msh_03.cc
tests/grid/grid_in_msh_version_1.cc
tests/grid/grid_in_msh_version_2.cc
tests/grid/grid_in_unv_2d.cc
tests/grid/grid_in_unv_3d.cc
tests/grid/grid_in_unv_3d_02.cc
tests/grid/grid_in_vtk_2d.cc
tests/grid/grid_in_vtk_3d.cc
tests/grid/grid_in_vtk_3d_02.cc
tests/grid/grid_in_vtk_3d_03.cc
tests/grid/grid_in_vtk_3d_04.cc
tests/grid/grid_out_per_processor_vtu_01.cc
tests/grid/grid_out_per_processor_vtu_02.cc
tests/grid/grid_out_vtk_02.cc
tests/grid/grid_output_input.cc
tests/grid/grid_parallelepiped.cc
tests/grid/grid_parallelepiped_02.cc
tests/grid/grid_parallelepiped_03.cc
tests/grid/grid_parallelepiped_04.cc
tests/grid/grid_parallelepiped_05.cc
tests/grid/grid_tools_05.cc
tests/grid/grid_tools_06.cc
tests/grid/grid_tools_active_cell_layer_within_distance_01.cc
tests/grid/grid_tools_active_cell_layer_within_distance_02.cc
tests/grid/grid_tools_bounding_box_01.cc
tests/grid/grid_tools_halo_layer_01.cc
tests/grid/grid_tools_transform_01.cc
tests/grid/have_same_coarse_mesh_01.cc
tests/grid/have_same_coarse_mesh_02.cc
tests/grid/have_same_coarse_mesh_03.cc
tests/grid/measure_et_al.cc
tests/grid/measure_et_al_02.cc
tests/grid/merge_triangulations_02.cc
tests/grid/merge_triangulations_03.cc
tests/grid/recursively_set_material_id.cc
tests/grid/tria_signals_01.cc
tests/grid/twisted_parallelepiped_01.cc
tests/grid/twisted_parallelepiped_02.cc
tests/grid/user_data_01.cc
tests/hp/dof_handler_number_cache.cc
tests/hp/hp_constraints_neither_dominate_01.cc
tests/hp/hp_constraints_neither_dominate_02.cc
tests/hp/hp_q_hierarchical_constraints.cc
tests/hp/matrices.cc
tests/hp/matrices_hp.cc
tests/hp/n_boundary_dofs.cc
tests/hp/project_01.cc
tests/hp/project_01_curved_boundary.cc
tests/hp/project_02.cc
tests/hp/solution_transfer.cc
tests/hp/solution_transfer_12.cc
tests/hp/step-27.cc
tests/hp/vectors_boundary_rhs_01.cc
tests/hp/vectors_boundary_rhs_02.cc
tests/hp/vectors_boundary_rhs_03.cc
tests/hp/vectors_boundary_rhs_hp_01.cc
tests/hp/vectors_boundary_rhs_hp_03.cc
tests/hp/vectors_rhs_01.cc
tests/hp/vectors_rhs_02.cc
tests/hp/vectors_rhs_03.cc
tests/hp/vectors_rhs_hp_01.cc
tests/hp/vectors_rhs_hp_03.cc
tests/integrators/assembler_simple_system_inhom_01.cc
tests/integrators/cells_and_faces_01.cc
tests/integrators/functional_01.cc
tests/integrators/mesh_worker_01.cc
tests/integrators/mesh_worker_02.cc
tests/integrators/mesh_worker_03.cc
tests/integrators/mesh_worker_matrix_01.cc
tests/lac/filtered_matrix.cc
tests/lac/filtered_matrix_01.cc
tests/lac/filtered_matrix_02.cc
tests/lac/filtered_matrix_03.cc
tests/lac/filtered_matrix_04.cc
tests/lac/filtered_matrix_05.cc
tests/lac/gmres_eigenvalues.cc
tests/lac/identity_matrix_01.cc
tests/lac/identity_matrix_02.cc
tests/lac/identity_matrix_03.cc
tests/lac/identity_matrix_04.cc
tests/lac/identity_matrix_05.cc
tests/lac/identity_matrix_06.cc
tests/lac/linear_operator_05.cc
tests/lac/linear_operator_08.cc
tests/lac/linear_operator_10.cc
tests/lac/linear_operator_10a.cc
tests/lac/linear_operator_13.cc
tests/lac/linear_operator_14.cc
tests/lac/matrices_02.cc
tests/lac/pointer_matrix_01.cc
tests/lac/pointer_matrix_02.cc
tests/lac/pointer_matrix_03.cc
tests/lac/pointer_matrix_04.cc
tests/lac/pointer_matrix_05.cc
tests/lac/pointer_matrix_06.cc
tests/lac/pointer_matrix_07.cc
tests/lac/pointer_matrix_08.cc
tests/lac/pointer_matrix_09.cc
tests/lac/pointer_matrix_10.cc
tests/lac/quickmatrix.h
tests/lac/solver.cc
tests/lac/solver_02.cc
tests/lac/solver_control_01.cc
tests/lac/solver_control_02.cc
tests/lac/solver_control_03.cc
tests/lac/solver_control_04.cc
tests/lac/solver_memorytest.cc
tests/lac/solver_monitor.cc
tests/lac/solver_monitor_disconnect.cc
tests/lac/solver_relaxation_01.cc
tests/lac/solver_relaxation_02.cc
tests/lac/solver_relaxation_03.cc
tests/lac/solver_relaxation_04.cc
tests/lac/solver_signals.cc
tests/lac/sparse_matrices.cc
tests/lac/tridiagonal_matrix.cc
tests/lac/tridiagonal_matrix_sym.cc
tests/lac/vector_memory.cc
tests/lac/vector_view.cc
tests/lac/vector_view_01.cc
tests/lac/vector_view_02.cc
tests/lac/vector_view_03.cc
tests/lac/vector_view_04.cc
tests/lac/vector_view_05.cc
tests/lapack/solver_cg.cc
tests/manifold/copy_boundary_to_manifold_id_01.cc
tests/manifold/copy_material_to_manifold_id_01.cc
tests/manifold/polar_manifold_06.cc
tests/manifold/set_all_manifold_ids_01.cc
tests/manifold/set_all_manifold_ids_02.cc
tests/mappings/fe_face_values_1d_mapping_cartesian.cc
tests/mappings/fe_face_values_1d_mapping_q2.cc
tests/mappings/mapping.cc
tests/mappings/mapping_fe_field_01.cc
tests/mappings/mapping_fe_field_real_to_unit_b1.cc
tests/mappings/mapping_fe_field_real_to_unit_b2_curved.cc
tests/mappings/mapping_fe_field_real_to_unit_b2_mask.cc
tests/mappings/mapping_fe_field_real_to_unit_b3_curved.cc
tests/mappings/mapping_fe_field_real_to_unit_b4_curved.cc
tests/mappings/mapping_fe_field_real_to_unit_b5_curved.cc
tests/mappings/mapping_fe_field_real_to_unit_q1.cc
tests/mappings/mapping_fe_field_real_to_unit_q2_curved.cc
tests/mappings/mapping_fe_field_real_to_unit_q2_mask.cc
tests/mappings/mapping_fe_field_real_to_unit_q3_curved.cc
tests/mappings/mapping_fe_field_real_to_unit_q4_curved.cc
tests/mappings/mapping_fe_field_real_to_unit_q5_curved.cc
tests/mappings/mapping_manifold_01.cc
tests/mappings/mapping_manifold_02.cc
tests/mappings/mapping_manifold_03.cc
tests/mappings/mapping_manifold_04.cc
tests/mappings/mapping_manifold_05.cc
tests/mappings/mapping_manifold_06.cc
tests/mappings/mapping_manifold_07.cc
tests/mappings/mapping_q1_eulerian.cc
tests/mappings/mapping_q_convergence.cc
tests/mappings/mapping_q_manifold_01.cc
tests/mappings/mapping_q_manifold_02.cc
tests/mappings/mapping_real_to_unit_02.cc
tests/mappings/mapping_real_to_unit_q1.cc
tests/mappings/mapping_real_to_unit_q1_singular.cc
tests/mappings/mapping_real_to_unit_q4_curved.cc
tests/mappings/mapping_real_to_unit_q4_curved_codim.cc
tests/mappings/mapping_real_to_unit_q4_straight.cc
tests/matrix_free/parallel_multigrid.cc
tests/matrix_free/parallel_multigrid_02.cc
tests/matrix_free/parallel_multigrid_adaptive_01.cc
tests/matrix_free/parallel_multigrid_adaptive_02.cc
tests/matrix_free/parallel_multigrid_adaptive_03.cc
tests/matrix_free/parallel_multigrid_adaptive_04.cc
tests/matrix_free/parallel_multigrid_adaptive_05.cc
tests/matrix_free/parallel_multigrid_mf.cc
tests/meshworker/codim_01.cc
tests/mpi/attach_data_01.cc
tests/mpi/cell_weights_01.cc
tests/mpi/cell_weights_01_back_and_forth_01.cc
tests/mpi/cell_weights_01_back_and_forth_02.cc
tests/mpi/cell_weights_02.cc
tests/mpi/cell_weights_03.cc
tests/mpi/cell_weights_04.cc
tests/mpi/cell_weights_05.cc
tests/mpi/cell_weights_06.cc
tests/mpi/codim_01.cc
tests/mpi/communicate_moved_vertices_01.cc
tests/mpi/communicate_moved_vertices_02.cc
tests/mpi/compute_mean_value.cc
tests/mpi/condense_01.cc
tests/mpi/constraint_matrix_trilinos_bug.cc
tests/mpi/count_dofs_per_block_01.cc
tests/mpi/count_dofs_per_block_02.cc
tests/mpi/count_dofs_per_component_01.cc
tests/mpi/crash_01.cc
tests/mpi/crash_02.cc
tests/mpi/crash_03.cc
tests/mpi/crash_04.cc
tests/mpi/crash_05.cc
tests/mpi/crash_06.cc
tests/mpi/cuthill_mckee_01.cc
tests/mpi/distribute_flux_sparsity_pattern.cc
tests/mpi/dof_handler_number_cache.cc
tests/mpi/extract_boundary_dofs.cc
tests/mpi/extract_constant_modes_01.cc
tests/mpi/extract_constant_modes_02.cc
tests/mpi/extract_locally_active_dofs.cc
tests/mpi/fe_field_function_01.cc
tests/mpi/fe_field_function_02.cc
tests/mpi/fe_field_function_03.cc
tests/mpi/find_active_cell_around_point_01.cc
tests/mpi/has_active_dofs_01.cc
tests/mpi/has_active_dofs_02.cc
tests/mpi/has_hanging_nodes.cc
tests/mpi/integrate_difference.cc
tests/mpi/interpolate_01.cc
tests/mpi/interpolate_02.cc
tests/mpi/interpolate_03.cc
tests/mpi/interpolate_04.cc
tests/mpi/interpolate_to_different_mesh_01.cc
tests/mpi/is_locally_owned.cc
tests/mpi/make_zero_boundary_values.cc
tests/mpi/map_dofs_to_support_points.cc
tests/mpi/mesh_worker_01.cc
tests/mpi/mesh_worker_02.cc
tests/mpi/mesh_worker_03.cc
tests/mpi/mesh_worker_04.cc
tests/mpi/mesh_worker_05.cc
tests/mpi/mesh_worker_matrix_01.cc
tests/mpi/mg_01.cc
tests/mpi/mg_02.cc
tests/mpi/mg_03.cc
tests/mpi/mg_04.cc
tests/mpi/mg_05.cc
tests/mpi/mg_06.cc
tests/mpi/no_flux_constraints.cc
tests/mpi/no_flux_constraints_02.cc
tests/mpi/no_flux_constraints_03.cc
tests/mpi/normal_flux_constraints.cc
tests/mpi/p4est_2d_coarse_01.cc
tests/mpi/p4est_2d_constraintmatrix_01.cc
tests/mpi/p4est_2d_constraintmatrix_02.cc
tests/mpi/p4est_2d_constraintmatrix_03.cc
tests/mpi/p4est_2d_constraintmatrix_04.cc
tests/mpi/p4est_2d_constraintmatrix_05.cc
tests/mpi/p4est_2d_dofhandler_01.cc
tests/mpi/p4est_2d_dofhandler_02.cc
tests/mpi/p4est_2d_dofhandler_03.cc
tests/mpi/p4est_2d_dofhandler_04.cc
tests/mpi/p4est_2d_dofhandler_05.cc
tests/mpi/p4est_2d_ghost_01.cc
tests/mpi/p4est_2d_ghost_02.cc
tests/mpi/p4est_2d_refine_01.cc
tests/mpi/p4est_2d_refine_02.cc
tests/mpi/p4est_2d_refine_03.cc
tests/mpi/p4est_2d_renumber_01.cc
tests/mpi/p4est_2d_renumber_02.cc
tests/mpi/p4est_2d_simple.cc
tests/mpi/p4est_3d_constraintmatrix_01.cc
tests/mpi/p4est_3d_constraintmatrix_02.cc
tests/mpi/p4est_3d_constraintmatrix_03.cc
tests/mpi/p4est_3d_ghost_01.cc
tests/mpi/p4est_3d_refine_01.cc
tests/mpi/p4est_3d_refine_02.cc
tests/mpi/p4est_3d_refine_03.cc
tests/mpi/p4est_3d_refine_04.cc
tests/mpi/p4est_data_out_01.cc
tests/mpi/p4est_get_subdomain_association.cc
tests/mpi/p4est_max_refine.cc
tests/mpi/p4est_save_01.cc
tests/mpi/p4est_save_02.cc
tests/mpi/p4est_save_03.cc
tests/mpi/p4est_save_04.cc
tests/mpi/parallel_vtu_01.cc
tests/mpi/periodicity_04.cc
tests/mpi/petsc_03.cc
tests/mpi/point_value_01.cc
tests/mpi/renumber_cuthill_mckee.cc
tests/mpi/renumber_cuthill_mckee_02.cc
tests/mpi/renumber_z_order_01.cc
tests/mpi/renumber_z_order_02.cc
tests/mpi/repartition_01.cc
tests/mpi/repartition_02.cc
tests/mpi/repartition_03.cc
tests/mpi/solution_transfer_01.cc
tests/mpi/tria_01.cc
tests/mpi/tria_copy_triangulation.cc
tests/mpi/tria_signals_01.cc
tests/mpi/tria_signals_02.cc
tests/mpi/tria_signals_03.cc
tests/mpi/tria_signals_04.cc
tests/mpi/tria_signals_05.cc
tests/mpi/tria_signals_06.cc
tests/multigrid/mg_coarse_01.cc
tests/multigrid/mg_output_dirichlet.cc
tests/multigrid/mg_output_neumann.cc
tests/multigrid/smoother_block.cc
tests/multigrid/transfer_02.cc
tests/multigrid/transfer_03.cc
tests/multigrid/transfer_system_adaptive_01.cc
tests/multigrid/transfer_system_adaptive_02.cc
tests/multigrid/transfer_system_adaptive_03.cc
tests/multigrid/transfer_system_adaptive_04.cc
tests/multigrid/transfer_system_adaptive_05.cc
tests/multigrid/transfer_system_adaptive_06.cc
tests/multigrid/transfer_system_adaptive_07.cc
tests/multigrid/transfer_system_adaptive_08.cc
tests/multigrid/transfer_system_adaptive_09.cc
tests/numerics/boundaries.cc
tests/numerics/data_out_08.cc
tests/numerics/derivative_approximation_02.cc
tests/numerics/derivative_approximation_03.cc
tests/numerics/error_estimator.cc
tests/numerics/error_estimator_02.cc
tests/numerics/no_flux_01.cc
tests/numerics/no_flux_02.cc
tests/numerics/no_flux_03.cc
tests/numerics/no_flux_04.cc
tests/numerics/no_flux_05.cc
tests/numerics/no_flux_06.cc
tests/numerics/no_flux_07.cc
tests/numerics/no_flux_hp_01.cc
tests/numerics/no_flux_hp_02.cc
tests/numerics/no_flux_hp_03.cc
tests/numerics/no_flux_hp_04.cc
tests/numerics/no_flux_hp_05.cc
tests/numerics/normal_flux_01.cc
tests/numerics/normal_flux_02.cc
tests/numerics/normal_flux_03.cc
tests/numerics/normal_flux_hp_01.cc
tests/numerics/normal_flux_inhom_01.cc
tests/numerics/project_01.cc
tests/numerics/project_01_curved_boundary.cc
tests/numerics/project_02.cc
tests/numerics/project_boundary_01.cc
tests/numerics/project_boundary_rt_01.cc
tests/numerics/tangential_flux_inhom_01.cc
tests/numerics/vectors_boundary_rhs_01.cc
tests/numerics/vectors_boundary_rhs_02.cc
tests/numerics/vectors_boundary_rhs_03.cc
tests/numerics/vectors_point_source_01.cc
tests/numerics/vectors_rhs_01.cc
tests/numerics/vectors_rhs_03.cc
tests/petsc/64.cc
tests/petsc/deal_solver_01.cc
tests/petsc/deal_solver_02.cc
tests/petsc/deal_solver_03.cc
tests/petsc/deal_solver_04.cc
tests/petsc/deal_solver_05.cc
tests/petsc/solver_03.cc
tests/petsc/solver_03_mf.cc
tests/petsc/solver_03_precondition_boomeramg.cc
tests/petsc/solver_03_precondition_boomeramg_symmetric.cc
tests/petsc/solver_03_precondition_eisenstat.cc
tests/petsc/solver_03_precondition_icc.cc
tests/petsc/solver_03_precondition_ilu.cc
tests/petsc/solver_03_precondition_lu.cc
tests/petsc/solver_03_precondition_parasails.cc
tests/petsc/solver_03_precondition_sor.cc
tests/petsc/solver_03_precondition_ssor.cc
tests/petsc/solver_04.cc
tests/petsc/solver_05.cc
tests/petsc/solver_06.cc
tests/petsc/solver_07.cc
tests/petsc/solver_08.cc
tests/petsc/solver_09.cc
tests/petsc/solver_10.cc
tests/petsc/solver_12.cc
tests/petsc/solver_13.cc
tests/petsc_complex/parallel_sparse_matrix_01.cc
tests/petsc_complex/solver_real_03.cc
tests/petsc_complex/solver_real_03_mf.cc
tests/petsc_complex/solver_real_04.cc
tests/physics/elasticity-kinematics_01.cc
tests/physics/elasticity-standard_tensors_01.cc
tests/quick_tests/p4est.cc
tests/sharedtria/copy_tria_01.cc
tests/sharedtria/dof_01.cc
tests/sharedtria/dof_02.cc
tests/sharedtria/dof_03.cc
tests/sharedtria/dof_04.cc
tests/sharedtria/tria_01.cc
tests/sharedtria/tria_02.cc
tests/sharedtria/tria_custom_refine01.cc
tests/sharedtria/tria_custom_refine02.cc
tests/sharedtria/tria_load_01.cc
tests/sharedtria/tria_multigrid_01.cc
tests/sharedtria/tria_multigrid_02.cc
tests/sharedtria/tria_zorder_01.cc
tests/sharedtria/tria_zorder_02.cc
tests/slepc/solve_01.cc
tests/slepc/solve_04.cc
tests/slepc/testmatrix.h
tests/testmatrix.h
tests/tests.h
tests/trilinos/64.cc
tests/trilinos/deal_solver_01.cc
tests/trilinos/deal_solver_02.cc
tests/trilinos/deal_solver_03.cc
tests/trilinos/deal_solver_04.cc
tests/trilinos/deal_solver_05.cc
tests/trilinos/deal_solver_06.cc
tests/trilinos/elide_zeros.cc
tests/trilinos/solver_03.cc
tests/trilinos/solver_05.cc
tests/trilinos/solver_07.cc
tests/trilinos/solver_control_01.cc
tests/trilinos/solver_control_02.cc
tests/trilinos/solver_control_03.cc
tests/trilinos/sparse_matrix_mmult_01.cc

index a8aa054a293ef784fb11a79ae11d73795e1d76f7..41a9d30436323eeec5fd7f46b6c9415035df4a0a 100644 (file)
@@ -76,7 +76,7 @@ namespace Step26
   // that the <code>refine_mesh</code> function takes arguments for the
   // minimal and maximal mesh refinement level. The purpose of this is
   // discussed in the introduction.
-  template<int dim>
+  template <int dim>
   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<int dim>
+  template <int dim>
   class RightHandSide : public Function<dim>
   {
   public:
@@ -141,7 +141,7 @@ namespace Step26
 
 
 
-  template<int dim>
+  template <int dim>
   double RightHandSide<dim>::value (const Point<dim> &p,
                                     const unsigned int component) const
   {
@@ -172,7 +172,7 @@ namespace Step26
 
 
 
-  template<int dim>
+  template <int dim>
   class BoundaryValues : public Function<dim>
   {
   public:
@@ -182,7 +182,7 @@ namespace Step26
 
 
 
-  template<int dim>
+  template <int dim>
   double BoundaryValues<dim>::value (const Point<dim> &/*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<int dim>
+  template <int dim>
   HeatEquation<dim>::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<int dim>
+  template <int dim>
   void HeatEquation<dim>::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<int dim>
+  template <int dim>
   void HeatEquation<dim>::solve_time_step()
   {
     SolverControl solver_control(1000, 1e-8 * system_rhs.l2_norm());
@@ -296,7 +296,7 @@ namespace Step26
   // @sect4{<code>HeatEquation::output_results</code>}
   //
   // Neither is there anything new in generating graphical output:
-  template<int dim>
+  template <int dim>
   void HeatEquation<dim>::output_results() const
   {
     DataOut<dim> 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<int dim>
+  template <int dim>
   void HeatEquation<dim>::run()
   {
     const unsigned int initial_global_refinement = 2;
index af57be39f4cc0737443adbb4f0543e046c27d0fc..e6b66e28c599c76ac51a8a1fc0b6744767105a64 100644 (file)
@@ -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
index 6feeee47419b40595a459342ef02460264af9f8c..b7a2aee1b2479ab20eec7eddb0e6bc65e5c82d00 100644 (file)
@@ -375,7 +375,7 @@ namespace DataOutBase
    *
    * @ingroup output
    */
-  template<typename FlagsType>
+  template <typename FlagsType>
   struct OutputFlagsBase
   {
     /**
@@ -406,17 +406,17 @@ namespace DataOutBase
   };
 
 
-  template<typename FlagsType>
+  template <typename FlagsType>
   void OutputFlagsBase<FlagsType>::declare_parameters (ParameterHandler &)
   {}
 
 
-  template<typename FlagsType>
+  template <typename FlagsType>
   void OutputFlagsBase<FlagsType>::parse_parameters (const ParameterHandler &)
   {}
 
 
-  template<typename FlagsType>
+  template <typename FlagsType>
   std::size_t OutputFlagsBase<FlagsType>::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<int dim>
+    template <int dim>
     void write_point(const unsigned int &index, const Point<dim> &p);
 
     /**
      * Record a deal.II cell in the internal reordered format.
      */
-    template<int dim>
+    template <int dim>
     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 <tt>flags</tt>
    * to be a member of one of the child classes of <tt>OutputFlagsBase</tt>.
    */
-  template<typename FlagType>
+  template <typename FlagType>
   void set_flags (const FlagType &flags);
 
 
index 0274ef171376114a2a42808845dd05aa825d8fc1..46859929ffde6f58490a25afd66544cdbe398023 100644 (file)
@@ -48,7 +48,7 @@ namespace Functions
    * @ingroup functions
    * @author: Guido Kanschat, 1999
    */
-  template<int dim>
+  template <int dim>
   class SquareFunction : public Function<dim>
   {
   public:
@@ -82,7 +82,7 @@ namespace Functions
    * @ingroup functions
    * @author: Guido Kanschat, 2000
    */
-  template<int dim>
+  template <int dim>
   class Q1WedgeFunction : public Function<dim>
   {
   public:
@@ -137,7 +137,7 @@ namespace Functions
    * @ingroup functions
    * @author: Guido Kanschat, 1999
    */
-  template<int dim>
+  template <int dim>
   class PillowFunction : public Function<dim>
   {
   public:
@@ -199,7 +199,7 @@ namespace Functions
    * @ingroup functions
    * @author Guido Kanschat, 1999
    */
-  template<int dim>
+  template <int dim>
   class CosineFunction : public Function<dim>
   {
   public:
@@ -260,7 +260,7 @@ namespace Functions
    * @ingroup functions
    * @author Guido Kanschat, 2010
    */
-  template<int dim>
+  template <int dim>
   class CosineGradFunction : public Function<dim>
   {
   public:
@@ -302,7 +302,7 @@ namespace Functions
    * @ingroup functions
    * @author Guido Kanschat, 1999
    */
-  template<int dim>
+  template <int dim>
   class ExpFunction : public Function<dim>
   {
   public:
@@ -527,7 +527,7 @@ namespace Functions
    * @ingroup functions
    * @author: Guido Kanschat, 2000
    */
-  template<int dim>
+  template <int dim>
   class JumpFunction : public Function<dim>
   {
   public:
@@ -888,7 +888,7 @@ namespace Functions
    * @ingroup functions
    * @author Guido Kanschat, 2001, 2002
    */
-  template<int dim>
+  template <int dim>
   class CutOffFunctionLinfty : public CutOffFunctionBase<dim>
   {
   public:
@@ -933,7 +933,7 @@ namespace Functions
    * @ingroup functions
    * @author Guido Kanschat, 2001, 2002
    */
-  template<int dim>
+  template <int dim>
   class CutOffFunctionW1 : public CutOffFunctionBase<dim>
   {
   public:
@@ -980,7 +980,7 @@ namespace Functions
    * @ingroup functions
    * @author Guido Kanschat, 2001, 2002
    */
-  template<int dim>
+  template <int dim>
   class CutOffFunctionCinfty : public CutOffFunctionBase<dim>
   {
   public:
index 1c80ddd2cabb395c02015af22470a5b5ec245a2e..7829fde73f6f339b259d7a29949363cffbbbb297 100644 (file)
@@ -111,7 +111,7 @@ private:
 
 #ifndef DOXYGEN
 
-template<typename Number>
+template <typename Number>
 inline Number
 FunctionTime<Number>::get_time () const
 {
index 5ec72ad4c5567505ca7079a265b20eb84086ccd2..6c42d87f4f177a446e9c963883a2fdce8f6377bc 100644 (file)
@@ -21,7 +21,7 @@
 DEAL_II_NAMESPACE_OPEN
 
 
-template<typename Number>
+template <typename Number>
 FunctionTime<Number>::FunctionTime(const Number initial_time)
   :
   time(initial_time)
@@ -29,13 +29,13 @@ FunctionTime<Number>::FunctionTime(const Number initial_time)
 
 
 
-template<typename Number>
+template <typename Number>
 FunctionTime<Number>::~FunctionTime()
 {}
 
 
 
-template<typename Number>
+template <typename Number>
 void
 FunctionTime<Number>::set_time (const Number new_time)
 {
@@ -43,7 +43,7 @@ FunctionTime<Number>::set_time (const Number new_time)
 }
 
 
-template<typename Number>
+template <typename Number>
 void
 FunctionTime<Number>::advance_time (const Number delta_t)
 {
index 94d3ee412ce7900e45bfeae6a5bc33942c13b371..e22d428a9962487649dbe1b90ff4d560833b774b 100644 (file)
@@ -237,7 +237,7 @@ namespace MemoryConsumption
    * @note This returns the size of the pointer, not the size of the object
    * pointed to.
    */
-  template<typename T>
+  template <typename T>
   inline
   std::size_t
   memory_consumption (const T *const);
@@ -388,7 +388,7 @@ namespace MemoryConsumption
 
 
 
-  template<typename T>
+  template <typename T>
   inline
   std::size_t
   memory_consumption(const T *const)
index 1f8d689af7fefabf241512503ee350d6ffdb6764..cf632d0a583d6a4dd72cbaf238e2da75183ababc 100644 (file)
@@ -43,7 +43,7 @@ DEAL_II_NAMESPACE_OPEN
  * @ingroup data
  * @author Wolfgang Bangerth, Guido Kanschat, 1999, 2005, 2010
  */
-template<class Object>
+template <class Object>
 class MGLevelObject : public Subscriptor
 {
 public:
@@ -157,7 +157,7 @@ private:
 /* ------------------------------------------------------------------- */
 
 
-template<class Object>
+template <class Object>
 MGLevelObject<Object>::MGLevelObject(const unsigned int min,
                                      const unsigned int max)
   :
@@ -167,7 +167,7 @@ MGLevelObject<Object>::MGLevelObject(const unsigned int min,
 }
 
 
-template<class Object>
+template <class Object>
 Object &
 MGLevelObject<Object>::operator[] (const unsigned int i)
 {
@@ -177,7 +177,7 @@ MGLevelObject<Object>::operator[] (const unsigned int i)
 }
 
 
-template<class Object>
+template <class Object>
 const Object &
 MGLevelObject<Object>::operator[] (const unsigned int i) const
 {
@@ -187,7 +187,7 @@ MGLevelObject<Object>::operator[] (const unsigned int i) const
 }
 
 
-template<class Object>
+template <class Object>
 void
 MGLevelObject<Object>::resize (const unsigned int new_minlevel,
                                const unsigned int new_maxlevel)
@@ -205,7 +205,7 @@ MGLevelObject<Object>::resize (const unsigned int new_minlevel,
 }
 
 
-template<class Object>
+template <class Object>
 MGLevelObject<Object> &
 MGLevelObject<Object>::operator = (const double d)
 {
@@ -216,7 +216,7 @@ MGLevelObject<Object>::operator = (const double d)
 }
 
 
-template<class Object>
+template <class Object>
 void
 MGLevelObject<Object>::clear () // DEPRECATED
 {
@@ -225,7 +225,7 @@ MGLevelObject<Object>::clear () // DEPRECATED
 }
 
 
-template<class Object>
+template <class Object>
 void
 MGLevelObject<Object>::clear_elements ()
 {
@@ -235,7 +235,7 @@ MGLevelObject<Object>::clear_elements ()
 }
 
 
-template<class Object>
+template <class Object>
 unsigned int
 MGLevelObject<Object>::min_level () const
 {
@@ -243,7 +243,7 @@ MGLevelObject<Object>::min_level () const
 }
 
 
-template<class Object>
+template <class Object>
 unsigned int
 MGLevelObject<Object>::max_level () const
 {
@@ -251,7 +251,7 @@ MGLevelObject<Object>::max_level () const
 }
 
 
-template<class Object>
+template <class Object>
 std::size_t
 MGLevelObject<Object>::memory_consumption () const
 {
index 8b20afef3b4fdcd53f37e318748bae5e05048f41..2e96652a7b18cc5ca310a28a185e2472b8b395ea 100644 (file)
@@ -430,7 +430,7 @@ Point<dim,Number>::operator - () const
 
 
 template <int dim, typename Number>
-template<typename OtherNumber>
+template <typename OtherNumber>
 inline
 Point<dim,typename ProductType<Number, typename EnableIfScalar<OtherNumber>::type>::type>
 Point<dim,Number>::operator * (const OtherNumber factor) const
@@ -444,7 +444,7 @@ Point<dim,Number>::operator * (const OtherNumber factor) const
 
 
 template <int dim, typename Number>
-template<typename OtherNumber>
+template <typename OtherNumber>
 inline
 Point<dim,typename ProductType<Number, typename EnableIfScalar<OtherNumber>::type>::type>
 Point<dim,Number>::operator / (const OtherNumber factor) const
index a8964e8fbcffd9e644f6c625c9a71b5c23581f11..5ce23ebd8e607d7cc61fb39c5a82736a7f88c46f 100644 (file)
@@ -280,7 +280,7 @@ PolynomialSpace<dim>::PolynomialSpace (const std::vector<Pol> &pols)
 }
 
 
-template<int dim>
+template <int dim>
 inline
 unsigned int
 PolynomialSpace<dim>::n() const
@@ -290,7 +290,7 @@ PolynomialSpace<dim>::n() const
 
 
 
-template<int dim>
+template <int dim>
 inline
 unsigned int
 PolynomialSpace<dim>::degree() const
index 46daf6715ed232b2a749a389a711af5508cb5937..f1869b6c1260e5216aa361afeb96bcd226d5ef78 100644 (file)
@@ -325,7 +325,7 @@ private:
 // -------------------  inline and template functions ----------------
 
 
-template<int dim>
+template <int dim>
 inline
 unsigned int
 Quadrature<dim>::size () const
index cb1299d8e2dca2a31217618cb8749d93e232dc2e..715150f0976b1643699ee56902e127006cc48ac5 100644 (file)
@@ -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<typename T=DataType>
+  template <typename T=DataType>
   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<typename T=DataType>
+  template <typename T=DataType>
   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<typename T=DataType>
+  template <typename T=DataType>
   std::vector<std::shared_ptr<T> > get_data(const CellIteratorType &cell);
 
   /**
@@ -139,7 +139,7 @@ public:
    *
    * @pre The type @p T needs to match the class provided to initialize() .
    */
-  template<typename T=DataType>
+  template <typename T=DataType>
   std::vector<std::shared_ptr<const T> > get_data(const CellIteratorType &cell) const;
 
 private:
@@ -496,7 +496,7 @@ CellDataStorage<CellIteratorType,DataType>::
 
 
 template <typename CellIteratorType, typename DataType>
-template<typename T>
+template <typename T>
 void CellDataStorage<CellIteratorType,DataType>::initialize(const CellIteratorType &cell,
                                                             const unsigned int n_q_points)
 {
@@ -517,7 +517,7 @@ void CellDataStorage<CellIteratorType,DataType>::initialize(const CellIteratorTy
 
 
 template <typename CellIteratorType, typename DataType>
-template<typename T>
+template <typename T>
 void CellDataStorage<CellIteratorType,DataType>::initialize(const CellIteratorType &cell_start,
                                                             const CellIteratorType &cell_end,
                                                             const unsigned int number)
@@ -623,7 +623,7 @@ CellDataStorage<CellIteratorType,DataType>::get_data(const CellIteratorType &cel
  * whereas the second index represents different values stored at each
  * quadrature point in the DataType class.
  */
-template<typename CellIteratorType, typename DataType>
+template <typename CellIteratorType, typename DataType>
 void pack_cell_data
 (const CellIteratorType &cell,
  const CellDataStorage<CellIteratorType,DataType> *data_storage,
@@ -656,7 +656,7 @@ void pack_cell_data
 /*
  * the opposite of the pack function above.
  */
-template<typename CellIteratorType, typename DataType>
+template <typename CellIteratorType, typename DataType>
 void unpack_to_cell_data
 (const CellIteratorType &cell,
  const FullMatrix<double> &values_at_qp,
@@ -688,7 +688,7 @@ namespace parallel
 {
   namespace distributed
   {
-    template<int dim, typename DataType>
+    template <int dim, typename DataType>
     ContinuousQuadratureDataTransfer<dim,DataType>::ContinuousQuadratureDataTransfer
     (const FiniteElement<dim> &projection_fe_,
      const Quadrature<dim> &lhs_quadrature,
@@ -720,13 +720,13 @@ namespace parallel
 
 
 
-    template<int dim, typename DataType>
+    template <int dim, typename DataType>
     ContinuousQuadratureDataTransfer<dim,DataType>::~ContinuousQuadratureDataTransfer()
     {}
 
 
 
-    template<int dim, typename DataType>
+    template <int dim, typename DataType>
     void ContinuousQuadratureDataTransfer<dim,DataType>::prepare_for_coarsening_and_refinement
     (parallel::distributed::Triangulation<dim> &tr_,
      CellDataStorage<CellIteratorType,DataType> &data_storage_)
@@ -767,7 +767,7 @@ namespace parallel
 
 
 
-    template<int dim, typename DataType>
+    template <int dim, typename DataType>
     void ContinuousQuadratureDataTransfer<dim,DataType>::interpolate ()
     {
       triangulation->notify_ready_to_unpack(offset,
@@ -784,7 +784,7 @@ namespace parallel
 
 
 
-    template<int dim, typename DataType>
+    template <int dim, typename DataType>
     void ContinuousQuadratureDataTransfer<dim,DataType>::pack_function
     (const typename parallel::distributed::Triangulation<dim,dim>::cell_iterator &cell,
      const typename parallel::distributed::Triangulation<dim,dim>::CellStatus /*status*/,
@@ -802,7 +802,7 @@ namespace parallel
 
 
 
-    template<int dim, typename DataType>
+    template <int dim, typename DataType>
     void ContinuousQuadratureDataTransfer<dim,DataType>::
     unpack_function (const typename parallel::distributed::Triangulation<dim,dim>::cell_iterator &cell,
                      const typename parallel::distributed::Triangulation<dim,dim>::CellStatus status,
index 025dc07f146c02e7179b0a5f3178bfc0ee8583dc..3316963106a4f8ed08fe0860242c6deb5bfd54d6 100644 (file)
@@ -36,7 +36,7 @@ DEAL_II_NAMESPACE_OPEN
  * @ingroup Quadrature
  * @author Ralf Schulz, 2003
  */
-template<int dim>
+template <int dim>
 class QuadratureSelector : public Quadrature<dim>
 {
 public:
index 4c8e5fadfa3b673d505bfc45b48e3cd519c2df12..4be387daad5ccf156258c082e139b2f0f9175663 100644 (file)
@@ -59,7 +59,7 @@ DEAL_II_NAMESPACE_OPEN
  * @ingroup memory
  * @author Guido Kanschat, Wolfgang Bangerth, 1998 - 2009
  */
-template<typename T, typename P = void>
+template <typename T, typename P = void>
 class SmartPointer
 {
 public:
index 17289b48f223a7c1c533fed8580344e0ba6dbd63..f8fef1f735c23216574dfb9cc82b8a54cc229922 100644 (file)
@@ -471,7 +471,7 @@ public:
    * This function requires that the type <tt>T2</tt> is convertible to
    * <tt>T</tt>.
    */
-  template<typename T2>
+  template <typename T2>
   TableBase<N,T> &operator = (const TableBase<N,T2> &src);
 
   /**
index cc79e2c0fa12e9da4ddb9347a7094e455f02dcbf..79d68ae21abdaf1832485dacef54b426d06e6b53 100644 (file)
@@ -600,7 +600,7 @@ protected:
      */
     template <class Archive>
     void save(Archive &ar, const unsigned int version) const;
-    template<class Archive>
+    template <class Archive>
     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<class Archive>
+template <class Archive>
 void
 TableHandler::Column::load(Archive &ar, const unsigned int /*version*/)
 {
index 58748bae7284289da30a488e3f45cd31aa4ab981..a34599104ea4de20c68f78681ab812b366b17167 100644 (file)
@@ -181,25 +181,25 @@ public:
   /**
    * Test for equality of two tensors.
    */
-  template<typename OtherNumber>
+  template <typename OtherNumber>
   bool operator == (const Tensor<0,dim,OtherNumber> &rhs) const;
 
   /**
    * Test for inequality of two tensors.
    */
-  template<typename OtherNumber>
+  template <typename OtherNumber>
   bool operator != (const Tensor<0,dim,OtherNumber> &rhs) const;
 
   /**
    * Add another scalar
    */
-  template<typename OtherNumber>
+  template <typename OtherNumber>
   Tensor<0,dim,Number> &operator += (const Tensor<0,dim,OtherNumber> &rhs);
 
   /**
    * Subtract another scalar.
    */
-  template<typename OtherNumber>
+  template <typename OtherNumber>
   Tensor<0,dim,Number> &operator -= (const Tensor<0,dim,OtherNumber> &rhs);
 
   /**
@@ -207,13 +207,13 @@ public:
    *
    * @ingroup CUDAWrappers
    */
-  template<typename OtherNumber>
+  template <typename OtherNumber>
   DEAL_II_CUDA_HOST_DEV Tensor<0,dim,Number> &operator *= (const OtherNumber factor);
 
   /**
    * Divide the scalar by <tt>factor</tt>.
    */
-  template<typename OtherNumber>
+  template <typename OtherNumber>
   Tensor<0,dim,Number> &operator /= (const OtherNumber factor);
 
   /**
@@ -1619,9 +1619,9 @@ scalar_product (const Tensor<rank, dim, Number> &left,
  * @relates Tensor
  * @author Matthias Maier, 2015, Jean-Paul Pelteret 2017
  */
-template <template<int, int, typename> class TensorT1,
-          template<int, int, typename> class TensorT2,
-          template<int, int, typename> class TensorT3,
+template <template <int, int, typename> class TensorT1,
+          template <int, int, typename> class TensorT2,
+          template <int, int, typename> class TensorT3,
           int rank_1, int rank_2, int dim,
           typename T1, typename T2, typename T3>
 typename ProductType<T1, typename ProductType<T2, T3>::type>::type
index 89720cb856e673fb77681dc0224da1d91623ce36..52c7ca7bf1ab576d94d57122ad90dec485b33ce8 100644 (file)
@@ -52,7 +52,7 @@ DEAL_II_NAMESPACE_OPEN
  * <code>operator[](unsigned int)</code> that returns a (const or non-const)
  * reference of <code>value_type</code>:
  * @code
- *   template<...>
+ *   template <...>
  *   class T
  *   {
  *     typedef ... value_type;
@@ -214,7 +214,7 @@ namespace TensorAccessors
    *
    * @author Matthias Maier, 2015
    */
-  template<int rank, typename T, typename ArrayType> typename
+  template <int rank, typename T, typename ArrayType> typename
   ReturnType<rank, T>::value_type &
   extract(T &t, const ArrayType &indices)
   {
@@ -331,7 +331,7 @@ namespace TensorAccessors
      * StoreIndex and ReorderedIndexView that return rvalues, we have to
      * return by value.
      */
-    template<typename T>
+    template <typename T>
     struct ReferenceType
     {
       typedef T &type;
@@ -538,10 +538,10 @@ namespace TensorAccessors
     // Straightforward recursion implemented by specializing ExtractHelper
     // for position == rank. We use the type trait ReturnType<rank, T> to
     // have an idea what the final type will be.
-    template<int position, int rank>
+    template <int position, int rank>
     struct ExtractHelper
     {
-      template<typename T, typename ArrayType>
+      template <typename T, typename ArrayType>
       inline
       static
       typename ReturnType<rank - position, T>::value_type &
@@ -556,10 +556,10 @@ namespace TensorAccessors
 
     // For position == rank there is nothing to extract, just return the
     // object.
-    template<int rank>
+    template <int rank>
     struct ExtractHelper<rank, rank>
     {
-      template<typename T, typename ArrayType>
+      template <typename T, typename ArrayType>
       inline
       static
       T &extract(T &t,
@@ -589,7 +589,7 @@ namespace TensorAccessors
     class Contract
     {
     public:
-      template<typename T1, typename T2, typename T3>
+      template <typename T1, typename T2, typename T3>
       inline DEAL_II_ALWAYS_INLINE static
       void contract(T1 &result, const T2 &left, const T3 &right)
       {
@@ -617,7 +617,7 @@ namespace TensorAccessors
     class Contract<no_contr, no_contr, rank_2, dim>
     {
     public:
-      template<typename T1, typename T2, typename T3>
+      template <typename T1, typename T2, typename T3>
       inline DEAL_II_ALWAYS_INLINE static
       void contract(T1 &result, const T2 &left, const T3 &right)
       {
@@ -645,7 +645,7 @@ namespace TensorAccessors
     class Contract<no_contr, no_contr, no_contr, dim>
     {
     public:
-      template<typename T1, typename T2, typename T3>
+      template <typename T1, typename T2, typename T3>
       inline DEAL_II_ALWAYS_INLINE static
       void contract(T1 &result, const T2 &left, const T3 &right)
       {
@@ -661,7 +661,7 @@ namespace TensorAccessors
     class Contract2
     {
     public:
-      template<typename T1, typename T2, typename T3>
+      template <typename T1, typename T2, typename T3>
       inline DEAL_II_ALWAYS_INLINE static
       T1 contract2(const T2 &left, const T3 &right)
       {
@@ -679,7 +679,7 @@ namespace TensorAccessors
     class Contract2<0, dim>
     {
     public:
-      template<typename T1, typename T2, typename T3>
+      template <typename T1, typename T2, typename T3>
       inline DEAL_II_ALWAYS_INLINE static
       T1 contract2(const T2 &left, const T3 &right)
       {
@@ -706,7 +706,7 @@ namespace TensorAccessors
     class Contract3
     {
     public:
-      template<typename T1, typename T2, typename T3, typename T4>
+      template <typename T1, typename T2, typename T3, typename T4>
       static inline
       T1 contract3(const T2 &left, const T3 &middle, const T4 &right)
       {
@@ -732,7 +732,7 @@ namespace TensorAccessors
     class Contract3<0, rank_2, dim>
     {
     public:
-      template<typename T1, typename T2, typename T3, typename T4>
+      template <typename T1, typename T2, typename T3, typename T4>
       static inline
       T1 contract3(const T2 &left, const T3 &middle, const T4 &right)
       {
@@ -750,7 +750,7 @@ namespace TensorAccessors
     class Contract3<0, 0, dim>
     {
     public:
-      template<typename T1, typename T2, typename T3, typename T4>
+      template <typename T1, typename T2, typename T3, typename T4>
       static inline
       T1 contract3(const T2 &left, const T3 &middle, const T4 &right)
       {
index 867a75f78a29a34831641cb5aea9f2dccfa988f7..39a848324c5e45fbda4f43fad18fb99a12b8bfc3 100644 (file)
@@ -326,7 +326,7 @@ namespace Utilities
    * This function simply makes the assumption that the sequence is sorted,
    * and we simply don't do the additional check.
    */
-  template<typename Iterator, typename T>
+  template <typename Iterator, typename T>
   Iterator
   lower_bound (Iterator  first,
                Iterator  last,
@@ -338,7 +338,7 @@ namespace Utilities
    * compare individual elements of the sequence of objects pointed to by the
    * iterators.
    */
-  template<typename Iterator, typename T, typename Comp>
+  template <typename Iterator, typename T, typename Comp>
   Iterator
   lower_bound (Iterator   first,
                Iterator   last,
@@ -618,7 +618,7 @@ namespace Utilities
 
 
 
-  template<typename Iterator, typename T>
+  template <typename Iterator, typename T>
   inline
   Iterator
   lower_bound (Iterator  first,
@@ -631,7 +631,7 @@ namespace Utilities
 
 
 
-  template<typename Iterator, typename T, typename Comp>
+  template <typename Iterator, typename T, typename Comp>
   inline
   Iterator
   lower_bound (Iterator    first,
index 96e2d941d53258f8781b098081245f38a06f4f06..96231eaf35f93a24586cc2d73d995186990e3460 100644 (file)
@@ -87,7 +87,7 @@ namespace internal
 // Enable the EnableIfScalar type trait for VectorizedArray<Number> such
 // that it can be used as a Number type in Tensor<rank,dim,Number>, etc.
 
-template<typename Number>
+template <typename Number>
 struct EnableIfScalar<VectorizedArray<Number> >
 {
   typedef VectorizedArray<typename EnableIfScalar<Number>::type> type;
@@ -877,7 +877,7 @@ vectorized_transpose_and_store(const bool                     add_into,
 /**
  * Specialization for float and AVX512.
  */
-template<>
+template <>
 class VectorizedArray<float>
 {
 public:
@@ -1648,7 +1648,7 @@ vectorized_transpose_and_store(const bool                     add_into,
 /**
  * Specialization for float and AVX.
  */
-template<>
+template <>
 class VectorizedArray<float>
 {
 public:
index 2fe9c739f665f0e883a89ccd318e776b75a551a5..1fb2741a08651ca1cf6c6180c31785a68da58d68 100644 (file)
@@ -687,7 +687,7 @@ namespace internal
       }
 
 
-      template<int dim, int spacedim>
+      template <int dim, int spacedim>
       static
       types::global_dof_index
       mg_vertex_dof_index (const dealii::DoFHandler<dim,spacedim> &dof_handler,
@@ -699,7 +699,7 @@ namespace internal
       }
 
 
-      template<int dim, int spacedim>
+      template <int dim, int spacedim>
       static
       types::global_dof_index
       mg_vertex_dof_index (const dealii::hp::DoFHandler<dim,spacedim> &,
@@ -712,7 +712,7 @@ namespace internal
       }
 
 
-      template<int dim, int spacedim>
+      template <int dim, int spacedim>
       static
       void
       set_mg_vertex_dof_index (dealii::DoFHandler<dim,spacedim> &dof_handler,
@@ -725,7 +725,7 @@ namespace internal
       }
 
 
-      template<int dim, int spacedim>
+      template <int dim, int spacedim>
       static
       void
       set_mg_vertex_dof_index (dealii::hp::DoFHandler<dim,spacedim> &,
@@ -1244,7 +1244,7 @@ namespace internal
       }
 
 
-      template<int dim, int spacedim>
+      template <int dim, int spacedim>
       static
       types::global_dof_index
       get_vertex_dof_index (const dealii::hp::DoFHandler<dim,spacedim> &dof_handler,
@@ -1302,7 +1302,7 @@ namespace internal
        * Return the number of different finite elements that are active on a
        * given vertex.
        */
-      template<int dim, int spacedim>
+      template <int dim, int spacedim>
       static
       unsigned int
       n_active_vertex_fe_indices (const dealii::hp::DoFHandler<dim,spacedim> &dof_handler,
@@ -1349,7 +1349,7 @@ namespace internal
        * Return the fe index of the n-th finite element active on a given
        * vertex.
        */
-      template<int dim, int spacedim>
+      template <int dim, int spacedim>
       static
       unsigned int
       nth_active_vertex_fe_index (const dealii::hp::DoFHandler<dim,spacedim> &dof_handler,
@@ -1406,7 +1406,7 @@ namespace internal
        * Return whether a particular finite element index is active on the
        * specified vertex.
        */
-      template<int dim, int spacedim>
+      template <int dim, int spacedim>
       static
       bool
       fe_is_active_on_vertex (const dealii::hp::DoFHandler<dim,spacedim> &dof_handler,
@@ -1456,7 +1456,7 @@ namespace internal
           }
       }
 
-      template<typename DoFHandlerType, bool level_dof_access>
+      template <typename DoFHandlerType, bool level_dof_access>
       static
       void set_mg_dof_indices (const dealii::DoFAccessor<1,DoFHandlerType,level_dof_access> &,
                                const int,
@@ -1468,7 +1468,7 @@ namespace internal
 
 
 
-      template<typename DoFHandlerType, bool level_dof_access>
+      template <typename DoFHandlerType, bool level_dof_access>
       static
       void set_mg_dof_indices (dealii::DoFAccessor<2, DoFHandlerType,level_dof_access> &accessor,
                                const int level,
@@ -1495,7 +1495,7 @@ namespace internal
 
 
 
-      template<typename DoFHandlerType, bool level_dof_access>
+      template <typename DoFHandlerType, bool level_dof_access>
       static
       void set_mg_dof_indices
       (const dealii::DoFAccessor<3, DoFHandlerType,level_dof_access>      &accessor,
@@ -1614,7 +1614,7 @@ DoFAccessor<dim,DoFHandlerType,level_dof_access>::dof_index (const unsigned int
 }
 
 
-template<int structdim, typename DoFHandlerType, bool level_dof_access>
+template <int structdim, typename DoFHandlerType, bool level_dof_access>
 inline
 types::global_dof_index
 DoFAccessor<structdim, DoFHandlerType,level_dof_access>::mg_dof_index (const int level,
@@ -1710,7 +1710,7 @@ DoFAccessor<structdim, DoFHandlerType,level_dof_access>::vertex_dof_index
 }
 
 
-template<int structdim, typename DoFHandlerType, bool level_dof_access>
+template <int structdim, typename DoFHandlerType, bool level_dof_access>
 inline
 types::global_dof_index
 DoFAccessor<structdim, DoFHandlerType,level_dof_access>::mg_vertex_dof_index (const int level,
@@ -1751,7 +1751,7 @@ DoFAccessor<structdim, DoFHandlerType,level_dof_access>::set_vertex_dof_index (c
 }
 
 
-template<int structdim, typename DoFHandlerType, bool level_dof_access>
+template <int structdim, typename DoFHandlerType, bool level_dof_access>
 inline
 void
 DoFAccessor<structdim, DoFHandlerType,level_dof_access>::set_mg_vertex_dof_index
@@ -1778,7 +1778,7 @@ DoFAccessor<structdim, DoFHandlerType,level_dof_access>::set_mg_vertex_dof_index
 }
 
 
-template<int structdim, typename DoFHandlerType, bool level_dof_access>
+template <int structdim, typename DoFHandlerType, bool level_dof_access>
 inline
 void
 DoFAccessor<structdim, DoFHandlerType,level_dof_access>::set_mg_dof_index
@@ -1942,7 +1942,7 @@ namespace internal
 
 
 
-    template<typename DoFHandlerType, bool level_dof_access>
+    template <typename DoFHandlerType, bool level_dof_access>
     void get_mg_dof_indices
     (const dealii::DoFAccessor<1, DoFHandlerType,level_dof_access> &accessor,
      const int                                                      level,
@@ -1967,7 +1967,7 @@ namespace internal
 
 
 
-    template<typename DoFHandlerType, bool level_dof_access>
+    template <typename DoFHandlerType, bool level_dof_access>
     void get_mg_dof_indices (const dealii::DoFAccessor<2, DoFHandlerType,level_dof_access> &accessor,
                              const int level,
                              std::vector<types::global_dof_index> &dof_indices,
@@ -1995,7 +1995,7 @@ namespace internal
 
 
 
-    template<typename DoFHandlerType, bool level_dof_access>
+    template <typename DoFHandlerType, bool level_dof_access>
     void get_mg_dof_indices
     (const dealii::DoFAccessor<3, DoFHandlerType,level_dof_access> &accessor,
      const int                                                      level,
@@ -2100,7 +2100,7 @@ DoFAccessor<structdim,DoFHandlerType,level_dof_access>::get_dof_indices
 
 
 
-template<int structdim, typename DoFHandlerType, bool level_dof_access>
+template <int structdim, typename DoFHandlerType, bool level_dof_access>
 inline
 void DoFAccessor<structdim, DoFHandlerType,level_dof_access>::get_mg_dof_indices
 (const int                             level,
@@ -2152,7 +2152,7 @@ void DoFAccessor<structdim, DoFHandlerType,level_dof_access>::get_mg_dof_indices
 }
 
 
-template<int structdim, typename DoFHandlerType, bool level_dof_access>
+template <int structdim, typename DoFHandlerType, bool level_dof_access>
 inline
 void DoFAccessor<structdim, DoFHandlerType,level_dof_access>::set_mg_dof_indices
 (const int                                   level,
@@ -2218,7 +2218,7 @@ namespace internal
     }
 
 
-    template<bool level_dof_access>
+    template <bool level_dof_access>
     inline
     typename dealii::internal::DoFHandler::Iterators<dealii::DoFHandler<2,2>, level_dof_access>::quad_iterator
     get_quad(const dealii::Triangulation<2,2> *,
@@ -2229,7 +2229,7 @@ namespace internal
       return typename dealii::internal::DoFHandler::Iterators<dealii::DoFHandler<2,2>, level_dof_access>::line_iterator();
     }
 
-    template<bool level_dof_access>
+    template <bool level_dof_access>
     inline
     typename dealii::internal::DoFHandler::Iterators<dealii::DoFHandler<2,3>, level_dof_access>::quad_iterator
     get_quad(const dealii::Triangulation<2,3> *,
@@ -2240,7 +2240,7 @@ namespace internal
       return typename dealii::internal::DoFHandler::Iterators<dealii::DoFHandler<2,3>, level_dof_access>::line_iterator();
     }
 
-    template<bool level_dof_access>
+    template <bool level_dof_access>
     inline
     typename dealii::internal::DoFHandler::Iterators<dealii::hp::DoFHandler<2,2>, level_dof_access>::quad_iterator
     get_quad(const dealii::Triangulation<2,2> *,
@@ -2251,7 +2251,7 @@ namespace internal
       return typename dealii::internal::DoFHandler::Iterators<dealii::hp::DoFHandler<2,2>, level_dof_access>::line_iterator();
     }
 
-    template<bool level_dof_access>
+    template <bool level_dof_access>
     inline
     typename dealii::internal::DoFHandler::Iterators<dealii::hp::DoFHandler<2,3>, level_dof_access>::quad_iterator
     get_quad(const dealii::Triangulation<2,3> *,
@@ -3585,7 +3585,7 @@ DoFCellAccessor<DoFHandlerType,level_dof_access>::get_dof_indices
 
 
 
-template<typename DoFHandlerType, bool level_dof_access>
+template <typename DoFHandlerType, bool level_dof_access>
 inline
 void DoFCellAccessor<DoFHandlerType,level_dof_access>::get_mg_dof_indices
 (std::vector<types::global_dof_index> &dof_indices) const
@@ -3595,7 +3595,7 @@ void DoFCellAccessor<DoFHandlerType,level_dof_access>::get_mg_dof_indices
 
 
 
-template<typename DoFHandlerType, bool level_dof_access>
+template <typename DoFHandlerType, bool level_dof_access>
 inline
 void DoFCellAccessor<DoFHandlerType,level_dof_access>::set_mg_dof_indices
 (const std::vector<types::global_dof_index> &dof_indices)
@@ -3605,7 +3605,7 @@ void DoFCellAccessor<DoFHandlerType,level_dof_access>::set_mg_dof_indices
 
 
 
-template<typename DoFHandlerType, bool level_dof_access>
+template <typename DoFHandlerType, bool level_dof_access>
 inline
 void DoFCellAccessor<DoFHandlerType,level_dof_access>::get_active_or_mg_dof_indices
 (std::vector<types::global_dof_index> &dof_indices) const
index f4ea6b48f3191be58dab3b1f6a1dcda8b20e6319..338fc51f59d45bb502015e94687e7980323333e0 100644 (file)
@@ -64,7 +64,7 @@ namespace internal
      *
      * @author Tobias Leicht, 2006
      */
-    template<int dim>
+    template <int dim>
     class DoFFaces
     {
       /**
@@ -81,7 +81,7 @@ namespace internal
      *
      * @author Tobias Leicht, 2006
      */
-    template<>
+    template <>
     class DoFFaces<1>
     {
     public:
@@ -106,7 +106,7 @@ namespace internal
      *
      * @author Tobias Leicht, 2006
      */
-    template<>
+    template <>
     class DoFFaces<2>
     {
     public:
@@ -136,7 +136,7 @@ namespace internal
      *
      * @author Tobias Leicht, 2006
      */
-    template<>
+    template <>
     class DoFFaces<3>
     {
     public:
index c238e6f144ed512e3c0aef5c04a9f2c4a13128d6..fbb876662d0b5b7619feeaaed061de0c89d0e7cb 100644 (file)
@@ -736,7 +736,7 @@ public:
    *
    * The type of boundary_ids equals typename FunctionMap<spacedim,number>::type .
    */
-  template<typename number>
+  template <typename number>
   types::global_dof_index
   n_boundary_dofs (const std::map<types::boundary_id, const Function<spacedim,number>*> &boundary_ids) const;
 
@@ -1161,7 +1161,7 @@ DoFHandler<dim,spacedim>::n_dofs () const
 
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 inline
 types::global_dof_index DoFHandler<dim, spacedim>::n_dofs (const unsigned int level) const
 {
@@ -1289,7 +1289,7 @@ namespace internal
    *
    * Defined in dof_handler.cc.
    */
-  template<int dim, int spacedim>
+  template <int dim, int spacedim>
   std::string policy_to_string(const dealii::internal::DoFHandler::Policy::PolicyBase<dim,spacedim> &policy);
 }
 
@@ -1375,7 +1375,7 @@ DoFHandler<dim, spacedim>::MGVertexDoFs::get_index (const unsigned int level,
 
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 inline
 void
 DoFHandler<dim, spacedim>::MGVertexDoFs::set_index (const unsigned int level,
index e098966ce49b834c281aee97eafac8459c1319e8..184b825fe2e9240123e05adfd998b537864c0fb2 100644 (file)
@@ -665,7 +665,7 @@ namespace DoFTools
    *
    * @ingroup constraints
    */
-  template<typename DoFHandlerType, typename SparsityPatternType>
+  template <typename DoFHandlerType, typename SparsityPatternType>
   void
   make_flux_sparsity_pattern (const DoFHandlerType &dof_handler,
                               SparsityPatternType  &sparsity_pattern);
@@ -678,7 +678,7 @@ namespace DoFTools
    *
    * @ingroup constraints
    */
-  template<typename DoFHandlerType, typename SparsityPatternType>
+  template <typename DoFHandlerType, typename SparsityPatternType>
   void
   make_flux_sparsity_pattern (const DoFHandlerType      &dof_handler,
                               SparsityPatternType       &sparsity_pattern,
@@ -1081,7 +1081,7 @@ namespace DoFTools
    *
    * @author Matthias Maier, 2012 - 2015
    */
-  template<typename FaceIterator>
+  template <typename FaceIterator>
   void
   make_periodicity_constraints
   (const FaceIterator                          &face_1,
@@ -1117,7 +1117,7 @@ namespace DoFTools
    *
    * @author Daniel Arndt, Matthias Maier, 2013 - 2015
    */
-  template<typename DoFHandlerType>
+  template <typename DoFHandlerType>
   void
   make_periodicity_constraints
   (const std::vector<GridTools::PeriodicFacePair<typename DoFHandlerType::cell_iterator> >
@@ -1158,7 +1158,7 @@ namespace DoFTools
    *
    * @author Matthias Maier, 2012
    */
-  template<typename DoFHandlerType>
+  template <typename DoFHandlerType>
   void
   make_periodicity_constraints
   (const DoFHandlerType     &dof_handler,
@@ -1194,7 +1194,7 @@ namespace DoFTools
    * @ref GlossPeriodicConstraints "Glossary entry on periodic boundary conditions"
    * for further information.
    */
-  template<typename DoFHandlerType>
+  template <typename DoFHandlerType>
   void
   make_periodicity_constraints
   (const DoFHandlerType     &dof_handler,
index 5e8f2405fb6d3b83e0d9d97661f49e719c932d88..961116babb6b22df96673d77a79532e8aed4daef 100644 (file)
@@ -70,7 +70,7 @@ template <int spacedim, typename Number> class Function;
  * @ingroup functions
  * @author Wolfgang Bangerth, Ralf Hartmann, 2001
  */
-template<int dim,typename Number=double>
+template <int dim,typename Number=double>
 struct FunctionMap
 {
   /**
index 37b9ffed1fd999e2b51b6f8109cc7429166db169..e111d4831b753224739dd60dbe84bbd3246c5836 100644 (file)
@@ -143,7 +143,7 @@ namespace FETools
    * While the first vector is checked to have the correct size, the second
    * one is reinitialized for convenience.
    */
-  template<int dim, int spacedim>
+  template <int dim, int spacedim>
   void compute_component_wise(
     const FiniteElement<dim,spacedim>                &fe,
     std::vector<unsigned int>               &renumbering,
@@ -164,7 +164,7 @@ namespace FETools
    * indicates the index which this degree of freedom receives in a numbering
    * scheme, where the first block is numbered completely before the second.
    */
-  template<int dim, int spacedim>
+  template <int dim, int spacedim>
   void compute_block_renumbering (
     const FiniteElement<dim,spacedim>  &fe,
     std::vector<types::global_dof_index> &renumbering,
index 8c6512ca31bac0586f943fff8c1fab0c238e67bf..82c95674a3bc53f35e4d25d00d3efc11c7a74723 100644 (file)
@@ -38,7 +38,7 @@ DEAL_II_NAMESPACE_OPEN
  *
  * @author Wolfgang Bangerth, 2001, 2015
  */
-template<int dim, int spacedim=dim>
+template <int dim, int spacedim=dim>
 class MappingC1 : public MappingQ<dim,spacedim>
 {
 public:
index b75923ef36368eca93ace46cc421dd07951f307a..9fd359330c1a98e13c006c6d8686b72bd8b9ef58 100644 (file)
@@ -395,7 +395,7 @@ public:
 
 #ifndef DOXYGEN
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 inline
 void
 MappingManifold<dim,spacedim>::InternalData::store_vertices (const typename Triangulation<dim,spacedim>::cell_iterator &cell) const
index 99e101e8d788a327b0aba19ec690b166de27fd27..a98193885e4480732fd07bdbf24300e82cc60b95 100644 (file)
@@ -700,7 +700,7 @@ protected:
 
 #ifndef DOXYGEN
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 inline
 const double &
 MappingQGeneric<dim,spacedim>::InternalData::shape (const unsigned int qpoint,
@@ -714,7 +714,7 @@ MappingQGeneric<dim,spacedim>::InternalData::shape (const unsigned int qpoint,
 
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 inline
 double &
 MappingQGeneric<dim,spacedim>::InternalData::shape (const unsigned int qpoint,
@@ -727,7 +727,7 @@ MappingQGeneric<dim,spacedim>::InternalData::shape (const unsigned int qpoint,
 }
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 inline
 const Tensor<1,dim> &
 MappingQGeneric<dim,spacedim>::InternalData::derivative (const unsigned int qpoint,
@@ -741,7 +741,7 @@ MappingQGeneric<dim,spacedim>::InternalData::derivative (const unsigned int qpoi
 
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 inline
 Tensor<1,dim> &
 MappingQGeneric<dim,spacedim>::InternalData::derivative (const unsigned int qpoint,
index 2f18a8e86d443748060063e8d24d0efea623da7d..2016476ce1c9d79ec85d86df53e72e7aafb093e7 100644 (file)
@@ -113,13 +113,13 @@ public:
   /**
    * Return a compact and fast binary representation of this CellId.
    */
-  template<int dim>
+  template <int dim>
   binary_type to_binary() const;
 
   /**
    * Return a cell_iterator to the cell represented by this CellId.
    */
-  template<int dim, int spacedim>
+  template <int dim, int spacedim>
   typename Triangulation<dim,spacedim>::cell_iterator
   to_cell(const Triangulation<dim,spacedim> &tria) const;
 
index d2fa439c4a8d1c3a66a930385f8b0a3db1479a0e..a38169d27173e27c1a3952782cf091ea13156eef 100644 (file)
@@ -884,7 +884,7 @@ namespace GridGenerator
    * and 6 in 3d). If @p colorize is set to false, then flat faces get the
    * number 0 and the hole gets number 1.
    */
-  template<int dim>
+  template <int dim>
   void hyper_cube_with_cylindrical_hole (
     Triangulation<dim> &triangulation,
     const double        inner_radius = .25,
index aa09acb32074b94b21e4b3903be0894ec242beb3..3d4ee4e9f73ee18fe3ca739b2c8c6a19619296c9 100644 (file)
@@ -672,17 +672,17 @@ public:
 
 
 // declaration of explicit specializations
-template<>
+template <>
 void
 GridReordering<2>::invert_all_cells_of_negative_grid(const std::vector<Point<2> > &all_vertices,
                                                      std::vector<CellData<2> >    &cells);
 
-template<>
+template <>
 void
 GridReordering<2,3>::invert_all_cells_of_negative_grid(const std::vector<Point<3> > &all_vertices,
                                                        std::vector<CellData<2> >    &cells);
 
-template<>
+template <>
 void
 GridReordering<3>::invert_all_cells_of_negative_grid(const std::vector<Point<3> > &all_vertices,
                                                      std::vector<CellData<3> >    &cells);
index 37198c9744287e2af9fd16a74d8ea9218d8d53e3..1a2532d306da476aa6ea7a15a0af04abf0f1ead6 100644 (file)
@@ -50,14 +50,14 @@ class SparsityPattern;
 
 namespace internal
 {
-  template<int dim, int spacedim, class MeshType>
+  template <int dim, int spacedim, class MeshType>
   class ActiveCellIterator
   {
   public:
     typedef typename MeshType::active_cell_iterator type;
   };
 
-  template<int dim, int spacedim>
+  template <int dim, int spacedim>
   class ActiveCellIterator<dim, spacedim, dealii::DoFHandler<dim, spacedim> >
   {
   public:
@@ -68,7 +68,7 @@ namespace internal
 #endif
   };
 
-  template<int dim, int spacedim>
+  template <int dim, int spacedim>
   class ActiveCellIterator<dim, spacedim, dealii::hp::DoFHandler<dim, spacedim> >
   {
   public:
@@ -284,7 +284,7 @@ namespace GridTools
    *
    * @note Implemented for dim=1, 2, and 3.
    */
-  template<int dim>
+  template <int dim>
   void
   rotate (const double          angle,
           const unsigned int    axis,
@@ -424,7 +424,7 @@ namespace GridTools
    *
    * @author Mauro Bardelloni, Luca Heltai, Andrea Mola, 2016
    */
-  template<int dim, int spacedim>
+  template <int dim, int spacedim>
   void
   remove_hanging_nodes( Triangulation<dim,spacedim> &tria,
                         const bool isotropic = false,
@@ -455,7 +455,7 @@ namespace GridTools
    *
    * @author Mauro Bardelloni, Luca Heltai, Andrea Mola, 2016
    */
-  template<int dim, int spacedim>
+  template <int dim, int spacedim>
   void
   remove_anisotropy(  Triangulation<dim,spacedim> &tria,
                       const double max_ratio = 1.6180339887,
@@ -610,7 +610,7 @@ namespace GridTools
    * right thing with anisotropically refined meshes. It needs to be checked
    * for this case.
    */
-  template<int dim, template <int, int> class MeshType, int spacedim>
+  template <int dim, template <int, int> class MeshType, int spacedim>
 #ifndef _MSC_VER
   std::vector<typename MeshType<dim, spacedim>::active_cell_iterator>
 #else
@@ -736,7 +736,7 @@ namespace GridTools
    * evaluating the solution) may not be possible and you will have to decide
    * what to do in that case.
    */
-  template <int dim, template<int, int> class MeshType, int spacedim>
+  template <int dim, template <int, int> class MeshType, int spacedim>
 #ifndef _MSC_VER
   std::pair<typename MeshType<dim, spacedim>::active_cell_iterator, Point<dim> >
 #else
@@ -824,7 +824,7 @@ namespace GridTools
    * An example of a custom predicate is one that checks for a given material
    * id
    * @code
-   * template<int dim>
+   * template <int dim>
    * bool
    * pred_mat_id(const typename Triangulation<dim>::active_cell_iterator & cell)
    * {
@@ -1004,7 +1004,7 @@ namespace GridTools
    * For a description of how predicate works,
    * see compute_active_cell_halo_layer()
    */
-  template<class MeshType>
+  template <class MeshType>
   std::pair< Point<MeshType::space_dimension>, Point<MeshType::space_dimension> >
   compute_bounding_box
   ( const MeshType                                                                    &mesh,
@@ -1052,7 +1052,7 @@ namespace GridTools
    *
    * @author Mauro Bardelloni, Luca Heltai, Andrea Mola, 2016
    */
-  template<int dim, int spacedim>
+  template <int dim, int spacedim>
   std::pair<unsigned int, double>
   get_longest_direction(typename Triangulation<dim, spacedim>::active_cell_iterator cell);
 
@@ -1565,7 +1565,7 @@ namespace GridTools
    * constraints and a periodic p4est forest with respect to two 'periodic'
    * cell faces.
    */
-  template<typename CellIterator>
+  template <typename CellIterator>
   struct PeriodicFacePair
   {
     /**
@@ -1667,7 +1667,7 @@ namespace GridTools
    *
    * @author Matthias Maier, 2012
    */
-  template<typename FaceIterator>
+  template <typename FaceIterator>
   bool
   orthogonal_equality (std::bitset<3>     &orientation,
                        const FaceIterator &face1,
@@ -1681,7 +1681,7 @@ namespace GridTools
   /**
    * Same function as above, but doesn't return the actual orientation
    */
-  template<typename FaceIterator>
+  template <typename FaceIterator>
   bool
   orthogonal_equality (const FaceIterator &face1,
                        const FaceIterator &face2,
index ffcf1317da483de812fc2624eed39e0743d8a6aa..80d8cbf20ec743701b3b6ade16575b455b3f19bd 100644 (file)
@@ -51,7 +51,7 @@ template <int dim, int spacedim> class Manifold;
 
 namespace GridTools
 {
-  template<typename CellIterator>  struct PeriodicFacePair;
+  template <typename CellIterator>  struct PeriodicFacePair;
 }
 
 template <int, int, int> class TriaAccessor;
@@ -2042,12 +2042,12 @@ public:
    * functions below. It takes an iterator range and returns the sum of
    * values.
    */
-  template<typename T>
+  template <typename T>
   struct CellWeightSum
   {
     typedef T result_type;
 
-    template<typename InputIterator>
+    template <typename InputIterator>
     T operator()(InputIterator first, InputIterator last) const
     {
       return std::accumulate (first, last, T());
index f4ae231bed8a679da52805fbcd5bf6851d82df58..0138bbb35d9cc45050357ddf9134e3e0413922a7 100644 (file)
@@ -1553,7 +1553,7 @@ private:
  * @ingroup Accessors
  * @author Bruno Turcksin, 2015
  */
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 class TriaAccessor<0, dim, spacedim>
 {
 public:
@@ -3207,7 +3207,7 @@ protected:
    * partial templates. we use this auxiliary function that is then called
    * from point_inside.
    */
-  template<int dim_,int spacedim_ >
+  template <int dim_,int spacedim_ >
   bool point_inside_codim(const Point<spacedim_> &p) const;
 
 
index e199d56e7d1cdf82f5f939d83cf18a8fd55e8a43..d0fae38ae8001125ea40566602038c08c09c8c76 100644 (file)
@@ -45,7 +45,7 @@ namespace internal
      * @author Tobias Leicht, 2006
      */
 
-    template<int dim>
+    template <int dim>
     class TriaFaces
     {
     private:
@@ -64,7 +64,7 @@ namespace internal
      * <tt>dim@>=2</tt> the use of TriaFaces is reasonable, for <tt>dim=1</tt>
      * the class is empty.
      */
-    template<>
+    template <>
     class TriaFaces<1>
     {
 
@@ -87,7 +87,7 @@ namespace internal
     /**
      * In <tt>dim=2</tt> the cells are quads, the faces accordingly are lines.
      */
-    template<>
+    template <>
     class TriaFaces<2>
     {
     public:
@@ -116,7 +116,7 @@ namespace internal
      * In <tt>dim=3</tt> the cells are hexes, the faces accordingly are quads.
      * In addition to that we also have to enable the storage of lines.
      */
-    template<>
+    template <>
     class TriaFaces<3>
     {
     public:
index 79d7ec592d443ad90e5fed428dfbfa1692cb0f16..9cc6633ae70c694cb7dd3e3b489760f3d3b1f141 100644 (file)
@@ -212,7 +212,7 @@ namespace internal
      * instead of TriaObjects. Refer to the documentation of the general class
      * template for details.
      */
-    template<>
+    template <>
     class TriaLevel<3>
     {
     public:
index 77de4e7f59e55879015bd03c2af9d00ed0d7e0f9..4ef29caa4efadc7550f4cf91efb88897a82e307a 100644 (file)
@@ -601,7 +601,7 @@ namespace internal
     }
 
 
-    template<typename G>
+    template <typename G>
     inline
     bool
     TriaObjects<G>::
@@ -611,7 +611,7 @@ namespace internal
     }
 
 
-    template<typename G>
+    template <typename G>
     inline
     void *&
     TriaObjects<G>::user_pointer (const unsigned int i)
@@ -625,7 +625,7 @@ namespace internal
     }
 
 
-    template<typename G>
+    template <typename G>
     inline
     const void *
     TriaObjects<G>::user_pointer (const unsigned int i) const
@@ -639,7 +639,7 @@ namespace internal
     }
 
 
-    template<typename G>
+    template <typename G>
     inline
     unsigned int &
     TriaObjects<G>::user_index (const unsigned int i)
@@ -653,7 +653,7 @@ namespace internal
     }
 
 
-    template<typename G>
+    template <typename G>
     inline
     void
     TriaObjects<G>::clear_user_data (const unsigned int i)
@@ -674,7 +674,7 @@ namespace internal
     {}
 
 
-    template<typename G>
+    template <typename G>
     inline
     unsigned int TriaObjects<G>::user_index (const unsigned int i) const
     {
@@ -687,7 +687,7 @@ namespace internal
     }
 
 
-    template<typename G>
+    template <typename G>
     inline
     void TriaObjects<G>::clear_user_data ()
     {
@@ -697,7 +697,7 @@ namespace internal
     }
 
 
-    template<typename G>
+    template <typename G>
     inline
     void TriaObjects<G>::clear_user_flags ()
     {
@@ -705,7 +705,7 @@ namespace internal
     }
 
 
-    template<typename G>
+    template <typename G>
     template <class Archive>
     void
     TriaObjects<G>::UserData::serialize (Archive &ar,
@@ -862,7 +862,7 @@ namespace internal
 
 // declaration of explicit specializations
 
-    template<>
+    template <>
     void
     TriaObjects<TriaObject<2> >::monitor_memory (const unsigned int) const;
 
index 93c179c0c0ac3a43475a1fe9f90099f729825ddf..d7bd3db04fb1fe565b06bbeec9bae7aa2b887a94 100644 (file)
@@ -237,7 +237,7 @@ namespace internal
      * @ingroup dofs
      * @author Tobias Leicht, 2006
      */
-    template<int dim>
+    template <int dim>
     class DoFIndicesOnFaces;
 
 
@@ -248,7 +248,7 @@ namespace internal
      * @ingroup hp
      * @author Tobias Leicht, 2006
      */
-    template<>
+    template <>
     class DoFIndicesOnFaces<1>
     {
     public:
@@ -274,7 +274,7 @@ namespace internal
      * @ingroup hp
      * @author Tobias Leicht, 2006
      */
-    template<>
+    template <>
     class DoFIndicesOnFaces<2>
     {
     public:
@@ -305,7 +305,7 @@ namespace internal
      * @ingroup hp
      * @author Tobias Leicht, 2006
      */
-    template<>
+    template <>
     class DoFIndicesOnFaces<3>
     {
     public:
index a8f0b05c1ecb2c2d4808d4742e0b918922fe5dc9..0a5b3bb5d0b0cd0680fe8473397bb73682e3adb3 100644 (file)
@@ -1032,7 +1032,7 @@ namespace hp
 
 
 
-  template<int dim, int spacedim>
+  template <int dim, int spacedim>
   inline
   const hp::FECollection<dim,spacedim> &
   DoFHandler<dim,spacedim>::get_fe () const
@@ -1045,7 +1045,7 @@ namespace hp
 
 
 
-  template<int dim, int spacedim>
+  template <int dim, int spacedim>
   inline
   const Triangulation<dim,spacedim> &
   DoFHandler<dim,spacedim>::get_triangulation () const
index 2ae978694764cf3eeff203284e34e110f3884908..881a2c1e9f401740d19122a438f5927228345d23 100644 (file)
@@ -50,7 +50,7 @@ namespace hp
    *
    * @author Oliver Kayser-Herold, 2005
    */
-  template<int dim, int spacedim=dim>
+  template <int dim, int spacedim=dim>
   class MappingCollection : public Subscriptor
   {
   public:
@@ -133,7 +133,7 @@ namespace hp
    * collection can then be used in all of those places where such a
    * collection is needed.
    */
-  template<int dim, int spacedim=dim>
+  template <int dim, int spacedim=dim>
   struct StaticMappingQ1
   {
   public:
@@ -146,7 +146,7 @@ namespace hp
 
   /* --------------- inline functions ------------------- */
 
-  template<int dim, int spacedim>
+  template <int dim, int spacedim>
   inline
   unsigned int
   MappingCollection<dim,spacedim>::size () const
@@ -156,7 +156,7 @@ namespace hp
 
 
 
-  template<int dim, int spacedim>
+  template <int dim, int spacedim>
   inline
   const Mapping<dim,spacedim> &
   MappingCollection<dim,spacedim>::operator[] (const unsigned int index) const
index e77d09f3b00f5b8ca4c94ae2383649094f1b45f6..fd07054459a79258d7befaece81514b355915ed0 100644 (file)
@@ -71,7 +71,7 @@ namespace LocalIntegrators
      * @author Guido Kanschat
      * @date 2012
      */
-    template<int dim>
+    template <int dim>
     void cell_matrix (
       FullMatrix<double> &M,
       const FEValuesBase<dim> &fe,
index 791b671973afa13b28a5afec132cf2554cfad941..7b1ad870beb0acdebce40b792e031a97fe082533 100644 (file)
@@ -266,7 +266,7 @@ namespace LocalIntegrators
      * @author Guido Kanschat
      * @date 2011
      */
-    template<int dim>
+    template <int dim>
     void
     u_dot_n_matrix (
       FullMatrix<double> &M,
@@ -303,7 +303,7 @@ namespace LocalIntegrators
      * @author Guido Kanschat
      * @date 2011
      */
-    template<int dim, typename number>
+    template <int dim, typename number>
     void
     u_dot_n_residual (
       Vector<number> &result,
@@ -339,7 +339,7 @@ namespace LocalIntegrators
      * @author Guido Kanschat
      * @date 2013
      */
-    template<int dim, typename number>
+    template <int dim, typename number>
     void
     u_times_n_residual (
       Vector<number> &result,
@@ -374,7 +374,7 @@ namespace LocalIntegrators
      * @author Guido Kanschat
      * @date 2011
      */
-    template<int dim>
+    template <int dim>
     void
     u_dot_n_matrix (
       FullMatrix<double> &M11,
@@ -473,7 +473,7 @@ namespace LocalIntegrators
      * @author Guido Kanschat
      * @date 2011
      */
-    template<int dim>
+    template <int dim>
     void
     u_dot_n_jump_matrix (
       FullMatrix<double> &M11,
index f4a0d378fe5e167f94077d7bdd2867709055eeee..e7957e924af634f50f824ed798f9935776f7c6e4 100644 (file)
@@ -471,7 +471,7 @@ namespace LocalIntegrators
      * @author Guido Kanschat
      * @date 2013
      */
-    template<int dim, typename number>
+    template <int dim, typename number>
     void
     ip_residual(
       Vector<number> &result1,
index 58b8868fe890472ad51d50aba06f25fa417e957a..ba429829969968a8e5f0c9a8a8401ea2ab6cdd66 100644 (file)
@@ -290,7 +290,7 @@ namespace LocalIntegrators
      * @author Guido Kanschat
      * @date 2016
      */
-    template<int dim>
+    template <int dim>
     void
     ip_residual(
       Vector<double> &result1,
index 8c9494689fce06fc1b70214f0dab39d32769573b..e1cfefd6a2d16d5b23adc60568976d267cb79662 100644 (file)
@@ -48,7 +48,7 @@ namespace LocalIntegrators
      * @author Guido Kanschat
      * @date 2008, 2009, 2010
      */
-    template<int dim>
+    template <int dim>
     void cell_matrix (
       FullMatrix<double> &M,
       const FEValuesBase<dim> &fe,
@@ -527,7 +527,7 @@ namespace LocalIntegrators
      * @author Guido Kanschat
      * @date 2012
      */
-    template<int dim>
+    template <int dim>
     void
     ip_residual(
       Vector<double> &result1,
@@ -594,7 +594,7 @@ namespace LocalIntegrators
      * @author Guido Kanschat
      * @date 2012
      */
-    template<int dim>
+    template <int dim>
     void
     ip_residual(
       Vector<double> &result1,
index e62a3a42171d4b3cd4e6cb7dbbda017da75fe559..ec9f83c987864ce0ca955f2b0840e2f285026fc3 100644 (file)
@@ -30,7 +30,7 @@ namespace internal
 {
   namespace BlockLinearOperator
   {
-    template<typename PayloadBlockType = internal::LinearOperator::EmptyPayload>
+    template <typename PayloadBlockType = internal::LinearOperator::EmptyPayload>
     class EmptyBlockPayload;
   }
 }
@@ -184,7 +184,7 @@ public:
    * an object @p op for which the conversion function
    * <code>block_operator</code> is defined.
    */
-  template<typename Op>
+  template <typename Op>
   BlockLinearOperator(const Op &op)
   {
     *this = block_operator<Range, Domain, BlockPayload, Op>(op);
@@ -195,7 +195,7 @@ public:
    * LinearOperator. This constructor calls the corresponding block_operator()
    * specialization.
    */
-  template<size_t m, size_t n>
+  template <size_t m, size_t n>
   BlockLinearOperator(const std::array<std::array<BlockType, n>, m> &ops)
   {
     *this = block_operator<m, n, Range, Domain, BlockPayload>(ops);
@@ -206,7 +206,7 @@ public:
    * @p ops of LinearOperator. This constructor calls the corresponding
    * block_operator() specialization.
    */
-  template<size_t m>
+  template <size_t m>
   BlockLinearOperator(const std::array<BlockType, m> &ops)
   {
     *this = block_diagonal_operator<m, Range, Domain, BlockPayload>(ops);
@@ -386,7 +386,7 @@ namespace internal
      *
      * @ingroup LAOperators
      */
-    template<typename PayloadBlockType>
+    template <typename PayloadBlockType>
     class EmptyBlockPayload
     {
     public:
index 0e6da0137c4b3360482929ec6fc0be5bd851641d..b57c27a182738bfe5f648d12bf9f833ef4c381a9 100644 (file)
@@ -272,7 +272,7 @@ protected:
      * Constructor initializing all data fields. A PointerMatrix object is
      * generated for <tt>matrix</tt>.
      */
-    template<typename MatrixType>
+    template <typename MatrixType>
     Entry (const MatrixType &matrix,
            size_type row,
            size_type col,
index 8e4bf52fe3dd6057a81e1ef1e976e8b7a2e78efa..0daf94c35edc93d3d9e44312710adebee0f710ad 100644 (file)
@@ -48,7 +48,7 @@ template <typename Number> class BlockVector;
  * @ref GlossBlockLA "Block (linear algebra)"
  * @author Guido Kanschat, 2002, 2003
  */
-template<typename Number>
+template <typename Number>
 class BlockSparseMatrixEZ : public Subscriptor
 {
 public:
index 1e8b6c29d9e3355bc61b6c6993cde740192a846a..c071886c06dde81688ba8d1f3f6f255ec28cf3a1 100644 (file)
@@ -485,7 +485,7 @@ namespace internal
      * A helper class used internally in linear_operator.h. Specialization for
      * BlockVector<number>.
      */
-    template<typename number>
+    template <typename number>
     class ReinitHelper<BlockVector<number> >
     {
     public:
index 00ec01ebbb1e2952624bb8fd58e59aa3002c5cf8..12bbd24433546266ad31c909faf92046c04f75d9 100644 (file)
@@ -26,8 +26,8 @@
 
 DEAL_II_NAMESPACE_OPEN
 
-template<typename number> class Vector;
-template<typename number> class FullMatrix;
+template <typename number> class Vector;
+template <typename number> class FullMatrix;
 
 /*! @addtogroup Matrix1
  *@{
index a210200b7b73b3a22fbccd43ac579c07583c00d4..61ffd3bbf2e0e90e8e0dc59ce7fd29a58a7d719e 100644 (file)
@@ -371,7 +371,7 @@ namespace internal
 {
   namespace ChunkSparseMatrix
   {
-    template<typename T>
+    template <typename T>
     void zero_subrange (const unsigned int begin,
                         const unsigned int end,
                         T *dst)
index 2aa28b4f3b7c8fead6554b1d1153c76f2cab8d43..6c849277fe40bf46ea39824aba9829924b32098e 100644 (file)
@@ -33,7 +33,7 @@
 
 DEAL_II_NAMESPACE_OPEN
 
-template<int dim, class T> class Table;
+template <int dim, class T> class Table;
 template <typename> class FullMatrix;
 class SparsityPattern;
 class DynamicSparsityPattern;
@@ -595,7 +595,7 @@ public:
    * See the general documentation of this class for more detailed
    * information.
    */
-  template<typename number>
+  template <typename number>
   void condense (SparseMatrix<number> &matrix) const;
 
   /**
@@ -640,7 +640,7 @@ public:
    * See the general documentation of this class for more detailed
    * information.
    */
-  template<typename number, class VectorType>
+  template <typename number, class VectorType>
   void condense (SparseMatrix<number> &matrix,
                  VectorType           &vector) const;
 
index 6ae5b7f2563377debdee17c6528204710fb39d60..2f973b755d00340c08b4680c758bc46d3193ef64 100644 (file)
@@ -40,7 +40,7 @@
 DEAL_II_NAMESPACE_OPEN
 
 
-template<typename number>
+template <typename number>
 void
 ConstraintMatrix::condense (SparseMatrix<number> &uncondensed) const
 {
@@ -60,7 +60,7 @@ ConstraintMatrix::condense (BlockSparseMatrix<number> &uncondensed) const
 
 
 
-template<class VectorType>
+template <class VectorType>
 void
 ConstraintMatrix::condense (const VectorType &vec_ghosted,
                             VectorType       &vec) const
@@ -118,7 +118,7 @@ ConstraintMatrix::condense (VectorType &vec) const
 
 
 
-template<typename number, class VectorType>
+template <typename number, class VectorType>
 void
 ConstraintMatrix::condense (SparseMatrix<number> &uncondensed,
                             VectorType           &vec) const
@@ -513,7 +513,7 @@ namespace internal
     {
       typedef types::global_dof_index size_type;
 
-      template<class VEC>
+      template <class VEC>
       void set_zero_parallel(const std::vector<size_type> &cm, VEC &vec, size_type shift = 0)
       {
         Assert(!vec.has_ghost_elements(), ExcInternalError());
@@ -534,7 +534,7 @@ namespace internal
           }
       }
 
-      template<typename Number>
+      template <typename Number>
       void set_zero_parallel(const std::vector<size_type> &cm, LinearAlgebra::distributed::Vector<Number> &vec, size_type shift = 0)
       {
         for (typename std::vector<size_type>::const_iterator it = cm.begin();
@@ -554,14 +554,14 @@ namespace internal
         vec.zero_out_ghosts();
       }
 
-      template<class VEC>
+      template <class VEC>
       void set_zero_in_parallel(const std::vector<size_type> &cm, VEC &vec, internal::bool2type<false>)
       {
         set_zero_parallel(cm, vec, 0);
       }
 
       // in parallel for BlockVectors
-      template<class VEC>
+      template <class VEC>
       void set_zero_in_parallel(const std::vector<size_type> &cm, VEC &vec, internal::bool2type<true>)
       {
         size_type start_shift = 0;
@@ -572,7 +572,7 @@ namespace internal
           }
       }
 
-      template<class VEC>
+      template <class VEC>
       void set_zero_serial(const std::vector<size_type> &cm, VEC &vec)
       {
         for (typename std::vector<size_type>::const_iterator it = cm.begin();
@@ -580,7 +580,7 @@ namespace internal
           vec(*it) = 0.;
       }
 
-      template<class VEC>
+      template <class VEC>
       void set_zero_all(const std::vector<size_type> &cm, VEC &vec)
       {
         set_zero_in_parallel<VEC>(cm, vec, internal::bool2type<IsBlockVector<VEC>::value>());
@@ -588,13 +588,13 @@ namespace internal
       }
 
 
-      template<class T>
+      template <class T>
       void set_zero_all(const std::vector<size_type> &cm, dealii::Vector<T> &vec)
       {
         set_zero_serial(cm, vec);
       }
 
-      template<class T>
+      template <class T>
       void set_zero_all(const std::vector<size_type> &cm, dealii::BlockVector<T> &vec)
       {
         set_zero_serial(cm, vec);
@@ -1592,7 +1592,7 @@ namespace internals
   // resolves constraints of one column at the innermost loop. goes through
   // the origin of each global entry and finds out which data we need to
   // collect.
-  template<typename LocalType>
+  template <typename LocalType>
   static inline
   LocalType resolve_matrix_entry (const GlobalRowsFromLocal   &global_rows,
                                   const GlobalRowsFromLocal &global_cols,
@@ -2179,7 +2179,7 @@ make_sorted_row_list (const std::vector<size_type> &local_dof_indices,
 
 
 // Resolve the constraints from the vector and apply inhomogeneities.
-template< typename LocalType>
+template < typename LocalType>
 inline
 LocalType
 ConstraintMatrix::
index a6b28604c2c28fc68befcf5eb05d85630d9b616a..b3fb56988223ef80d6b477deb4c640dc19fa0430 100644 (file)
@@ -547,7 +547,7 @@ private:
 
 //--------------------------------Iterators--------------------------------------//
 
-template<typename VectorType>
+template <typename VectorType>
 inline
 FilteredMatrix<VectorType>::Accessor::Accessor
 (const FilteredMatrix<VectorType> *matrix,
@@ -562,7 +562,7 @@ FilteredMatrix<VectorType>::Accessor::Accessor
 
 
 
-template<typename VectorType>
+template <typename VectorType>
 inline
 types::global_dof_index
 FilteredMatrix<VectorType>::Accessor::row() const
@@ -572,7 +572,7 @@ FilteredMatrix<VectorType>::Accessor::row() const
 
 
 
-template<typename VectorType>
+template <typename VectorType>
 inline
 types::global_dof_index
 FilteredMatrix<VectorType>::Accessor::column() const
@@ -582,7 +582,7 @@ FilteredMatrix<VectorType>::Accessor::column() const
 
 
 
-template<typename VectorType>
+template <typename VectorType>
 inline
 double
 FilteredMatrix<VectorType>::Accessor::value() const
@@ -592,7 +592,7 @@ FilteredMatrix<VectorType>::Accessor::value() const
 
 
 
-template<typename VectorType>
+template <typename VectorType>
 inline
 void
 FilteredMatrix<VectorType>::Accessor::advance()
@@ -604,7 +604,7 @@ FilteredMatrix<VectorType>::Accessor::advance()
 
 
 
-template<typename VectorType>
+template <typename VectorType>
 inline
 FilteredMatrix<VectorType>::const_iterator::const_iterator
 (const FilteredMatrix<VectorType> *matrix,
@@ -615,7 +615,7 @@ FilteredMatrix<VectorType>::const_iterator::const_iterator
 
 
 
-template<typename VectorType>
+template <typename VectorType>
 inline
 typename FilteredMatrix<VectorType>::const_iterator &
 FilteredMatrix<VectorType>::const_iterator::operator++ ()
index 932c51db321e629ffdf71e181aef87556e00ecac..4cb65b815bf6bf4f5ed3bebac64edc5121be2b28 100644 (file)
@@ -28,7 +28,7 @@ DEAL_II_NAMESPACE_OPEN
 
 
 // forward declarations
-template<typename number> class Vector;
+template <typename number> class Vector;
 
 
 /*! @addtogroup Matrix2
@@ -52,7 +52,7 @@ template<typename number> class Vector;
  *
  * @author Guido Kanschat, 2005
  */
-template<typename number>
+template <typename number>
 class Householder : private FullMatrix<number>
 {
 public:
@@ -69,13 +69,13 @@ public:
   /**
    * Create an object holding the QR-decomposition of a matrix.
    */
-  template<typename number2>
+  template <typename number2>
   Householder (const FullMatrix<number2> &);
 
   /**
    * Compute the QR-decomposition of another matrix.
    */
-  template<typename number2>
+  template <typename number2>
   void
   initialize (const FullMatrix<number2> &);
 
@@ -89,14 +89,14 @@ public:
    * problem. It will be changed during the algorithm and is unusable on
    * return.
    */
-  template<typename number2>
+  template <typename number2>
   double least_squares (Vector<number2> &dst,
                         const Vector<number2> &src) const;
 
   /**
    * This function does the same as the one for BlockVectors.
    */
-  template<typename number2>
+  template <typename number2>
   double least_squares (BlockVector<number2> &dst,
                         const BlockVector<number2> &src) const;
 
@@ -104,10 +104,10 @@ public:
    * A wrapper to least_squares(), implementing the standard MatrixType
    * interface.
    */
-  template<class VectorType>
+  template <class VectorType>
   void vmult (VectorType &dst, const VectorType &src) const;
 
-  template<class VectorType>
+  template <class VectorType>
   void Tvmult (VectorType &dst, const VectorType &src) const;
 
 
index f1a015e0f4214a8bc79ddf46913925afc26bd0b9..f0963d8da2ea0b8cd1bbd12244de6eb8f61f8991 100644 (file)
 DEAL_II_NAMESPACE_OPEN
 
 // forward declarations
-template<typename number> class Vector;
-template<typename number> class BlockVector;
-template<typename number> class FullMatrix;
-template<typename number> class SparseMatrix;
+template <typename number> class Vector;
+template <typename number> class BlockVector;
+template <typename number> class FullMatrix;
+template <typename number> class SparseMatrix;
 
 
 /**
@@ -184,7 +184,7 @@ public:
    * The final two arguments allow to enter a multiple of the source or its
    * transpose.
    */
-  template<typename MatrixType>
+  template <typename MatrixType>
   void fill (const MatrixType &src,
              const size_type dst_offset_i = 0,
              const size_type dst_offset_j = 0,
index a3d8896e859ab1a9feee5c7fcf7c39cdaddd4489..f7d7ab064b5783c30c0d2bd77f9ec452bc4a6ff2 100644 (file)
@@ -252,7 +252,7 @@ DEAL_II_NAMESPACE_OPEN
 
 
 /// Template wrapper for LAPACK functions daxpy and saxpy
-template<typename number1, typename number2, typename number3>
+template <typename number1, typename number2, typename number3>
 inline void
 axpy (const int *, const number1 *, const number2 *, const int *, number3 *, const int *)
 {
@@ -290,7 +290,7 @@ axpy (const int *, const float *, const float *, const int *, float *, const int
 
 
 /// Template wrapper for LAPACK functions dgemv and sgemv
-template<typename number1, typename number2, typename number3, typename number4, typename number5>
+template <typename number1, typename number2, typename number3, typename number4, typename number5>
 inline void
 gemv (const char *, const int *, const int *, const number1 *, const number2 *, const int *, const number3 *, const int *, const number4 *, number5 *, const int *)
 {
@@ -328,7 +328,7 @@ gemv (const char *, const int *, const int *, const float *, const float *, cons
 
 
 /// Template wrapper for LAPACK functions dgemm and sgemm
-template<typename number1, typename number2, typename number3, typename number4, typename number5>
+template <typename number1, typename number2, typename number3, typename number4, typename number5>
 inline void
 gemm (const char *, const char *, const int *, const int *, const int *, const number1 *, const number2 *, const int *, const number3 *, const int *, const number4 *, number5 *, const int *)
 {
@@ -366,7 +366,7 @@ gemm (const char *, const char *, const int *, const int *, const int *, const f
 
 
 /// Template wrapper for LAPACK functions dgetrf and sgetrf
-template<typename number1>
+template <typename number1>
 inline void
 getrf (const int *, const int *, number1 *, const int *, int *, int *)
 {
@@ -404,7 +404,7 @@ getrf (const int *, const int *, float *, const int *, int *, int *)
 
 
 /// Template wrapper for LAPACK functions dgetrs and sgetrs
-template<typename number1, typename number2>
+template <typename number1, typename number2>
 inline void
 getrs (const char *, const int *, const int *, const number1 *, const int *, const int *, number2 *, const int *, int *)
 {
@@ -442,7 +442,7 @@ getrs (const char *, const int *, const int *, const float *, const int *, const
 
 
 /// Template wrapper for LAPACK functions dgetri and sgetri
-template<typename number1, typename number2>
+template <typename number1, typename number2>
 inline void
 getri (const int *, number1 *, const int *, int *, number2 *, const int *, int *)
 {
@@ -480,7 +480,7 @@ getri (const int *, float *, const int *, int *, float *, const int *, int *)
 
 
 /// Template wrapper for LAPACK functions dgeqrf and sgeqrf
-template<typename number1, typename number2, typename number3>
+template <typename number1, typename number2, typename number3>
 inline void
 geqrf (const int *, const int *, number1 *, const int *, number2 *, number3 *, const int *, int *)
 {
@@ -518,7 +518,7 @@ geqrf (const int *, const int *, float *, const int *, float *, float *, const i
 
 
 /// Template wrapper for LAPACK functions dormqr and sormqr
-template<typename number1, typename number2, typename number3, typename number4>
+template <typename number1, typename number2, typename number3, typename number4>
 inline void
 ormqr (const char *, const char *, const int *, const int *, const int *, const number1 *, const int *, const number2 *, number3 *, const int *, number4 *, const int *, int *)
 {
@@ -556,7 +556,7 @@ ormqr (const char *, const char *, const int *, const int *, const int *, const
 
 
 /// Template wrapper for LAPACK functions dorgqr and sorgqr
-template<typename number1, typename number2, typename number3>
+template <typename number1, typename number2, typename number3>
 inline void
 orgqr (const int *, const int *, const int *, const number1 *, const int *, const number2 *, number3 *, const int *, int *)
 {
@@ -594,7 +594,7 @@ orgqr (const int *, const int *, const int *, const float *, const int *, const
 
 
 /// Template wrapper for LAPACK functions dtrtrs and strtrs
-template<typename number1, typename number2>
+template <typename number1, typename number2>
 inline void
 trtrs (const char *, const char *, const char *, const int *, const int *, const number1 *, const int *, number2 *, const int *, int *)
 {
@@ -632,7 +632,7 @@ trtrs (const char *, const char *, const char *, const int *, const int *, const
 
 
 /// Template wrapper for LAPACK functions dgeev and sgeev
-template<typename number1, typename number2, typename number3, typename number4, typename number5, typename number6>
+template <typename number1, typename number2, typename number3, typename number4, typename number5, typename number6>
 inline void
 geev (const char *, const char *, const int *, number1 *, const int *, number2 *, number3 *, number4 *, const int *, number5 *, const int *, number6 *, const int *, int *)
 {
@@ -670,7 +670,7 @@ geev (const char *, const char *, const int *, float *, const int *, float *, fl
 
 
 /// Template wrapper for LAPACK functions dgeevx and sgeevx
-template<typename number1, typename number2, typename number3, typename number4, typename number5, typename number6, typename number7, typename number8, typename number9, typename number10>
+template <typename number1, typename number2, typename number3, typename number4, typename number5, typename number6, typename number7, typename number8, typename number9, typename number10>
 inline void
 geevx (const char *, const char *, const char *, const char *, const int *, number1 *, const int *, number2 *, number3 *, number4 *, const int *, number5 *, const int *, int *, int *, number6 *, number7 *, number8 *, number9 *, number10 *, const int *, int *, int *)
 {
@@ -708,7 +708,7 @@ geevx (const char *, const char *, const char *, const char *, const int *, floa
 
 
 /// Template wrapper for LAPACK functions dsyev and ssyev
-template<typename number1, typename number2, typename number3>
+template <typename number1, typename number2, typename number3>
 inline void
 syev (const char *, const char *, const int *, number1 *, const int *, number2 *, number3 *, const int *, int *)
 {
@@ -746,7 +746,7 @@ syev (const char *, const char *, const int *, float *, const int *, float *, fl
 
 
 /// Template wrapper for LAPACK functions dsyevx and ssyevx
-template<typename number1, typename number2, typename number3, typename number4, typename number5, typename number6, typename number7>
+template <typename number1, typename number2, typename number3, typename number4, typename number5, typename number6, typename number7>
 inline void
 syevx (const char *, const char *, const char *, const int *, number1 *, const int *, const number2 *, const number3 *, const int *, const int *, const number4 *, int *, number5 *, number6 *, const int *, number7 *, const int *, int *, int *, int *)
 {
@@ -784,7 +784,7 @@ syevx (const char *, const char *, const char *, const int *, float *, const int
 
 
 /// Template wrapper for LAPACK functions dsygv and ssygv
-template<typename number1, typename number2, typename number3, typename number4>
+template <typename number1, typename number2, typename number3, typename number4>
 inline void
 sygv (const int *, const char *, const char *, const int *, number1 *, const int *, number2 *, const int *, number3 *, number4 *, const int *, int *)
 {
@@ -822,7 +822,7 @@ sygv (const int *, const char *, const char *, const int *, float *, const int *
 
 
 /// Template wrapper for LAPACK functions dsygvx and ssygvx
-template<typename number1, typename number2, typename number3, typename number4, typename number5, typename number6, typename number7, typename number8>
+template <typename number1, typename number2, typename number3, typename number4, typename number5, typename number6, typename number7, typename number8>
 inline void
 sygvx (const int *, const char *, const char *, const char *, const int *, number1 *, const int *, number2 *, const int *, const number3 *, const number4 *, const int *, const int *, const number5 *, int *, number6 *, number7 *, const int *, number8 *, const int *, int *, int *, int *)
 {
@@ -860,7 +860,7 @@ sygvx (const int *, const char *, const char *, const char *, const int *, float
 
 
 /// Template wrapper for LAPACK functions dgesdd and sgesdd
-template<typename number1, typename number2, typename number3, typename number4, typename number5>
+template <typename number1, typename number2, typename number3, typename number4, typename number5>
 inline void
 gesdd (const char *, const int *, const int *, number1 *, const int *, number2 *, number3 *, const int *, number4 *, const int *, number5 *, const int *, int *, int *)
 {
@@ -898,7 +898,7 @@ gesdd (const char *, const int *, const int *, float *, const int *, float *, fl
 
 
 /// Template wrapper for LAPACK functions dgesvd and sgesvd
-template<typename number1, typename number2, typename number3, typename number4, typename number5>
+template <typename number1, typename number2, typename number3, typename number4, typename number5>
 inline void
 gesvd (int *, int *, const int *, const int *, number1 *, const int *, number2 *, number3 *, const int *, number4 *, const int *, number5 *, const int *, int *)
 {
@@ -936,7 +936,7 @@ gesvd (int *, int *, const int *, const int *, float *, const int *, float *, fl
 
 
 /// Template wrapper for LAPACK functions dgelsd and sgelsd
-template<typename number1, typename number2, typename number3, typename number4, typename number5>
+template <typename number1, typename number2, typename number3, typename number4, typename number5>
 inline void
 gelsd (const int *, const int *, const int *, const number1 *, const int *, number2 *, const int *, number3 *, const number4 *, int *, number5 *, const int *, int *, int *)
 {
@@ -974,7 +974,7 @@ gelsd (const int *, const int *, const int *, const float *, const int *, float
 
 
 /// Template wrapper for LAPACK functions dstev and sstev
-template<typename number1, typename number2, typename number3, typename number4>
+template <typename number1, typename number2, typename number3, typename number4>
 inline void
 stev (const char *, const int *, number1 *, number2 *, number3 *, const int *, number4 *, int *)
 {
index 108d1f32b48ac6440e50bfaa6edf4c18eacff37b..22d37c2fbc9e0ac9470d4d1af05bac894cb51b20 100644 (file)
@@ -213,8 +213,8 @@ public:
    * object @p op for which the conversion function
    * <code>linear_operator</code> is defined.
    */
-  template<typename Op,
-           typename = typename std::enable_if<!std::is_base_of<LinearOperator<Range, Domain, Payload>, Op>::value>::type>
+  template <typename Op,
+            typename = typename std::enable_if<!std::is_base_of<LinearOperator<Range, Domain, Payload>, Op>::value>::type>
   LinearOperator (const Op &op)
   {
     *this = linear_operator<Range, Domain, Payload, Op>(op);
@@ -872,7 +872,7 @@ namespace internal
      * This class is specialized for more complicated data structures, such as
      * TrilinosWrappers::MPI::Vector, etc.
      */
-    template<typename Vector>
+    template <typename Vector>
     class ReinitHelper
     {
     public:
index a03f43709995bc7dbff155c888b71d47201ca68c..8142db84edc273ac7625ccfc29fc68971b6572c5 100644 (file)
@@ -236,7 +236,7 @@ public:
    * MatrixType. No index computations are done, thus, the vectors need to
    * have sizes matching #matrix.
    */
-  template<class VectorType>
+  template <class VectorType>
   void vmult (VectorType &w, const VectorType &v) const;
 
   /**
@@ -244,7 +244,7 @@ public:
    * MatrixType. No index computations are done, thus, the vectors need to
    * have sizes matching #matrix.
    */
-  template<class VectorType>
+  template <class VectorType>
   void vmult_add (VectorType &w, const VectorType &v) const;
 
   /**
@@ -252,7 +252,7 @@ public:
    * MatrixType. No index computations are done, thus, the vectors need to
    * have sizes matching #matrix.
    */
-  template<class VectorType>
+  template <class VectorType>
   void Tvmult (VectorType &w, const VectorType &v) const;
 
   /**
@@ -260,7 +260,7 @@ public:
    * MatrixType. No index computations are done, thus, the vectors need to
    * have sizes matching #matrix.
    */
-  template<class VectorType>
+  template <class VectorType>
   void Tvmult_add (VectorType &w, const VectorType &v) const;
 
   /**
index 8fed803703dce79475468a8b604ed9aedca52276..6c30b82fb3ad375931b13c4cc8152e5b76e70cef 100644 (file)
@@ -23,9 +23,9 @@
 
 DEAL_II_NAMESPACE_OPEN
 
-template<typename number> class Vector;
-template<typename number> class BlockVector;
-template<typename number> class SparseMatrix;
+template <typename number> class Vector;
+template <typename number> class BlockVector;
+template <typename number> class SparseMatrix;
 
 /*! @addtogroup Matrix2
  *@{
index d15537d4e99d10dcbf4b5f7a5ccaca72a1d5eeb1..8cd8057e61905073d2e734fe6cb3f52f6accf83b 100644 (file)
@@ -523,7 +523,7 @@ namespace internal
      * A helper class used internally in linear_operator.h. Specialization for
      * PETScWrappers::MPI::BlockVector.
      */
-    template<>
+    template <>
     class ReinitHelper<PETScWrappers::MPI::BlockVector>
     {
     public:
index 07fb0857e8c85de36eb487c7c62b165166f8b482..4b311c78f6503bd75cc7d729d05ebd5ea9cf7cc2 100644 (file)
@@ -504,7 +504,7 @@ namespace internal
      * A helper class used internally in linear_operator.h. Specialization for
      * PETScWrappers::MPI::Vector.
      */
-    template<>
+    template <>
     class ReinitHelper<PETScWrappers::MPI::Vector>
     {
     public:
index dd6016681c7e6e9914ae98333c64d687213e6111..a9b0e45522e674b00db8b7459c9431e56148327c 100644 (file)
@@ -23,7 +23,7 @@
 
 DEAL_II_NAMESPACE_OPEN
 
-template<typename VectorType> class VectorMemory;
+template <typename VectorType> class VectorMemory;
 
 class IdentityMatrix;
 template <typename number> class FullMatrix;
@@ -47,7 +47,7 @@ template <typename number, typename BlockVectorType> class BlockMatrixArray;
  *
  * @author Guido Kanschat, 2000, 2001, 2002
  */
-template<typename VectorType>
+template <typename VectorType>
 class PointerMatrixBase : public Subscriptor
 {
 public:
@@ -109,7 +109,7 @@ public:
  *
  * @author Guido Kanschat 2000, 2001, 2002
  */
-template<typename MatrixType, typename VectorType>
+template <typename MatrixType, typename VectorType>
 class PointerMatrix : public PointerMatrixBase<VectorType>
 {
 public:
@@ -209,7 +209,7 @@ private:
  *
  * @author Guido Kanschat 2006
  */
-template<typename MatrixType, typename VectorType>
+template <typename MatrixType, typename VectorType>
 class PointerMatrixAux : public PointerMatrixBase<VectorType>
 {
 public:
@@ -573,7 +573,7 @@ new_pointer_matrix_base(const TridiagonalMatrix<numberm> &matrix, const Vector<n
 /*@}*/
 //---------------------------------------------------------------------------
 
-template<typename VectorType>
+template <typename VectorType>
 inline
 PointerMatrixBase<VectorType>::~PointerMatrixBase ()
 {}
@@ -583,26 +583,26 @@ PointerMatrixBase<VectorType>::~PointerMatrixBase ()
 //----------------------------------------------------------------------//
 
 
-template<typename MatrixType, typename VectorType>
+template <typename MatrixType, typename VectorType>
 PointerMatrix<MatrixType, VectorType>::PointerMatrix (const MatrixType *M)
   : m(M, typeid(*this).name())
 {}
 
 
-template<typename MatrixType, typename VectorType>
+template <typename MatrixType, typename VectorType>
 PointerMatrix<MatrixType, VectorType>::PointerMatrix (const char *name)
   : m(nullptr, name)
 {}
 
 
-template<typename MatrixType, typename VectorType>
+template <typename MatrixType, typename VectorType>
 PointerMatrix<MatrixType, VectorType>::PointerMatrix (const MatrixType *M,
                                                       const char       *name)
   : m(M, name)
 {}
 
 
-template<typename MatrixType, typename VectorType>
+template <typename MatrixType, typename VectorType>
 inline void
 PointerMatrix<MatrixType, VectorType>::clear ()
 {
@@ -610,7 +610,7 @@ PointerMatrix<MatrixType, VectorType>::clear ()
 }
 
 
-template<typename MatrixType, typename VectorType>
+template <typename MatrixType, typename VectorType>
 inline const PointerMatrix<MatrixType, VectorType> &
 PointerMatrix<MatrixType, VectorType>::operator= (const MatrixType *M)
 {
@@ -619,7 +619,7 @@ PointerMatrix<MatrixType, VectorType>::operator= (const MatrixType *M)
 }
 
 
-template<typename MatrixType, typename VectorType>
+template <typename MatrixType, typename VectorType>
 inline bool
 PointerMatrix<MatrixType, VectorType>::empty () const
 {
@@ -628,7 +628,7 @@ PointerMatrix<MatrixType, VectorType>::empty () const
   return m->empty();
 }
 
-template<typename MatrixType, typename VectorType>
+template <typename MatrixType, typename VectorType>
 inline void
 PointerMatrix<MatrixType, VectorType>::vmult (VectorType       &dst,
                                               const VectorType &src) const
@@ -638,7 +638,7 @@ PointerMatrix<MatrixType, VectorType>::vmult (VectorType       &dst,
 }
 
 
-template<typename MatrixType, typename VectorType>
+template <typename MatrixType, typename VectorType>
 inline void
 PointerMatrix<MatrixType, VectorType>::Tvmult (VectorType       &dst,
                                                const VectorType &src) const
@@ -648,7 +648,7 @@ PointerMatrix<MatrixType, VectorType>::Tvmult (VectorType       &dst,
 }
 
 
-template<typename MatrixType, typename VectorType>
+template <typename MatrixType, typename VectorType>
 inline void
 PointerMatrix<MatrixType, VectorType>::vmult_add (VectorType       &dst,
                                                   const VectorType &src) const
@@ -658,7 +658,7 @@ PointerMatrix<MatrixType, VectorType>::vmult_add (VectorType       &dst,
 }
 
 
-template<typename MatrixType, typename VectorType>
+template <typename MatrixType, typename VectorType>
 inline void
 PointerMatrix<MatrixType, VectorType>::Tvmult_add (VectorType       &dst,
                                                    const VectorType &src) const
@@ -672,7 +672,7 @@ PointerMatrix<MatrixType, VectorType>::Tvmult_add (VectorType       &dst,
 //----------------------------------------------------------------------//
 
 
-template<typename MatrixType, typename VectorType>
+template <typename MatrixType, typename VectorType>
 PointerMatrixAux<MatrixType, VectorType>::PointerMatrixAux (VectorMemory<VectorType> *mem,
                                                             const MatrixType *M)
   : mem(mem, typeid(*this).name()),
@@ -682,7 +682,7 @@ PointerMatrixAux<MatrixType, VectorType>::PointerMatrixAux (VectorMemory<VectorT
 }
 
 
-template<typename MatrixType, typename VectorType>
+template <typename MatrixType, typename VectorType>
 PointerMatrixAux<MatrixType, VectorType>::PointerMatrixAux (VectorMemory<VectorType> *mem,
                                                             const char               *name)
   : mem(mem, name),
@@ -692,7 +692,7 @@ PointerMatrixAux<MatrixType, VectorType>::PointerMatrixAux (VectorMemory<VectorT
 }
 
 
-template<typename MatrixType, typename VectorType>
+template <typename MatrixType, typename VectorType>
 PointerMatrixAux<MatrixType, VectorType>::PointerMatrixAux (VectorMemory<VectorType> *mem,
                                                             const MatrixType         *M,
                                                             const char               *name)
@@ -703,7 +703,7 @@ PointerMatrixAux<MatrixType, VectorType>::PointerMatrixAux (VectorMemory<VectorT
 }
 
 
-template<typename MatrixType, typename VectorType>
+template <typename MatrixType, typename VectorType>
 inline void
 PointerMatrixAux<MatrixType, VectorType>::clear ()
 {
@@ -711,7 +711,7 @@ PointerMatrixAux<MatrixType, VectorType>::clear ()
 }
 
 
-template<typename MatrixType, typename VectorType>
+template <typename MatrixType, typename VectorType>
 inline const PointerMatrixAux<MatrixType, VectorType> &
 PointerMatrixAux<MatrixType, VectorType>::operator= (const MatrixType *M)
 {
@@ -720,7 +720,7 @@ PointerMatrixAux<MatrixType, VectorType>::operator= (const MatrixType *M)
 }
 
 
-template<typename MatrixType, typename VectorType>
+template <typename MatrixType, typename VectorType>
 inline void
 PointerMatrixAux<MatrixType, VectorType>::set_memory(VectorMemory<VectorType> *M)
 {
@@ -730,7 +730,7 @@ PointerMatrixAux<MatrixType, VectorType>::set_memory(VectorMemory<VectorType> *M
 }
 
 
-template<typename MatrixType, typename VectorType>
+template <typename MatrixType, typename VectorType>
 inline bool
 PointerMatrixAux<MatrixType, VectorType>::empty () const
 {
@@ -739,7 +739,7 @@ PointerMatrixAux<MatrixType, VectorType>::empty () const
   return m->empty();
 }
 
-template<typename MatrixType, typename VectorType>
+template <typename MatrixType, typename VectorType>
 inline void
 PointerMatrixAux<MatrixType, VectorType>::vmult (VectorType       &dst,
                                                  const VectorType &src) const
@@ -752,7 +752,7 @@ PointerMatrixAux<MatrixType, VectorType>::vmult (VectorType       &dst,
 }
 
 
-template<typename MatrixType, typename VectorType>
+template <typename MatrixType, typename VectorType>
 inline void
 PointerMatrixAux<MatrixType, VectorType>::Tvmult (VectorType       &dst,
                                                   const VectorType &src) const
@@ -765,7 +765,7 @@ PointerMatrixAux<MatrixType, VectorType>::Tvmult (VectorType       &dst,
 }
 
 
-template<typename MatrixType, typename VectorType>
+template <typename MatrixType, typename VectorType>
 inline void
 PointerMatrixAux<MatrixType, VectorType>::vmult_add (VectorType       &dst,
                                                      const VectorType &src) const
@@ -782,7 +782,7 @@ PointerMatrixAux<MatrixType, VectorType>::vmult_add (VectorType       &dst,
 }
 
 
-template<typename MatrixType, typename VectorType>
+template <typename MatrixType, typename VectorType>
 inline void
 PointerMatrixAux<MatrixType, VectorType>::Tvmult_add (VectorType       &dst,
                                                       const VectorType &src) const
@@ -802,26 +802,26 @@ PointerMatrixAux<MatrixType, VectorType>::Tvmult_add (VectorType       &dst,
 //----------------------------------------------------------------------//
 
 
-template<typename number>
+template <typename number>
 PointerMatrixVector<number>::PointerMatrixVector (const Vector<number> *M)
   : m(M, typeid(*this).name())
 {}
 
 
-template<typename number>
+template <typename number>
 PointerMatrixVector<number>::PointerMatrixVector (const char *name)
   : m(0, name)
 {}
 
 
-template<typename number>
+template <typename number>
 PointerMatrixVector<number>::PointerMatrixVector (const Vector<number> *M,
                                                   const char           *name)
   : m(M, name)
 {}
 
 
-template<typename number>
+template <typename number>
 inline void
 PointerMatrixVector<number>::clear ()
 {
@@ -829,7 +829,7 @@ PointerMatrixVector<number>::clear ()
 }
 
 
-template<typename number>
+template <typename number>
 inline const PointerMatrixVector<number> &
 PointerMatrixVector<number>::operator= (const Vector<number> *M)
 {
@@ -838,7 +838,7 @@ PointerMatrixVector<number>::operator= (const Vector<number> *M)
 }
 
 
-template<typename number>
+template <typename number>
 inline bool
 PointerMatrixVector<number>::empty () const
 {
@@ -847,7 +847,7 @@ PointerMatrixVector<number>::empty () const
   return m->empty();
 }
 
-template<typename number>
+template <typename number>
 inline void
 PointerMatrixVector<number>::vmult (Vector<number>       &dst,
                                     const Vector<number> &src) const
@@ -859,7 +859,7 @@ PointerMatrixVector<number>::vmult (Vector<number>       &dst,
 }
 
 
-template<typename number>
+template <typename number>
 inline void
 PointerMatrixVector<number>::Tvmult (Vector<number>       &dst,
                                      const Vector<number> &src) const
@@ -871,7 +871,7 @@ PointerMatrixVector<number>::Tvmult (Vector<number>       &dst,
 }
 
 
-template<typename number>
+template <typename number>
 inline void
 PointerMatrixVector<number>::vmult_add (Vector<number>       &dst,
                                         const Vector<number> &src) const
@@ -883,7 +883,7 @@ PointerMatrixVector<number>::vmult_add (Vector<number>       &dst,
 }
 
 
-template<typename number>
+template <typename number>
 inline void
 PointerMatrixVector<number>::Tvmult_add (Vector<number>       &dst,
                                          const Vector<number> &src) const
index bed1220a3e908fcbcfc57c682b4a996174cbc470..e41602a9d19176cf29c0d5f3222546462c21b46b 100644 (file)
@@ -106,27 +106,27 @@ public:
   /**
    * Apply preconditioner.
    */
-  template<class VectorType>
+  template <class VectorType>
   void vmult (VectorType &, const VectorType &) const;
 
   /**
    * Apply transpose preconditioner. Since this is the identity, this function
    * is the same as vmult().
    */
-  template<class VectorType>
+  template <class VectorType>
   void Tvmult (VectorType &, const VectorType &) const;
 
   /**
    * Apply preconditioner, adding to the previous value.
    */
-  template<class VectorType>
+  template <class VectorType>
   void vmult_add (VectorType &, const VectorType &) const;
 
   /**
    * Apply transpose preconditioner, adding. Since this is the identity, this
    * function is the same as vmult_add().
    */
-  template<class VectorType>
+  template <class VectorType>
   void Tvmult_add (VectorType &, const VectorType &) const;
 
   /**
@@ -229,26 +229,26 @@ public:
   /**
    * Apply preconditioner.
    */
-  template<class VectorType>
+  template <class VectorType>
   void vmult (VectorType &, const VectorType &) const;
 
   /**
    * Apply transpose preconditioner. Since this is the identity, this function
    * is the same as vmult().
    */
-  template<class VectorType>
+  template <class VectorType>
   void Tvmult (VectorType &, const VectorType &) const;
   /**
    * Apply preconditioner, adding to the previous value.
    */
-  template<class VectorType>
+  template <class VectorType>
   void vmult_add (VectorType &, const VectorType &) const;
 
   /**
    * Apply transpose preconditioner, adding. Since this is the identity, this
    * function is the same as vmult_add().
    */
-  template<class VectorType>
+  template <class VectorType>
   void Tvmult_add (VectorType &, const VectorType &) const;
 
   /**
@@ -334,7 +334,7 @@ private:
  *
  * @author Guido Kanschat, Wolfgang Bangerth, 1999
  */
-template<typename MatrixType = SparseMatrix<double>, class VectorType = Vector<double> >
+template <typename MatrixType = SparseMatrix<double>, class VectorType = Vector<double> >
 class PreconditionUseMatrix : public Subscriptor
 {
 public:
@@ -380,7 +380,7 @@ private:
  * @author Guido Kanschat, 2000; extension for full compatibility with
  * LinearOperator class: Jean-Paul Pelteret, 2015
  */
-template<typename MatrixType = SparseMatrix<double> >
+template <typename MatrixType = SparseMatrix<double> >
 class PreconditionRelaxation : public Subscriptor
 {
 public:
@@ -484,26 +484,26 @@ public:
   /**
    * Apply preconditioner.
    */
-  template<class VectorType>
+  template <class VectorType>
   void vmult (VectorType &, const VectorType &) const;
 
   /**
    * Apply transpose preconditioner. Since this is a symmetric preconditioner,
    * this function is the same as vmult().
    */
-  template<class VectorType>
+  template <class VectorType>
   void Tvmult (VectorType &, const VectorType &) const;
 
   /**
    * Perform one step of the preconditioned Richardson iteration.
    */
-  template<class VectorType>
+  template <class VectorType>
   void step (VectorType &x, const VectorType &rhs) const;
 
   /**
    * Perform one transposed step of the preconditioned Richardson iteration.
    */
-  template<class VectorType>
+  template <class VectorType>
   void Tstep (VectorType &x, const VectorType &rhs) const;
 };
 
@@ -566,25 +566,25 @@ public:
   /**
    * Apply preconditioner.
    */
-  template<class VectorType>
+  template <class VectorType>
   void vmult (VectorType &, const VectorType &) const;
 
   /**
    * Apply transpose preconditioner.
    */
-  template<class VectorType>
+  template <class VectorType>
   void Tvmult (VectorType &, const VectorType &) const;
 
   /**
    * Perform one step of the preconditioned Richardson iteration.
    */
-  template<class VectorType>
+  template <class VectorType>
   void step (VectorType &x, const VectorType &rhs) const;
 
   /**
    * Perform one transposed step of the preconditioned Richardson iteration.
    */
-  template<class VectorType>
+  template <class VectorType>
   void Tstep (VectorType &x, const VectorType &rhs) const;
 };
 
@@ -648,27 +648,27 @@ public:
   /**
    * Apply preconditioner.
    */
-  template<class VectorType>
+  template <class VectorType>
   void vmult (VectorType &, const VectorType &) const;
 
   /**
    * Apply transpose preconditioner. Since this is a symmetric preconditioner,
    * this function is the same as vmult().
    */
-  template<class VectorType>
+  template <class VectorType>
   void Tvmult (VectorType &, const VectorType &) const;
 
 
   /**
    * Perform one step of the preconditioned Richardson iteration
    */
-  template<class VectorType>
+  template <class VectorType>
   void step (VectorType &x, const VectorType &rhs) const;
 
   /**
    * Perform one transposed step of the preconditioned Richardson iteration.
    */
-  template<class VectorType>
+  template <class VectorType>
   void Tstep (VectorType &x, const VectorType &rhs) const;
 
 private:
@@ -789,13 +789,13 @@ public:
   /**
    * Apply preconditioner.
    */
-  template<class VectorType>
+  template <class VectorType>
   void vmult (VectorType &, const VectorType &) const;
 
   /**
    * Apply transpose preconditioner.
    */
-  template<class VectorType>
+  template <class VectorType>
   void Tvmult (VectorType &, const VectorType &) const;
 private:
   /**
@@ -1160,7 +1160,7 @@ PreconditionIdentity::initialize (const MatrixType &matrix,
 }
 
 
-template<class VectorType>
+template <class VectorType>
 inline void
 PreconditionIdentity::vmult (VectorType &dst, const VectorType &src) const
 {
@@ -1169,14 +1169,14 @@ PreconditionIdentity::vmult (VectorType &dst, const VectorType &src) const
 
 
 
-template<class VectorType>
+template <class VectorType>
 inline void
 PreconditionIdentity::Tvmult (VectorType &dst, const VectorType &src) const
 {
   dst = src;
 }
 
-template<class VectorType>
+template <class VectorType>
 inline void
 PreconditionIdentity::vmult_add (VectorType &dst, const VectorType &src) const
 {
@@ -1185,7 +1185,7 @@ PreconditionIdentity::vmult_add (VectorType &dst, const VectorType &src) const
 
 
 
-template<class VectorType>
+template <class VectorType>
 inline void
 PreconditionIdentity::Tvmult_add (VectorType &dst, const VectorType &src) const
 {
@@ -1250,7 +1250,7 @@ PreconditionRichardson::initialize
 
 
 
-template<class VectorType>
+template <class VectorType>
 inline void
 PreconditionRichardson::vmult (VectorType &dst, const VectorType &src) const
 {
@@ -1263,7 +1263,7 @@ PreconditionRichardson::vmult (VectorType &dst, const VectorType &src) const
 
 
 
-template<class VectorType>
+template <class VectorType>
 inline void
 PreconditionRichardson::Tvmult (VectorType &dst, const VectorType &src) const
 {
@@ -1274,7 +1274,7 @@ PreconditionRichardson::Tvmult (VectorType &dst, const VectorType &src) const
   dst.equ(relaxation,src);
 }
 
-template<class VectorType>
+template <class VectorType>
 inline void
 PreconditionRichardson::vmult_add (VectorType &dst, const VectorType &src) const
 {
@@ -1287,7 +1287,7 @@ PreconditionRichardson::vmult_add (VectorType &dst, const VectorType &src) const
 
 
 
-template<class VectorType>
+template <class VectorType>
 inline void
 PreconditionRichardson::Tvmult_add (VectorType &dst, const VectorType &src) const
 {
@@ -1350,7 +1350,7 @@ PreconditionRelaxation<MatrixType>::n () const
 //---------------------------------------------------------------------------
 
 template <typename MatrixType>
-template<class VectorType>
+template <class VectorType>
 inline void
 PreconditionJacobi<MatrixType>::vmult (VectorType &dst, const VectorType &src) const
 {
@@ -1365,7 +1365,7 @@ PreconditionJacobi<MatrixType>::vmult (VectorType &dst, const VectorType &src) c
 
 
 template <typename MatrixType>
-template<class VectorType>
+template <class VectorType>
 inline void
 PreconditionJacobi<MatrixType>::Tvmult (VectorType &dst, const VectorType &src) const
 {
@@ -1380,7 +1380,7 @@ PreconditionJacobi<MatrixType>::Tvmult (VectorType &dst, const VectorType &src)
 
 
 template <typename MatrixType>
-template<class VectorType>
+template <class VectorType>
 inline void
 PreconditionJacobi<MatrixType>::step (VectorType &dst, const VectorType &src) const
 {
@@ -1395,7 +1395,7 @@ PreconditionJacobi<MatrixType>::step (VectorType &dst, const VectorType &src) co
 
 
 template <typename MatrixType>
-template<class VectorType>
+template <class VectorType>
 inline void
 PreconditionJacobi<MatrixType>::Tstep (VectorType &dst, const VectorType &src) const
 {
@@ -1411,7 +1411,7 @@ PreconditionJacobi<MatrixType>::Tstep (VectorType &dst, const VectorType &src) c
 //---------------------------------------------------------------------------
 
 template <typename MatrixType>
-template<class VectorType>
+template <class VectorType>
 inline void
 PreconditionSOR<MatrixType>::vmult (VectorType &dst, const VectorType &src) const
 {
@@ -1426,7 +1426,7 @@ PreconditionSOR<MatrixType>::vmult (VectorType &dst, const VectorType &src) cons
 
 
 template <typename MatrixType>
-template<class VectorType>
+template <class VectorType>
 inline void
 PreconditionSOR<MatrixType>::Tvmult (VectorType &dst, const VectorType &src) const
 {
@@ -1441,7 +1441,7 @@ PreconditionSOR<MatrixType>::Tvmult (VectorType &dst, const VectorType &src) con
 
 
 template <typename MatrixType>
-template<class VectorType>
+template <class VectorType>
 inline void
 PreconditionSOR<MatrixType>::step (VectorType &dst, const VectorType &src) const
 {
@@ -1456,7 +1456,7 @@ PreconditionSOR<MatrixType>::step (VectorType &dst, const VectorType &src) const
 
 
 template <typename MatrixType>
-template<class VectorType>
+template <class VectorType>
 inline void
 PreconditionSOR<MatrixType>::Tstep (VectorType &dst, const VectorType &src) const
 {
@@ -1507,7 +1507,7 @@ PreconditionSSOR<MatrixType>::initialize (const MatrixType                     &
 
 
 template <typename MatrixType>
-template<class VectorType>
+template <class VectorType>
 inline void
 PreconditionSSOR<MatrixType>::vmult (VectorType &dst, const VectorType &src) const
 {
@@ -1522,7 +1522,7 @@ PreconditionSSOR<MatrixType>::vmult (VectorType &dst, const VectorType &src) con
 
 
 template <typename MatrixType>
-template<class VectorType>
+template <class VectorType>
 inline void
 PreconditionSSOR<MatrixType>::Tvmult (VectorType &dst, const VectorType &src) const
 {
@@ -1537,7 +1537,7 @@ PreconditionSSOR<MatrixType>::Tvmult (VectorType &dst, const VectorType &src) co
 
 
 template <typename MatrixType>
-template<class VectorType>
+template <class VectorType>
 inline void
 PreconditionSSOR<MatrixType>::step (VectorType &dst, const VectorType &src) const
 {
@@ -1552,7 +1552,7 @@ PreconditionSSOR<MatrixType>::step (VectorType &dst, const VectorType &src) cons
 
 
 template <typename MatrixType>
-template<class VectorType>
+template <class VectorType>
 inline void
 PreconditionSSOR<MatrixType>::Tstep (VectorType &dst, const VectorType &src) const
 {
@@ -1610,7 +1610,7 @@ PreconditionPSOR<MatrixType>::vmult (VectorType &dst, const VectorType &src) con
 
 
 template <typename MatrixType>
-template<class VectorType>
+template <class VectorType>
 inline void
 PreconditionPSOR<MatrixType>::Tvmult (VectorType &dst, const VectorType &src) const
 {
@@ -1640,7 +1640,7 @@ PreconditionPSOR<MatrixType>::AdditionalData::AdditionalData
 //---------------------------------------------------------------------------
 
 
-template<typename MatrixType, class VectorType>
+template <typename MatrixType, class VectorType>
 PreconditionUseMatrix<MatrixType,VectorType>::PreconditionUseMatrix(const MatrixType   &M,
     const function_ptr method)
   :
@@ -1649,7 +1649,7 @@ PreconditionUseMatrix<MatrixType,VectorType>::PreconditionUseMatrix(const Matrix
 
 
 
-template<typename MatrixType, class VectorType>
+template <typename MatrixType, class VectorType>
 void
 PreconditionUseMatrix<MatrixType,VectorType>::vmult (VectorType       &dst,
                                                      const VectorType &src) const
@@ -1659,7 +1659,7 @@ PreconditionUseMatrix<MatrixType,VectorType>::vmult (VectorType       &dst,
 
 //---------------------------------------------------------------------------
 
-template<typename MatrixType>
+template <typename MatrixType>
 inline
 PreconditionRelaxation<MatrixType>::AdditionalData::
 AdditionalData (const double relaxation)
@@ -1790,7 +1790,7 @@ namespace internal
       mutable Number *dst;
     };
 
-    template<typename Number>
+    template <typename Number>
     struct VectorUpdatesRange : public parallel::ParallelForInteger
     {
       VectorUpdatesRange(const VectorUpdater<Number> &updater,
index 8aab5b675b4ad5e99082ce5d7a5a3ae49ea7931e..4d8cd31b0ec9285b925488ce8b7d81450dadc638 100644 (file)
@@ -77,7 +77,7 @@ DEAL_II_NAMESPACE_OPEN
  * @author Ralf Hartmann, Guido Kanschat
  * @date 1999, 2000, 2010
  */
-template<typename MatrixType, typename inverse_type = typename MatrixType::value_type>
+template <typename MatrixType, typename inverse_type = typename MatrixType::value_type>
 class PreconditionBlock
   : public virtual Subscriptor,
     protected PreconditionBlockBase<inverse_type>
@@ -363,7 +363,7 @@ protected:
  *
  * @author Ralf Hartmann, Guido Kanschat, 1999, 2000, 2003
  */
-template<typename MatrixType, typename inverse_type = typename MatrixType::value_type>
+template <typename MatrixType, typename inverse_type = typename MatrixType::value_type>
 class PreconditionBlockJacobi : public virtual Subscriptor,
   private PreconditionBlock<MatrixType, inverse_type>
 {
@@ -629,7 +629,7 @@ private:
  *
  * @author Ralf Hartmann, Guido Kanschat, 1999, 2000, 2001, 2002, 2003
  */
-template<typename MatrixType, typename inverse_type = typename MatrixType::value_type>
+template <typename MatrixType, typename inverse_type = typename MatrixType::value_type>
 class PreconditionBlockSOR : public virtual Subscriptor,
   protected PreconditionBlock<MatrixType, inverse_type>
 {
@@ -787,7 +787,7 @@ protected:
  *
  * @author Ralf Hartmann, Guido Kanschat, 1999, 2000
  */
-template<typename MatrixType, typename inverse_type = typename MatrixType::value_type>
+template <typename MatrixType, typename inverse_type = typename MatrixType::value_type>
 class PreconditionBlockSSOR : public virtual Subscriptor,
   private PreconditionBlockSOR<MatrixType, inverse_type>
 {
@@ -864,7 +864,7 @@ public:
 
 #ifndef DOXYGEN
 
-template<typename MatrixType, typename inverse_type>
+template <typename MatrixType, typename inverse_type>
 inline bool
 PreconditionBlock<MatrixType, inverse_type>::empty () const
 {
@@ -874,7 +874,7 @@ PreconditionBlock<MatrixType, inverse_type>::empty () const
 }
 
 
-template<typename MatrixType, typename inverse_type>
+template <typename MatrixType, typename inverse_type>
 inline inverse_type
 PreconditionBlock<MatrixType, inverse_type>::el (
   size_type i,
@@ -898,7 +898,7 @@ PreconditionBlock<MatrixType, inverse_type>::el (
 
 //---------------------------------------------------------------------------
 
-template<typename MatrixType, typename inverse_type>
+template <typename MatrixType, typename inverse_type>
 inline
 PreconditionBlockJacobi<MatrixType, inverse_type>::const_iterator::Accessor::
 Accessor (const PreconditionBlockJacobi<MatrixType, inverse_type> *matrix,
@@ -926,7 +926,7 @@ Accessor (const PreconditionBlockJacobi<MatrixType, inverse_type> *matrix,
 }
 
 
-template<typename MatrixType, typename inverse_type>
+template <typename MatrixType, typename inverse_type>
 inline
 typename PreconditionBlockJacobi<MatrixType, inverse_type>::size_type
 PreconditionBlockJacobi<MatrixType, inverse_type>::const_iterator::Accessor::row() const
@@ -938,7 +938,7 @@ PreconditionBlockJacobi<MatrixType, inverse_type>::const_iterator::Accessor::row
 }
 
 
-template<typename MatrixType, typename inverse_type>
+template <typename MatrixType, typename inverse_type>
 inline
 typename PreconditionBlockJacobi<MatrixType, inverse_type>::size_type
 PreconditionBlockJacobi<MatrixType, inverse_type>::const_iterator::Accessor::column() const
@@ -950,7 +950,7 @@ PreconditionBlockJacobi<MatrixType, inverse_type>::const_iterator::Accessor::col
 }
 
 
-template<typename MatrixType, typename inverse_type>
+template <typename MatrixType, typename inverse_type>
 inline
 inverse_type
 PreconditionBlockJacobi<MatrixType, inverse_type>::const_iterator::Accessor::value() const
@@ -962,7 +962,7 @@ PreconditionBlockJacobi<MatrixType, inverse_type>::const_iterator::Accessor::val
 }
 
 
-template<typename MatrixType, typename inverse_type>
+template <typename MatrixType, typename inverse_type>
 inline
 PreconditionBlockJacobi<MatrixType, inverse_type>::const_iterator::
 const_iterator(const PreconditionBlockJacobi<MatrixType, inverse_type> *matrix,
@@ -972,7 +972,7 @@ const_iterator(const PreconditionBlockJacobi<MatrixType, inverse_type> *matrix,
 {}
 
 
-template<typename MatrixType, typename inverse_type>
+template <typename MatrixType, typename inverse_type>
 inline
 typename PreconditionBlockJacobi<MatrixType, inverse_type>::const_iterator &
 PreconditionBlockJacobi<MatrixType, inverse_type>::const_iterator::operator++ ()
@@ -994,7 +994,7 @@ PreconditionBlockJacobi<MatrixType, inverse_type>::const_iterator::operator++ ()
 }
 
 
-template<typename MatrixType, typename inverse_type>
+template <typename MatrixType, typename inverse_type>
 inline
 const typename PreconditionBlockJacobi<MatrixType, inverse_type>::const_iterator::Accessor &
 PreconditionBlockJacobi<MatrixType, inverse_type>::const_iterator::operator* () const
@@ -1003,7 +1003,7 @@ PreconditionBlockJacobi<MatrixType, inverse_type>::const_iterator::operator* ()
 }
 
 
-template<typename MatrixType, typename inverse_type>
+template <typename MatrixType, typename inverse_type>
 inline
 const typename PreconditionBlockJacobi<MatrixType, inverse_type>::const_iterator::Accessor *
 PreconditionBlockJacobi<MatrixType, inverse_type>::const_iterator::operator-> () const
@@ -1012,7 +1012,7 @@ PreconditionBlockJacobi<MatrixType, inverse_type>::const_iterator::operator-> ()
 }
 
 
-template<typename MatrixType, typename inverse_type>
+template <typename MatrixType, typename inverse_type>
 inline
 bool
 PreconditionBlockJacobi<MatrixType, inverse_type>::const_iterator::
@@ -1030,7 +1030,7 @@ operator == (const const_iterator &other) const
 }
 
 
-template<typename MatrixType, typename inverse_type>
+template <typename MatrixType, typename inverse_type>
 inline
 bool
 PreconditionBlockJacobi<MatrixType, inverse_type>::const_iterator::
@@ -1040,7 +1040,7 @@ operator != (const const_iterator &other) const
 }
 
 
-template<typename MatrixType, typename inverse_type>
+template <typename MatrixType, typename inverse_type>
 inline
 bool
 PreconditionBlockJacobi<MatrixType, inverse_type>::const_iterator::
@@ -1052,7 +1052,7 @@ operator < (const const_iterator &other) const
 }
 
 
-template<typename MatrixType, typename inverse_type>
+template <typename MatrixType, typename inverse_type>
 inline
 typename PreconditionBlockJacobi<MatrixType, inverse_type>::const_iterator
 PreconditionBlockJacobi<MatrixType, inverse_type>::begin () const
@@ -1061,7 +1061,7 @@ PreconditionBlockJacobi<MatrixType, inverse_type>::begin () const
 }
 
 
-template<typename MatrixType, typename inverse_type>
+template <typename MatrixType, typename inverse_type>
 inline
 typename PreconditionBlockJacobi<MatrixType, inverse_type>::const_iterator
 PreconditionBlockJacobi<MatrixType, inverse_type>::end () const
@@ -1070,7 +1070,7 @@ PreconditionBlockJacobi<MatrixType, inverse_type>::end () const
 }
 
 
-template<typename MatrixType, typename inverse_type>
+template <typename MatrixType, typename inverse_type>
 inline
 typename PreconditionBlockJacobi<MatrixType, inverse_type>::const_iterator
 PreconditionBlockJacobi<MatrixType, inverse_type>::begin (
@@ -1082,7 +1082,7 @@ PreconditionBlockJacobi<MatrixType, inverse_type>::begin (
 
 
 
-template<typename MatrixType, typename inverse_type>
+template <typename MatrixType, typename inverse_type>
 inline
 typename PreconditionBlockJacobi<MatrixType, inverse_type>::const_iterator
 PreconditionBlockJacobi<MatrixType, inverse_type>::end (
index 789e87ccc4a0faceff5c32b1decd52418a0d189c..0ee3d4864eb4da7a1b25dec4c5f5be2504533e21 100644 (file)
@@ -29,7 +29,7 @@
 DEAL_II_NAMESPACE_OPEN
 
 
-template<typename MatrixType, typename inverse_type>
+template <typename MatrixType, typename inverse_type>
 PreconditionBlock<MatrixType, inverse_type>::AdditionalData::
 AdditionalData (const size_type block_size,
                 const double    relaxation,
index 2292f67b5a5da62ffd31d84a940d1853bd563261..b4941b6bb2f4e9d198182ebdfef618499f1753af 100644 (file)
@@ -273,9 +273,9 @@ private:
  * @author Guido Kanschat
  * @date 2010
  */
-template<typename MatrixType,
-         typename InverseNumberType = typename MatrixType::value_type,
-         typename VectorType = Vector<double> >
+template <typename MatrixType,
+          typename InverseNumberType = typename MatrixType::value_type,
+          typename VectorType = Vector<double> >
 class RelaxationBlockJacobi : public virtual Subscriptor,
   protected RelaxationBlock<MatrixType, InverseNumberType, VectorType>
 {
@@ -373,9 +373,9 @@ public:
  * @author Guido Kanschat
  * @date 2010
  */
-template<typename MatrixType,
-         typename InverseNumberType = typename MatrixType::value_type,
-         typename VectorType = Vector<double> >
+template <typename MatrixType,
+          typename InverseNumberType = typename MatrixType::value_type,
+          typename VectorType = Vector<double> >
 class RelaxationBlockSOR : public virtual Subscriptor,
   protected RelaxationBlock<MatrixType, InverseNumberType, VectorType>
 {
@@ -468,9 +468,9 @@ public:
  * @author Guido Kanschat
  * @date 2010
  */
-template<typename MatrixType,
-         typename InverseNumberType = typename MatrixType::value_type,
-         typename VectorType = Vector<double> >
+template <typename MatrixType,
+          typename InverseNumberType = typename MatrixType::value_type,
+          typename VectorType = Vector<double> >
 class RelaxationBlockSSOR : public virtual Subscriptor,
   protected RelaxationBlock<MatrixType, InverseNumberType, VectorType>
 {
index 7cb88f15a2bcc8523a5a9944e4ac98f415aa54f0..5f83bb5d535892a9e530401621534a1d66842649 100644 (file)
@@ -493,7 +493,7 @@ Solver<VectorType>::StateCombiner::operator ()(const Iterator begin,
 }
 
 
-template<class VectorType>
+template <class VectorType>
 inline
 Solver<VectorType>::Solver (SolverControl        &solver_control,
                             VectorMemory<VectorType> &vector_memory)
@@ -512,7 +512,7 @@ Solver<VectorType>::Solver (SolverControl        &solver_control,
 
 
 
-template<class VectorType>
+template <class VectorType>
 inline
 Solver<VectorType>::Solver (SolverControl &solver_control)
   :
@@ -531,7 +531,7 @@ Solver<VectorType>::Solver (SolverControl &solver_control)
 
 
 
-template<class VectorType>
+template <class VectorType>
 inline
 boost::signals2::connection
 Solver<VectorType>::
index df2d5ca800dcfa4e8f4f32d42b3ccbf5ff1aaec4..73db13787be8bf2c9509b8ee894fb25e99a94059 100644 (file)
@@ -129,7 +129,7 @@ public:
   /**
    * Solve primal problem only.
    */
-  template<typename MatrixType, typename PreconditionerType>
+  template <typename MatrixType, typename PreconditionerType>
   void
   solve (const MatrixType         &A,
          VectorType               &x,
@@ -254,7 +254,7 @@ private:
    * The iteration loop itself. The function returns a structure indicating
    * what happened in this function.
    */
-  template<typename MatrixType, typename PreconditionerType>
+  template <typename MatrixType, typename PreconditionerType>
   IterationResult
   iterate(const MatrixType         &A,
           const PreconditionerType &precondition);
@@ -266,7 +266,7 @@ private:
 #ifndef DOXYGEN
 
 
-template<typename VectorType>
+template <typename VectorType>
 SolverBicgstab<VectorType>::IterationResult::IterationResult
 (const bool                 breakdown,
  const SolverControl::State state,
@@ -280,7 +280,7 @@ SolverBicgstab<VectorType>::IterationResult::IterationResult
 {}
 
 
-template<typename VectorType>
+template <typename VectorType>
 SolverBicgstab<VectorType>::SolverBicgstab (SolverControl            &cn,
                                             VectorMemory<VectorType> &mem,
                                             const AdditionalData     &data)
@@ -291,7 +291,7 @@ SolverBicgstab<VectorType>::SolverBicgstab (SolverControl            &cn,
 
 
 
-template<typename VectorType>
+template <typename VectorType>
 SolverBicgstab<VectorType>::SolverBicgstab (SolverControl        &cn,
                                             const AdditionalData &data)
   :
@@ -317,7 +317,7 @@ SolverBicgstab<VectorType>::SolverBicgstab (SolverControl        &cn,
 
 
 
-template<typename VectorType>
+template <typename VectorType>
 SolverBicgstab<VectorType>::~SolverBicgstab ()
 {}
 
@@ -353,7 +353,7 @@ SolverBicgstab<VectorType>::start (const MatrixType &A)
 
 
 
-template<typename VectorType>
+template <typename VectorType>
 void
 SolverBicgstab<VectorType>::print_vectors(const unsigned int,
                                           const VectorType &,
@@ -363,8 +363,8 @@ SolverBicgstab<VectorType>::print_vectors(const unsigned int,
 
 
 
-template<typename VectorType>
-template<typename MatrixType, typename PreconditionerType>
+template <typename VectorType>
+template <typename MatrixType, typename PreconditionerType>
 typename SolverBicgstab<VectorType>::IterationResult
 SolverBicgstab<VectorType>::iterate(const MatrixType         &A,
                                     const PreconditionerType &precondition)
@@ -450,8 +450,8 @@ SolverBicgstab<VectorType>::iterate(const MatrixType         &A,
 }
 
 
-template<typename VectorType>
-template<typename MatrixType, typename PreconditionerType>
+template <typename VectorType>
+template <typename MatrixType, typename PreconditionerType>
 void
 SolverBicgstab<VectorType>::solve(const MatrixType         &A,
                                   VectorType               &x,
index 87a690154bcfd1373d96443625b5a7a50e077f82..7ec47b44679a2e3d142e1947153d12736936ebd6 100644 (file)
@@ -486,7 +486,7 @@ SolverCG<VectorType>::solve (const MatrixType         &A,
 
 
 
-template<typename VectorType>
+template <typename VectorType>
 boost::signals2::connection
 SolverCG<VectorType>::connect_coefficients_slot
 (const std::function<void(double,double)> &slot)
@@ -496,7 +496,7 @@ SolverCG<VectorType>::connect_coefficients_slot
 
 
 
-template<typename VectorType>
+template <typename VectorType>
 boost::signals2::connection
 SolverCG<VectorType>::connect_condition_number_slot
 (const std::function<void(double)> &slot,
@@ -514,7 +514,7 @@ SolverCG<VectorType>::connect_condition_number_slot
 
 
 
-template<typename VectorType>
+template <typename VectorType>
 boost::signals2::connection
 SolverCG<VectorType>::connect_eigenvalues_slot
 (const std::function<void (const std::vector<double> &)> &slot,
index 87b9118bce840b285c528c5e033514d08617aa58..dc8701adf883822c9cf28d15b79e3e3a18f5de24 100644 (file)
@@ -245,7 +245,7 @@ public:
   /**
    * Solve the linear system $Ax=b$ for x.
    */
-  template<typename MatrixType, typename PreconditionerType>
+  template <typename MatrixType, typename PreconditionerType>
   void
   solve (const MatrixType         &A,
          VectorType               &x,
@@ -476,7 +476,7 @@ public:
   /**
    * Solve the linear system $Ax=b$ for x.
    */
-  template<typename MatrixType, typename PreconditionerType>
+  template <typename MatrixType, typename PreconditionerType>
   void
   solve (const MatrixType         &A,
          VectorType               &x,
@@ -708,7 +708,7 @@ SolverGMRES<VectorType>::modified_gram_schmidt
 
 
 
-template<class VectorType>
+template <class VectorType>
 inline void
 SolverGMRES<VectorType>::compute_eigs_and_cond
 (const FullMatrix<double>                     &H_orig,
@@ -754,8 +754,8 @@ SolverGMRES<VectorType>::compute_eigs_and_cond
 
 
 
-template<class VectorType>
-template<typename MatrixType, typename PreconditionerType>
+template <class VectorType>
+template <typename MatrixType, typename PreconditionerType>
 void
 SolverGMRES<VectorType>::solve (const MatrixType         &A,
                                 VectorType               &x,
@@ -1056,7 +1056,7 @@ SolverGMRES<VectorType>::solve (const MatrixType         &A,
 
 
 
-template<class VectorType>
+template <class VectorType>
 boost::signals2::connection
 SolverGMRES<VectorType>::connect_condition_number_slot
 (const std::function<void(double)> &slot,
@@ -1074,7 +1074,7 @@ SolverGMRES<VectorType>::connect_condition_number_slot
 
 
 
-template<class VectorType>
+template <class VectorType>
 boost::signals2::connection
 SolverGMRES<VectorType>::connect_eigenvalues_slot
 (const std::function<void (const std::vector<std::complex<double> > &)> &slot,
@@ -1092,7 +1092,7 @@ SolverGMRES<VectorType>::connect_eigenvalues_slot
 
 
 
-template<class VectorType>
+template <class VectorType>
 boost::signals2::connection
 SolverGMRES<VectorType>::connect_hessenberg_slot
 (const std::function<void (const FullMatrix<double> &)> &slot,
@@ -1110,7 +1110,7 @@ SolverGMRES<VectorType>::connect_hessenberg_slot
 
 
 
-template<class VectorType>
+template <class VectorType>
 boost::signals2::connection
 SolverGMRES<VectorType>::connect_krylov_space_slot
 (const std::function<void (const internal::SolverGMRES::TmpVectors<VectorType> &)> &slot)
@@ -1120,7 +1120,7 @@ SolverGMRES<VectorType>::connect_krylov_space_slot
 
 
 
-template<class VectorType>
+template <class VectorType>
 double
 SolverGMRES<VectorType>::criterion ()
 {
@@ -1154,8 +1154,8 @@ SolverFGMRES<VectorType>::SolverFGMRES (SolverControl        &cn,
 
 
 
-template<class VectorType>
-template<typename MatrixType, typename PreconditionerType>
+template <class VectorType>
+template <typename MatrixType, typename PreconditionerType>
 void
 SolverFGMRES<VectorType>::solve (const MatrixType         &A,
                                  VectorType               &x,
index 72f407422a431dd07607662da694a01343d4e316..a4150e69e71897b2d42c13993fc80739b7893f4a 100644 (file)
@@ -99,7 +99,7 @@ public:
   /**
    * Solve the linear system $Ax=b$ for x.
    */
-  template<typename MatrixType, typename PreconditionerType>
+  template <typename MatrixType, typename PreconditionerType>
   void
   solve (const MatrixType         &A,
          VectorType               &x,
@@ -154,7 +154,7 @@ protected:
 
 #ifndef DOXYGEN
 
-template<class VectorType>
+template <class VectorType>
 SolverMinRes<VectorType>::SolverMinRes (SolverControl            &cn,
                                         VectorMemory<VectorType> &mem,
                                         const AdditionalData &)
@@ -164,7 +164,7 @@ SolverMinRes<VectorType>::SolverMinRes (SolverControl            &cn,
 
 
 
-template<class VectorType>
+template <class VectorType>
 SolverMinRes<VectorType>::SolverMinRes (SolverControl        &cn,
                                         const AdditionalData &)
   :
@@ -180,13 +180,13 @@ SolverMinRes<VectorType>::SolverMinRes (SolverControl        &cn,
 {}
 
 
-template<class VectorType>
+template <class VectorType>
 SolverMinRes<VectorType>::~SolverMinRes ()
 {}
 
 
 
-template<class VectorType>
+template <class VectorType>
 double
 SolverMinRes<VectorType>::criterion()
 {
@@ -194,7 +194,7 @@ SolverMinRes<VectorType>::criterion()
 }
 
 
-template<class VectorType>
+template <class VectorType>
 void
 SolverMinRes<VectorType>::print_vectors(const unsigned int,
                                         const VectorType &,
@@ -204,8 +204,8 @@ SolverMinRes<VectorType>::print_vectors(const unsigned int,
 
 
 
-template<class VectorType>
-template<typename MatrixType, typename PreconditionerType>
+template <class VectorType>
+template <typename MatrixType, typename PreconditionerType>
 void
 SolverMinRes<VectorType>::solve (const MatrixType         &A,
                                  VectorType               &x,
index 60e0073b4c8eedc4cfe3dfaaa0d61a839ef8f1cb..08bf9066af7122f97fd3ef7dae16657c2fd3b26f 100644 (file)
@@ -125,7 +125,7 @@ public:
   /**
    * Solve the linear system $Ax=b$ for x.
    */
-  template<typename MatrixType, typename PreconditionerType>
+  template <typename MatrixType, typename PreconditionerType>
   void
   solve (const MatrixType         &A,
          VectorType               &x,
@@ -198,7 +198,7 @@ private:
    * The iteration loop itself. The function returns a structure indicating
    * what happened in this function.
    */
-  template<typename MatrixType, typename PreconditionerType>
+  template <typename MatrixType, typename PreconditionerType>
   IterationResult
   iterate (const MatrixType         &A,
            const PreconditionerType &precondition);
@@ -214,7 +214,7 @@ private:
 
 #ifndef DOXYGEN
 
-template<class VectorType>
+template <class VectorType>
 SolverQMRS<VectorType>::IterationResult::IterationResult (const SolverControl::State state,
                                                           const double               last_residual)
   :
@@ -223,7 +223,7 @@ SolverQMRS<VectorType>::IterationResult::IterationResult (const SolverControl::S
 {}
 
 
-template<class VectorType>
+template <class VectorType>
 SolverQMRS<VectorType>::SolverQMRS (SolverControl            &cn,
                                     VectorMemory<VectorType> &mem,
                                     const AdditionalData     &data)
@@ -234,7 +234,7 @@ SolverQMRS<VectorType>::SolverQMRS (SolverControl            &cn,
 
 
 
-template<class VectorType>
+template <class VectorType>
 SolverQMRS<VectorType>::SolverQMRS(SolverControl        &cn,
                                    const AdditionalData &data)
   :
@@ -244,7 +244,7 @@ SolverQMRS<VectorType>::SolverQMRS(SolverControl        &cn,
 
 
 
-template<class VectorType>
+template <class VectorType>
 double
 SolverQMRS<VectorType>::criterion()
 {
@@ -253,7 +253,7 @@ SolverQMRS<VectorType>::criterion()
 
 
 
-template<class VectorType>
+template <class VectorType>
 void
 SolverQMRS<VectorType>::print_vectors(const unsigned int,
                                       const VectorType &,
@@ -263,8 +263,8 @@ SolverQMRS<VectorType>::print_vectors(const unsigned int,
 
 
 
-template<class VectorType>
-template<typename MatrixType, typename PreconditionerType>
+template <class VectorType>
+template <typename MatrixType, typename PreconditionerType>
 void
 SolverQMRS<VectorType>::solve (const MatrixType         &A,
                                VectorType               &x,
@@ -321,8 +321,8 @@ SolverQMRS<VectorType>::solve (const MatrixType         &A,
 
 
 
-template<class VectorType>
-template<typename MatrixType, typename PreconditionerType>
+template <class VectorType>
+template <typename MatrixType, typename PreconditionerType>
 typename SolverQMRS<VectorType>::IterationResult
 SolverQMRS<VectorType>::iterate(const MatrixType         &A,
                                 const PreconditionerType &precondition)
index fad56a269b857c304733f619a172d9a6360dd281..67df65cde8c468ab8c64ce2c2992a75934c86140 100644 (file)
@@ -79,7 +79,7 @@ public:
    * R(x_k,b)$. The matrix <i>A</i> itself is only used to compute the
    * residual.
    */
-  template<typename MatrixType, class RelaxationType>
+  template <typename MatrixType, class RelaxationType>
   void
   solve (const MatrixType     &A,
          VectorType           &x,
index f387cfcbbd5b1aa655519b5c6ecad31dde60199d..834a91dca59b194bb799693e283162dbf1d62bf1 100644 (file)
@@ -108,7 +108,7 @@ public:
   /**
    * Solve the linear system $Ax=b$ for x.
    */
-  template<typename MatrixType, typename PreconditionerType>
+  template <typename MatrixType, typename PreconditionerType>
   void
   solve (const MatrixType         &A,
          VectorType               &x,
@@ -118,7 +118,7 @@ public:
   /**
    * Solve $A^Tx=b$ for $x$.
    */
-  template<typename MatrixType, typename PreconditionerType>
+  template <typename MatrixType, typename PreconditionerType>
   void
   Tsolve (const MatrixType         &A,
           VectorType               &x,
index 0c78fc44c7c8dd3b2c003c3d30301de2146d93e2..9412e5cdcd061f85bdf848cb38f3193a4e2978e4 100644 (file)
@@ -118,7 +118,7 @@ public:
    * SolverName was specified in the constructor.
    *
    */
-  template<class Matrix, class Preconditioner>
+  template <class Matrix, class Preconditioner>
   void solve (const Matrix         &A,
               VectorType           &x,
               const VectorType     &b,
@@ -256,7 +256,7 @@ SolverSelector<VectorType>::select(const std::string &name)
 
 
 template <typename VectorType>
-template<class Matrix, class Preconditioner>
+template <class Matrix, class Preconditioner>
 void
 SolverSelector<VectorType>::solve (const Matrix         &A,
                                    VectorType           &x,
index b22b38b063776bec1f3eeeb3dac28a315474c735..7009208ba781ef1502519d1f38f7c49b7aa4a442 100644 (file)
@@ -278,7 +278,7 @@ protected:
    * Copies the passed SparseMatrix onto this object. This object's sparsity
    * pattern remains unchanged.
    */
-  template<typename somenumber>
+  template <typename somenumber>
   void copy_from (const SparseMatrix<somenumber> &matrix);
 
   /**
index a4154c43f404a9122b4a4af5a4fad56d157a78d0..b5827863f9bf386bc2db8d128ce3338bc9a10632 100644 (file)
@@ -27,7 +27,7 @@
 
 DEAL_II_NAMESPACE_OPEN
 
-template<typename number>
+template <typename number>
 SparseLUDecomposition<number>::SparseLUDecomposition()
   :
   SparseMatrix<number>(),
@@ -37,14 +37,14 @@ SparseLUDecomposition<number>::SparseLUDecomposition()
 
 
 
-template<typename number>
+template <typename number>
 SparseLUDecomposition<number>::~SparseLUDecomposition()
 {
   clear();
 }
 
 
-template<typename number>
+template <typename number>
 void SparseLUDecomposition<number>::clear()
 {
   std::vector<const size_type *> tmp;
@@ -61,7 +61,7 @@ void SparseLUDecomposition<number>::clear()
 
 
 
-template<typename number>
+template <typename number>
 template <typename somenumber>
 void SparseLUDecomposition<number>::initialize (
   const SparseMatrix<somenumber> &matrix,
@@ -130,7 +130,7 @@ void SparseLUDecomposition<number>::initialize (
 
 
 
-template<typename number>
+template <typename number>
 void
 SparseLUDecomposition<number>::prebuild_lower_bound()
 {
index bd1d517d9f89785eed7f4a3c7d401c397b8fb88e..17fe90d137de37494cb3fa01686191a9416adfd7 100644 (file)
@@ -167,7 +167,7 @@ namespace internal
   {
     typedef types::global_dof_index size_type;
 
-    template<typename T>
+    template <typename T>
     void zero_subrange (const size_type begin,
                         const size_type end,
                         T *dst)
index 66276cd39892338047d43c36f01c4528f1533902..5f4d45637f8cfc3c15e001ea0631149c11f9f673 100644 (file)
@@ -26,8 +26,8 @@
 
 DEAL_II_NAMESPACE_OPEN
 
-template<typename number> class Vector;
-template<typename number> class FullMatrix;
+template <typename number> class Vector;
+template <typename number> class FullMatrix;
 
 /**
  * @addtogroup Matrix1
@@ -1392,7 +1392,7 @@ SparseMatrixEZ<number>::end (const size_type r) const
   return result;
 }
 
-template<typename number>
+template <typename number>
 template <typename MatrixType>
 inline
 SparseMatrixEZ<number> &
@@ -1417,7 +1417,7 @@ SparseMatrixEZ<number>::copy_from (const MatrixType &M, const bool elide_zero_va
   return *this;
 }
 
-template<typename number>
+template <typename number>
 template <typename MatrixType>
 inline
 void
@@ -1445,7 +1445,7 @@ SparseMatrixEZ<number>::add (const number      factor,
 
 
 
-template<typename number>
+template <typename number>
 template <typename MatrixTypeA, typename MatrixTypeB>
 inline void
 SparseMatrixEZ<number>::conjugate_add (const MatrixTypeA &A,
index 73f813b2fb153e68bac1d87b2f254665dd966798..b73c34a7df30e526dffffd143aeced97ac366847 100644 (file)
@@ -127,7 +127,7 @@ template <typename number> class SparseBlockVanka;
  * @author Guido Kanschat, Wolfgang Bangerth; 1999, 2000; extension for full
  * compatibility with LinearOperator class: Jean-Paul Pelteret, 2015
  */
-template<typename number>
+template <typename number>
 class SparseVanka
 {
 public:
@@ -227,7 +227,7 @@ public:
    * Do the preconditioning. This function takes the residual in @p src and
    * returns the resulting update vector in @p dst.
    */
-  template<typename number2>
+  template <typename number2>
   void vmult (Vector<number2>       &dst,
               const Vector<number2> &src) const;
 
@@ -235,7 +235,7 @@ public:
    * Apply transpose preconditioner. This function takes the residual in @p
    * src  and returns the resulting update vector in @p dst.
    */
-  template<typename number2>
+  template <typename number2>
   void Tvmult (Vector<number2>       &dst,
                const Vector<number2> &src) const;
 
@@ -279,7 +279,7 @@ protected:
    * The @p vmult of this class of course calls this function with a null
    * pointer
    */
-  template<typename number2>
+  template <typename number2>
   void apply_preconditioner (Vector<number2>         &dst,
                              const Vector<number2>   &src,
                              const std::vector<bool> *const dof_mask = nullptr) const;
@@ -502,7 +502,7 @@ private:
  *
  * @author Wolfgang Bangerth, 2000
  */
-template<typename number>
+template <typename number>
 class SparseBlockVanka : public SparseVanka<number>
 {
 public:
@@ -540,7 +540,7 @@ public:
   /**
    * Apply the preconditioner.
    */
-  template<typename number2>
+  template <typename number2>
   void vmult (Vector<number2>       &dst,
               const Vector<number2> &src) const;
 
@@ -579,7 +579,7 @@ private:
 
 #ifndef DOXYGEN
 
-template<typename number>
+template <typename number>
 inline typename SparseVanka<number>::size_type
 SparseVanka<number>::m () const
 {
@@ -587,7 +587,7 @@ SparseVanka<number>::m () const
   return _m;
 }
 
-template<typename number>
+template <typename number>
 inline typename SparseVanka<number>::size_type
 SparseVanka<number>::n () const
 {
@@ -595,8 +595,8 @@ SparseVanka<number>::n () const
   return _n;
 }
 
-template<typename number>
-template<typename number2>
+template <typename number>
+template <typename number2>
 inline void
 SparseVanka<number>::Tvmult (Vector<number2>       &/*dst*/,
                              const Vector<number2> &/*src*/) const
index 31da7a5cc083f1dde9550f03082c155a092b0d96..835e883ef8cb4ffa1b3b9fb94efe1c4ebc054b7a 100644 (file)
@@ -29,7 +29,7 @@
 
 DEAL_II_NAMESPACE_OPEN
 
-template<typename number>
+template <typename number>
 SparseVanka<number>::SparseVanka()
   :
   matrix (),
@@ -43,7 +43,7 @@ SparseVanka<number>::SparseVanka()
 
 }
 
-template<typename number>
+template <typename number>
 SparseVanka<number>::SparseVanka(const SparseMatrix<number> &M,
                                  const std::vector<bool>    &selected_dofs,
                                  const bool                  conserve_mem,
@@ -65,7 +65,7 @@ SparseVanka<number>::SparseVanka(const SparseMatrix<number> &M,
 }
 
 
-template<typename number>
+template <typename number>
 SparseVanka<number>::~SparseVanka()
 {
   typename std::vector<SmartPointer<FullMatrix<float>,SparseVanka<number> > >::iterator i;
@@ -78,7 +78,7 @@ SparseVanka<number>::~SparseVanka()
 }
 
 
-template<typename number>
+template <typename number>
 void
 SparseVanka<number>::initialize(const SparseMatrix<number> &M,
                                 const AdditionalData       &additional_data)
@@ -220,8 +220,8 @@ SparseVanka<number>::compute_inverse (const size_type         row,
 }
 
 
-template<typename number>
-template<typename number2>
+template <typename number>
+template <typename number2>
 void
 SparseVanka<number>::vmult (Vector<number2>       &dst,
                             const Vector<number2> &src) const
@@ -237,8 +237,8 @@ SparseVanka<number>::vmult (Vector<number2>       &dst,
 }
 
 
-template<typename number>
-template<typename number2>
+template <typename number>
+template <typename number2>
 void
 SparseVanka<number>::apply_preconditioner (Vector<number2>         &dst,
                                            const Vector<number2>   &src,
index ffc1c1a6008f476885049c1fde1d09eb3753b250..28836a1f8223976c68daf90a471a022ce95e8752 100644 (file)
@@ -26,7 +26,7 @@
 DEAL_II_NAMESPACE_OPEN
 
 // forward declarations
-template<typename number> class Vector;
+template <typename number> class Vector;
 
 
 /*! @addtogroup Matrix1
@@ -45,7 +45,7 @@ template<typename number> class Vector;
  * @ingroup Matrix1
  * @author Guido Kanschat, 2005, 2006
  */
-template<typename number>
+template <typename number>
 class TridiagonalMatrix
 {
 public:
@@ -295,7 +295,7 @@ private:
 //---------------------------------------------------------------------------
 #ifndef DOXYGEN
 
-template<typename number>
+template <typename number>
 types::global_dof_index
 TridiagonalMatrix<number>::m() const
 {
@@ -304,7 +304,7 @@ TridiagonalMatrix<number>::m() const
 
 
 
-template<typename number>
+template <typename number>
 types::global_dof_index
 TridiagonalMatrix<number>::n() const
 {
@@ -312,7 +312,7 @@ TridiagonalMatrix<number>::n() const
 }
 
 
-template<typename number>
+template <typename number>
 inline
 number
 TridiagonalMatrix<number>::operator()(size_type i, size_type j) const
@@ -340,7 +340,7 @@ TridiagonalMatrix<number>::operator()(size_type i, size_type j) const
 }
 
 
-template<typename number>
+template <typename number>
 inline
 number &
 TridiagonalMatrix<number>::operator()(size_type i, size_type j)
index 6fdf7a376954aded250e6e42fef1b7a2934ab9f4..ef92198db6b30980d6912d9f85ad41a473b6625d 100644 (file)
@@ -595,7 +595,7 @@ namespace TrilinosWrappers
        *
        * @ingroup TrilinosWrappers
        */
-      template<typename PayloadBlockType>
+      template <typename PayloadBlockType>
       class TrilinosBlockPayload
       {
       public:
index d2b8d8fd87c22944aaed499c53cdf70475233ed9..01039bce7aa0472be9d642e6ef1b0e5b502413e3 100644 (file)
@@ -42,7 +42,7 @@ namespace TrilinosWrappers
 
     namespace BlockLinearOperator
     {
-      template<typename PayloadBlockType>
+      template <typename PayloadBlockType>
       class TrilinosBlockPayload;
     }
   }
index f184567c648631b264b726574550a5bed7751c24..9a6f4c34c35e21629538beea2c8f1c8cc07eeffe 100644 (file)
@@ -431,7 +431,7 @@ namespace internal
      * A helper class used internally in linear_operator.h. Specialization for
      * TrilinosWrappers::MPI::BlockVector.
      */
-    template<>
+    template <>
     class ReinitHelper<TrilinosWrappers::MPI::BlockVector>
     {
     public:
index 10c34bb7a059208041f19453aafebb940fc072e5..e22f3289cf9f2b57ab2a656e395220be1b7ff40e 100644 (file)
@@ -308,13 +308,13 @@ namespace TrilinosWrappers
      * The solve function is used to set properly the Epetra_LinearProblem,
      * once it is done this function solves the linear problem.
      */
-    template<typename Preconditioner>
+    template <typename Preconditioner>
     void do_solve(const Preconditioner &preconditioner);
 
     /**
      * A function that sets the preconditioner that the solver will apply
      */
-    template<typename Preconditioner>
+    template <typename Preconditioner>
     void set_preconditioner (AztecOO              &solver,
                              const Preconditioner &preconditioner);
 
index f6fe4e919cff4f4dcdc3e19935abb7d240b3678d..8c90ee992b86c7a56784a990480f409448b90d9e 100644 (file)
@@ -204,7 +204,7 @@ namespace TrilinosWrappers
     /**
      * The specialization for a const Accessor.
      */
-    template<>
+    template <>
     class Accessor<true> : public AccessorBase
     {
     public:
@@ -244,7 +244,7 @@ namespace TrilinosWrappers
     /**
      * The specialization for a mutable Accessor.
      */
-    template<>
+    template <>
     class Accessor<false> : public AccessorBase
     {
       class Reference
@@ -587,7 +587,7 @@ namespace TrilinosWrappers
      * This is a collective operation that needs to be called on all
      * processors in order to avoid a dead lock.
      */
-    template<typename SparsityPatternType>
+    template <typename SparsityPatternType>
     void reinit (const SparsityPatternType &sparsity_pattern);
 
     /**
@@ -749,7 +749,7 @@ namespace TrilinosWrappers
      *
      * @deprecated Use the respective method with IndexSet argument instead.
      */
-    template<typename SparsityPatternType>
+    template <typename SparsityPatternType>
     void reinit (const Epetra_Map          &parallel_partitioning,
                  const SparsityPatternType &sparsity_pattern,
                  const bool                 exchange_data = false) DEAL_II_DEPRECATED;
@@ -768,7 +768,7 @@ namespace TrilinosWrappers
      *
      * @deprecated Use the respective method with IndexSet argument instead.
      */
-    template<typename SparsityPatternType>
+    template <typename SparsityPatternType>
     void reinit (const Epetra_Map          &row_parallel_partitioning,
                  const Epetra_Map          &col_parallel_partitioning,
                  const SparsityPatternType &sparsity_pattern,
@@ -911,7 +911,7 @@ namespace TrilinosWrappers
      * This is a collective operation that needs to be called on all
      * processors in order to avoid a dead lock.
      */
-    template<typename SparsityPatternType>
+    template <typename SparsityPatternType>
     void reinit (const IndexSet            &parallel_partitioning,
                  const SparsityPatternType &sparsity_pattern,
                  const MPI_Comm            &communicator  = MPI_COMM_WORLD,
@@ -929,7 +929,7 @@ namespace TrilinosWrappers
      * This is a collective operation that needs to be called on all
      * processors in order to avoid a dead lock.
      */
-    template<typename SparsityPatternType>
+    template <typename SparsityPatternType>
     void reinit (const IndexSet            &row_parallel_partitioning,
                  const IndexSet            &col_parallel_partitioning,
                  const SparsityPatternType &sparsity_pattern,
@@ -1488,7 +1488,7 @@ namespace TrilinosWrappers
      * running on one processor, since the matrix object is inherently
      * distributed. Otherwise, an exception will be thrown.
      */
-    template<typename VectorType>
+    template <typename VectorType>
     void vmult (VectorType       &dst,
                 const VectorType &src) const;
 
@@ -1538,7 +1538,7 @@ namespace TrilinosWrappers
      * distributed. Otherwise, an exception will be thrown.
      *
      */
-    template<typename VectorType>
+    template <typename VectorType>
     void vmult_add (VectorType       &dst,
                     const VectorType &src) const;
 
index f37f9b477f8af15a4c9c40addb732c2afafefee8..476f4ed14444a53a3cdac9d9784d56bb3ac91b86 100644 (file)
@@ -368,7 +368,7 @@ namespace TrilinosWrappers
      * parallel, this function uses an ad-hoc partitioning of the rows and
      * columns.
      */
-    template<typename SparsityPatternType>
+    template <typename SparsityPatternType>
     void
     copy_from (const SparsityPatternType &nontrilinos_sparsity_pattern);
 
@@ -563,7 +563,7 @@ namespace TrilinosWrappers
      *
      * @deprecated Use the respective method with IndexSet argument instead.
      */
-    template<typename SparsityPatternType>
+    template <typename SparsityPatternType>
     void
     reinit (const Epetra_Map          &row_parallel_partitioning,
             const Epetra_Map          &col_parallel_partitioning,
@@ -580,7 +580,7 @@ namespace TrilinosWrappers
      *
      * @deprecated Use the respective method with IndexSet argument instead.
      */
-    template<typename SparsityPatternType>
+    template <typename SparsityPatternType>
     void
     reinit (const Epetra_Map          &parallel_partitioning,
             const SparsityPatternType &nontrilinos_sparsity_pattern,
@@ -795,7 +795,7 @@ namespace TrilinosWrappers
      * constructed. This feature is only implemented for input sparsity
      * patterns of type DynamicSparsityPattern.
      */
-    template<typename SparsityPatternType>
+    template <typename SparsityPatternType>
     void
     reinit (const IndexSet            &row_parallel_partitioning,
             const IndexSet            &col_parallel_partitioning,
@@ -811,7 +811,7 @@ namespace TrilinosWrappers
      * that is not fully constructed. This feature is only implemented for
      * input sparsity patterns of type DynamicSparsityPattern.
      */
-    template<typename SparsityPatternType>
+    template <typename SparsityPatternType>
     void
     reinit (const IndexSet            &parallel_partitioning,
             const SparsityPatternType &nontrilinos_sparsity_pattern,
index 0b149d164296741ccde97aad694d1338ebce5117..a2bfbd686c99c82a6746031e8daf916a99a4bcd1 100644 (file)
@@ -2166,7 +2166,7 @@ namespace internal
      * A helper class used internally in linear_operator.h. Specialization for
      * TrilinosWrappers::MPI::Vector.
      */
-    template<>
+    template <>
     class ReinitHelper<TrilinosWrappers::MPI::Vector>
     {
     public:
index 9c42d43339df2117f0069b8d2119196b142f5a82..d81bb464ef07a938d9e582830d4b2ff3bd9096b0 100644 (file)
@@ -59,7 +59,7 @@ namespace TrilinosWrappers
 }
 #endif
 
-template<typename number> class LAPACKFullMatrix;
+template <typename number> class LAPACKFullMatrix;
 
 template <typename> class BlockVector;
 
index 9968a50b96f10d188ccb415d0cb9c3e5fb90496f..1fb196db01f7c9a25e920be263ed269d07b85a4d 100644 (file)
@@ -67,7 +67,7 @@ DEAL_II_NAMESPACE_OPEN
  *
  * @author Guido Kanschat, 1998-2003
  */
-template<typename VectorType = dealii::Vector<double> >
+template <typename VectorType = dealii::Vector<double> >
 class VectorMemory : public Subscriptor
 {
 public:
@@ -169,7 +169,7 @@ public:
  * This class allocates and deletes vectors as needed from the global heap,
  * i.e. performs no specially adapted actions for memory management.
  */
-template<typename VectorType = dealii::Vector<double> >
+template <typename VectorType = dealii::Vector<double> >
 class PrimitiveVectorMemory : public VectorMemory<VectorType>
 {
 public:
@@ -232,7 +232,7 @@ public:
  *
  * @author Guido Kanschat, 1999, 2007
  */
-template<typename VectorType = dealii::Vector<double> >
+template <typename VectorType = dealii::Vector<double> >
 class GrowingVectorMemory : public VectorMemory<VectorType>
 {
 public:
index 03a2a043de5e3c3ffe4be9415a83c0aae1c41de4..5a700c78506e6080cfa94e3bdb7040f943b4f5af 100644 (file)
@@ -93,7 +93,7 @@ GrowingVectorMemory<VectorType>::GrowingVectorMemory (const size_type initial_si
 }
 
 
-template<typename VectorType>
+template <typename VectorType>
 inline
 GrowingVectorMemory<VectorType>::~GrowingVectorMemory()
 {
@@ -110,7 +110,7 @@ GrowingVectorMemory<VectorType>::~GrowingVectorMemory()
 
 
 
-template<typename VectorType>
+template <typename VectorType>
 inline
 VectorType *
 GrowingVectorMemory<VectorType>::alloc ()
@@ -140,7 +140,7 @@ GrowingVectorMemory<VectorType>::alloc ()
 
 
 
-template<typename VectorType>
+template <typename VectorType>
 inline
 void
 GrowingVectorMemory<VectorType>::free(const VectorType *const v)
@@ -161,7 +161,7 @@ GrowingVectorMemory<VectorType>::free(const VectorType *const v)
 
 
 
-template<typename VectorType>
+template <typename VectorType>
 inline
 void
 GrowingVectorMemory<VectorType>::release_unused_memory ()
@@ -187,7 +187,7 @@ GrowingVectorMemory<VectorType>::release_unused_memory ()
 
 
 
-template<typename VectorType>
+template <typename VectorType>
 inline
 std::size_t
 GrowingVectorMemory<VectorType>::memory_consumption () const
index 18a455a1449a65336ac4b30a381353f8733cdc95..660cc2f4209e41210f6dcd561b6d361d55f7fbef 100644 (file)
@@ -43,7 +43,7 @@ DEAL_II_NAMESPACE_OPEN
  *
  * @author Uwe Koecher, 2017
  */
-template<typename T>
+template <typename T>
 struct is_serial_vector;
 
 
index 4095238c7835a815d8bc389c0440d780a29776f5..1c968fef0e3b617bfa43e9363c28ce35cf13a0f5 100644 (file)
@@ -127,7 +127,7 @@ DEAL_II_NAMESPACE_OPEN
  *
  * @author Luca Heltai, 2009
  */
-template<typename Number>
+template <typename Number>
 class VectorView : public Vector<Number>
 {
 public:
@@ -232,7 +232,7 @@ public:
 
 #ifndef DOXYGEN
 
-template<typename Number>
+template <typename Number>
 inline
 VectorView<Number>::VectorView(const size_type new_size, Number *ptr)
 {
@@ -243,7 +243,7 @@ VectorView<Number>::VectorView(const size_type new_size, Number *ptr)
 
 
 
-template<typename Number>
+template <typename Number>
 inline
 VectorView<Number>::VectorView(const size_type new_size, const Number *ptr)
 {
@@ -254,7 +254,7 @@ VectorView<Number>::VectorView(const size_type new_size, const Number *ptr)
 
 
 
-template<typename Number>
+template <typename Number>
 inline
 VectorView<Number>::~VectorView()
 {
@@ -266,7 +266,7 @@ VectorView<Number>::~VectorView()
 }
 
 
-template<typename Number>
+template <typename Number>
 inline
 void VectorView<Number>::reinit(const size_type N,
                                 const bool omit_zeroing_entries)
@@ -278,7 +278,7 @@ void VectorView<Number>::reinit(const size_type N,
 }
 
 
-template<typename Number>
+template <typename Number>
 inline
 void VectorView<Number>::reinit(const size_type new_size, Number *ptr)
 {
@@ -288,7 +288,7 @@ void VectorView<Number>::reinit(const size_type new_size, Number *ptr)
 }
 
 
-template<typename Number>
+template <typename Number>
 inline
 void VectorView<Number>::reinit(const size_type new_size, const Number *ptr)
 {
@@ -298,7 +298,7 @@ void VectorView<Number>::reinit(const size_type new_size, const Number *ptr)
 }
 
 
-template<typename Number>
+template <typename Number>
 inline
 void VectorView<Number>::swap(Vector<Number> &)
 {
index 5487791c404b6b04b9713222769d5c583512d1bf..3058fb289145f93994376e14f3958bfd1ab047a3 100644 (file)
@@ -259,7 +259,7 @@ public:
    * writes to @p n_components blocks of the block vector starting at the
    * index @p first_index. For non-block vectors, @p first_index is ignored.
    */
-  template<typename VectorType>
+  template <typename VectorType>
   void distribute_local_to_global (VectorType        &dst,
                                    const unsigned int first_index = 0) const;
 
@@ -289,7 +289,7 @@ public:
    * writes to @p n_components blocks of the block vector starting at the
    * index @p first_index. For non-block vectors, @p first_index is ignored.
    */
-  template<typename VectorType>
+  template <typename VectorType>
   void set_dof_values (VectorType        &dst,
                        const unsigned int first_index = 0) const;
 
@@ -678,7 +678,7 @@ protected:
    * @p distribute_local_to_global, and @p set_dof_values. It performs the
    * operation for several vectors at a time.
    */
-  template<typename VectorType, typename VectorOperation>
+  template <typename VectorType, typename VectorOperation>
   void read_write_operation (const VectorOperation &operation,
                              VectorType            *vectors[]) const;
 
@@ -689,7 +689,7 @@ protected:
    * function DoFAccessor::read_dof_values. Note that if vectorization is
    * enabled, the DoF values for several cells are set.
    */
-  template<typename VectorType>
+  template <typename VectorType>
   void read_dof_values_plain (const VectorType *src_data[]);
 
   /**
@@ -2958,7 +2958,7 @@ namespace internal
 
 
 template <int dim, int n_components_, typename Number>
-template<typename VectorType, typename VectorOperation>
+template <typename VectorType, typename VectorOperation>
 inline
 void
 FEEvaluationBase<dim,n_components_,Number>
@@ -3303,7 +3303,7 @@ FEEvaluationBase<dim,n_components_,Number>
 
 
 template <int dim, int n_components_, typename Number>
-template<typename VectorType>
+template <typename VectorType>
 inline
 void
 FEEvaluationBase<dim,n_components_,Number>
@@ -3328,7 +3328,7 @@ FEEvaluationBase<dim,n_components_,Number>
 
 
 template <int dim, int n_components_, typename Number>
-template<typename VectorType>
+template <typename VectorType>
 inline
 void
 FEEvaluationBase<dim,n_components_,Number>
@@ -3348,7 +3348,7 @@ FEEvaluationBase<dim,n_components_,Number>
 
 
 template <int dim, int n_components_, typename Number>
-template<typename VectorType>
+template <typename VectorType>
 inline
 void
 FEEvaluationBase<dim,n_components_,Number>
@@ -3372,7 +3372,7 @@ FEEvaluationBase<dim,n_components_,Number>
 
 
 template <int dim, int n_components_, typename Number>
-template<typename VectorType>
+template <typename VectorType>
 inline
 void
 FEEvaluationBase<dim,n_components_,Number>
@@ -3396,7 +3396,7 @@ FEEvaluationBase<dim,n_components_,Number>
 
 
 template <int dim, int n_components_, typename Number>
-template<typename VectorType>
+template <typename VectorType>
 inline
 void
 FEEvaluationBase<dim,n_components_,Number>
index 99ce08adaf98089b89d289930fe6be8eb7a668ee..ebaf152bc73341290a2cbb58b24c397a3b9c0ff0 100644 (file)
@@ -169,7 +169,7 @@ namespace internal
      * in the use cases for this class, but be careful when using it in other
      * contexts.
      */
-    template<typename Number>
+    template <typename Number>
     struct FPArrayComparator
     {
       FPArrayComparator (const Number scaling);
index f68c9f72fb8163a9e3888bda50cd7006a08e5451..97163d1662b5523cb3614b00b6630c79349d35ff 100644 (file)
@@ -603,7 +603,7 @@ namespace internal
 
 
 
-    template<int dim, typename Number>
+    template <int dim, typename Number>
     void
     MappingInfo<dim,Number>::evaluate_on_cell (const dealii::Triangulation<dim> &tria,
                                                const std::pair<unsigned int,unsigned int> *cells,
index a95d6bb4adb09dec7711a9c7b3b1b2a5f6e20421..8a9d79b75290055c1572bdf6477d2c0fc8b6853e 100644 (file)
@@ -1761,47 +1761,47 @@ reinit(const Mapping<dim>                                    &mapping,
 // helper functions to select the blocks and template magic.
 namespace internal
 {
-  template<typename VectorStruct>
+  template <typename VectorStruct>
   bool update_ghost_values_start_block (const VectorStruct &vec,
                                         const unsigned int channel,
                                         internal::bool2type<true>);
-  template<typename VectorStruct>
+  template <typename VectorStruct>
   void reset_ghost_values_block (const VectorStruct &vec,
                                  const bool          zero_out_ghosts,
                                  internal::bool2type<true>);
-  template<typename VectorStruct>
+  template <typename VectorStruct>
   void update_ghost_values_finish_block (const VectorStruct &vec,
                                          internal::bool2type<true>);
-  template<typename VectorStruct>
+  template <typename VectorStruct>
   void compress_start_block (const VectorStruct &vec,
                              const unsigned int channel,
                              internal::bool2type<true>);
-  template<typename VectorStruct>
+  template <typename VectorStruct>
   void compress_finish_block (const VectorStruct &vec,
                               internal::bool2type<true>);
 
-  template<typename VectorStruct>
+  template <typename VectorStruct>
   bool update_ghost_values_start_block (const VectorStruct &,
                                         const unsigned int,
                                         internal::bool2type<false>)
   {
     return false;
   }
-  template<typename VectorStruct>
+  template <typename VectorStruct>
   void reset_ghost_values_block (const VectorStruct &,
                                  const bool,
                                  internal::bool2type<false>)
   {}
-  template<typename VectorStruct>
+  template <typename VectorStruct>
   void update_ghost_values_finish_block (const VectorStruct &,
                                          internal::bool2type<false>)
   {}
-  template<typename VectorStruct>
+  template <typename VectorStruct>
   void compress_start_block (const VectorStruct &,
                              const unsigned int,
                              internal::bool2type<false>)
   {}
-  template<typename VectorStruct>
+  template <typename VectorStruct>
   void compress_finish_block (const VectorStruct &,
                               internal::bool2type<false>)
   {}
@@ -1810,7 +1810,7 @@ namespace internal
 
   // returns true if the vector was in a state without ghost values before,
   // i.e., we need to zero out ghosts in the very end
-  template<typename VectorStruct>
+  template <typename VectorStruct>
   inline
   bool update_ghost_values_start (const VectorStruct &vec,
                                   const unsigned int channel = 0)
@@ -1822,7 +1822,7 @@ namespace internal
 
 
 
-  template<typename Number>
+  template <typename Number>
   inline
   bool update_ghost_values_start (const LinearAlgebra::distributed::Vector<Number> &vec,
                                   const unsigned int                  channel = 0)
@@ -1858,7 +1858,7 @@ namespace internal
 
 
 
-  template<typename VectorStruct>
+  template <typename VectorStruct>
   inline
   bool update_ghost_values_start_block (const VectorStruct &vec,
                                         const unsigned int channel,
@@ -1875,7 +1875,7 @@ namespace internal
   // if the input vector did not have ghosts imported, clear them here again
   // in order to avoid subsequent operations e.g. in linear solvers to work
   // with ghosts all the time
-  template<typename VectorStruct>
+  template <typename VectorStruct>
   inline
   void reset_ghost_values (const VectorStruct &vec,
                            const bool          zero_out_ghosts)
@@ -1886,7 +1886,7 @@ namespace internal
 
 
 
-  template<typename Number>
+  template <typename Number>
   inline
   void reset_ghost_values (const LinearAlgebra::distributed::Vector<Number> &vec,
                            const bool zero_out_ghosts)
@@ -1919,7 +1919,7 @@ namespace internal
 
 
 
-  template<typename VectorStruct>
+  template <typename VectorStruct>
   inline
   void reset_ghost_values_block (const VectorStruct &vec,
                                  const bool          zero_out_ghosts,
@@ -2091,7 +2091,7 @@ namespace internal
 
   namespace partition
   {
-    template<typename Worker>
+    template <typename Worker>
     class CellWork : public tbb::task
     {
     public:
@@ -2128,7 +2128,7 @@ namespace internal
 
 
 
-    template<typename Worker>
+    template <typename Worker>
     class PartitionWork : public tbb::task
     {
     public:
@@ -2256,7 +2256,7 @@ namespace internal
     };
 
 
-    template<typename Worker>
+    template <typename Worker>
     class PartitionWork : public tbb::task
     {
     public:
@@ -2294,7 +2294,7 @@ namespace internal
   } // end of namespace color
 
 
-  template<typename VectorStruct>
+  template <typename VectorStruct>
   class MPIComDistribute : public tbb::task
   {
   public:
@@ -2315,7 +2315,7 @@ namespace internal
 
 
 
-  template<typename VectorStruct>
+  template <typename VectorStruct>
   class MPIComCompress : public tbb::task
   {
   public:
index f1d1d199a74de4239b2fb6d7ec08f3a3e972068c..e386e1a5ad0e6b68697750bb636efdc79e1797df 100644 (file)
@@ -1655,7 +1655,7 @@ namespace MatrixFreeOperators
 
   namespace
   {
-    template<typename Number>
+    template <typename Number>
     bool
     non_negative(const VectorizedArray<Number> &n)
     {
index d3501c627f1fd97e8a842736a7760a0a58d81a43..00b933efda8697e9baeceb730cf0d4bcab0cea29 100644 (file)
@@ -130,13 +130,13 @@ namespace MeshWorker
       /**
        * Assemble the local residuals into the global residuals.
        */
-      template<class DOFINFO>
+      template <class DOFINFO>
       void assemble(const DOFINFO &info);
 
       /**
        * Assemble both local residuals into the global residuals.
        */
-      template<class DOFINFO>
+      template <class DOFINFO>
       void assemble(const DOFINFO &info1,
                     const DOFINFO &info2);
     private:
@@ -227,13 +227,13 @@ namespace MeshWorker
       /**
        * Assemble the local matrices into the global matrices.
        */
-      template<class DOFINFO>
+      template <class DOFINFO>
       void assemble(const DOFINFO &info);
 
       /**
        * Assemble all local matrices into the global matrices.
        */
-      template<class DOFINFO>
+      template <class DOFINFO>
       void assemble(const DOFINFO &info1,
                     const DOFINFO &info2);
 
@@ -351,13 +351,13 @@ namespace MeshWorker
       /**
        * Assemble the local matrices into the global matrices.
        */
-      template<class DOFINFO>
+      template <class DOFINFO>
       void assemble(const DOFINFO &info);
 
       /**
        * Assemble all local matrices into the global matrices.
        */
-      template<class DOFINFO>
+      template <class DOFINFO>
       void assemble(const DOFINFO &info1,
                     const DOFINFO &info2);
 
index 3e62ea35156ad45ca88bea823fdf600a6adee172..cfb96729bb54906f7b1c029d5f0b89e61aa934c4 100644 (file)
@@ -65,7 +65,7 @@ namespace MeshWorker
    * @ingroup MeshWorker
    * @author Guido Kanschat, 2009
    */
-  template<int dim, int spacedim = dim, typename number = double>
+  template <int dim, int spacedim = dim, typename number = double>
   class DoFInfo : public LocalResults<number>
   {
   public:
@@ -330,7 +330,7 @@ namespace MeshWorker
   }
 
 
-  template<int dim, int spacedim, typename number>
+  template <int dim, int spacedim, typename number>
   template <class DHFaceIterator>
   inline void
   DoFInfo<dim,spacedim,number>::set_face(
@@ -343,7 +343,7 @@ namespace MeshWorker
   }
 
 
-  template<int dim, int spacedim, typename number>
+  template <int dim, int spacedim, typename number>
   template <class DHCellIterator, class DHFaceIterator>
   inline void
   DoFInfo<dim,spacedim,number>::reinit(
@@ -366,7 +366,7 @@ namespace MeshWorker
   }
 
 
-  template<int dim, int spacedim, typename number>
+  template <int dim, int spacedim, typename number>
   template <class DHFaceIterator>
   inline void
   DoFInfo<dim,spacedim,number>::set_subface(
@@ -380,7 +380,7 @@ namespace MeshWorker
   }
 
 
-  template<int dim, int spacedim, typename number>
+  template <int dim, int spacedim, typename number>
   template <class DHCellIterator, class DHFaceIterator>
   inline void
   DoFInfo<dim,spacedim,number>::reinit(
@@ -404,7 +404,7 @@ namespace MeshWorker
   }
 
 
-  template<int dim, int spacedim, typename number>
+  template <int dim, int spacedim, typename number>
   inline const BlockIndices &
   DoFInfo<dim,spacedim,number>::local_indices() const
   {
index 3dfd76b8b05ecdfec0d0c0d47b8c6f4ec07a85d6..b122c9312c18cbfe7cca62829d689102fa4f877e 100644 (file)
@@ -62,13 +62,13 @@ namespace MeshWorker
       /**
        * Assemble the local values into the global vectors.
        */
-      template<class DOFINFO>
+      template <class DOFINFO>
       void assemble(const DOFINFO &info);
 
       /**
        * Assemble both local values into the global vectors.
        */
-      template<class DOFINFO>
+      template <class DOFINFO>
       void assemble(const DOFINFO &info1,
                     const DOFINFO &info2);
 
@@ -131,13 +131,13 @@ namespace MeshWorker
       /**
        * Assemble the local values into the global vectors.
        */
-      template<class DOFINFO>
+      template <class DOFINFO>
       void assemble(const DOFINFO &info);
 
       /**
        * Assemble both local values into the global vectors.
        */
-      template<class DOFINFO>
+      template <class DOFINFO>
       void assemble(const DOFINFO &info1,
                     const DOFINFO &info2);
 
index e75848a4ed72621e6cabadb57788f90ce0bed003..6aa329dee1ed00ba5be8dbae9dcdd1b228744cdd 100644 (file)
@@ -70,7 +70,7 @@ namespace MeshWorker
    * @ingroup MeshWorker
    * @author Guido Kanschat, 2009
    */
-  template<int dim, int spacedim = dim>
+  template <int dim, int spacedim = dim>
   class IntegrationInfo
   {
   private:
@@ -188,7 +188,7 @@ namespace MeshWorker
      * Use the finite element functions in #global_data and fill the vectors
      * #values, #gradients and #hessians.
      */
-    template<typename number>
+    template <typename number>
     void fill_local_data(const DoFInfo<dim, spacedim, number> &info, bool split_fevalues);
 
     /**
@@ -551,7 +551,7 @@ namespace MeshWorker
 
 //----------------------------------------------------------------------//
 
-  template<int dim, int sdim>
+  template <int dim, int sdim>
   inline
   IntegrationInfo<dim,sdim>::IntegrationInfo()
     :
@@ -562,7 +562,7 @@ namespace MeshWorker
   {}
 
 
-  template<int dim, int sdim>
+  template <int dim, int sdim>
   inline
   IntegrationInfo<dim,sdim>::IntegrationInfo(const IntegrationInfo<dim,sdim> &other)
     :
@@ -599,7 +599,7 @@ namespace MeshWorker
 
 
 
-  template<int dim, int sdim>
+  template <int dim, int sdim>
   template <class FEVALUES>
   inline void
   IntegrationInfo<dim,sdim>::initialize(
index 49338483e2c59d85ce3304e1943adb4b7c714798..111789adfae46fc73ee9194feb4fd63759f2abd8 100644 (file)
@@ -26,7 +26,7 @@ DEAL_II_NAMESPACE_OPEN
 
 namespace MeshWorker
 {
-  template<int dim, int sdim>
+  template <int dim, int sdim>
   void
   IntegrationInfo<dim,sdim>::initialize_data(
     const std::shared_ptr<VectorDataBase<dim,sdim> > &data)
@@ -75,7 +75,7 @@ namespace MeshWorker
   }
 
 
-  template<int dim, int sdim>
+  template <int dim, int sdim>
   void
   IntegrationInfo<dim,sdim>::clear()
   {
@@ -84,7 +84,7 @@ namespace MeshWorker
 
 
 
-  template<int dim, int sdim>
+  template <int dim, int sdim>
   template <typename number>
   void
   IntegrationInfo<dim,sdim>::fill_local_data(const DoFInfo<dim, sdim, number> &info, bool split_fevalues)
@@ -124,7 +124,7 @@ namespace MeshWorker
   }
 
 
-  template<int dim, int sdim>
+  template <int dim, int sdim>
   std::size_t
   IntegrationInfo<dim,sdim>::memory_consumption () const
   {
@@ -138,7 +138,7 @@ namespace MeshWorker
 
 //----------------------------------------------------------------------//
 
-  template<int dim, int sdim>
+  template <int dim, int sdim>
   IntegrationInfoBox<dim,sdim>::IntegrationInfoBox()
   {
     cell_flags = update_default;
@@ -148,7 +148,7 @@ namespace MeshWorker
   }
 
 
-  template<int dim, int sdim>
+  template <int dim, int sdim>
   void
   IntegrationInfoBox<dim,sdim>::initialize_update_flags (bool neighbor_geometry)
   {
@@ -193,7 +193,7 @@ namespace MeshWorker
   }
 
 
-  template<int dim, int sdim>
+  template <int dim, int sdim>
   std::size_t
   IntegrationInfoBox<dim,sdim>::memory_consumption () const
   {
index 7e025aae406198736ff608220763cd66c231331d..355b50abb323cf7a8aefee276f1cafb350b41000 100644 (file)
@@ -57,7 +57,7 @@ namespace internal
     return true;
   }
 
-  template<int dim, class DOFINFO, class A>
+  template <int dim, class DOFINFO, class A>
   void assemble(const MeshWorker::DoFInfoBox<dim, DOFINFO> &dinfo, A *assembler)
   {
     dinfo.assemble(*assembler);
@@ -171,7 +171,7 @@ namespace MeshWorker
    * @author Guido Kanschat
    * @date 2010
    */
-  template<class INFOBOX, class DOFINFO, int dim, int spacedim, class ITERATOR>
+  template <class INFOBOX, class DOFINFO, int dim, int spacedim, class ITERATOR>
   void cell_action(
     ITERATOR cell,
     DoFInfoBox<dim, DOFINFO> &dof_info,
@@ -379,7 +379,7 @@ namespace MeshWorker
    * @ingroup MeshWorker
    * @author Guido Kanschat, 2009
    */
-  template<int dim, int spacedim, class DOFINFO, class INFOBOX, class ASSEMBLER, class ITERATOR>
+  template <int dim, int spacedim, class DOFINFO, class INFOBOX, class ASSEMBLER, class ITERATOR>
   void loop(ITERATOR begin,
             typename identity<ITERATOR>::type end,
             DOFINFO &dinfo,
@@ -429,7 +429,7 @@ namespace MeshWorker
    * @ingroup MeshWorker
    * @author Guido Kanschat, 2009
    */
-  template<int dim, int spacedim, class ITERATOR, class ASSEMBLER>
+  template <int dim, int spacedim, class ITERATOR, class ASSEMBLER>
   void integration_loop(ITERATOR begin,
                         typename identity<ITERATOR>::type end,
                         DoFInfo<dim, spacedim> &dof_info,
index 06fae5fe745bdf8a4d4cc7ae702755567e9894d1..30eb1ae1edcbfe7f4536b6012af313ffb1891929 100644 (file)
@@ -93,13 +93,13 @@ namespace MeshWorker
       /**
        * Write the patch to the output stream.
        */
-      template<int dim>
+      template <int dim>
       void assemble(const DoFInfo<dim> &info);
 
       /**
        * @warning Not implemented yet
        */
-      template<int dim>
+      template <int dim>
       void assemble(const DoFInfo<dim> &info1,
                     const DoFInfo<dim> &info2);
 
@@ -108,7 +108,7 @@ namespace MeshWorker
        * Write the object T either to the stream #os, if initialize_stream()
        * has been called, or to @p deallog if no pointer has been set.
        */
-      template<typename T>
+      template <typename T>
       void write(const T &t) const;
 
       /**
index 0dba648c89cf3deea0b9db1a7e0ec1919166a8ff..b0cdd62c1993389fa368e7cf24611644cab27b23 100644 (file)
@@ -104,7 +104,7 @@ namespace MeshWorker
       /**
        * Assemble both local residuals into the global residuals.
        */
-      template<class DOFINFO>
+      template <class DOFINFO>
       void assemble(const DOFINFO &info1,
                     const DOFINFO &info2);
     protected:
@@ -194,14 +194,14 @@ namespace MeshWorker
        * Assemble the local matrices associated with a single cell into the
        * global matrix.
        */
-      template<class DOFINFO>
+      template <class DOFINFO>
       void assemble(const DOFINFO &info);
 
       /**
        * Assemble all local matrices associated with an interior face in the
        * info objects into the global matrix.
        */
-      template<class DOFINFO>
+      template <class DOFINFO>
       void assemble(const DOFINFO &info1,
                     const DOFINFO &info2);
     protected:
@@ -291,14 +291,14 @@ namespace MeshWorker
       /**
        * Assemble the matrix DoFInfo::M1[0] into the global matrix.
        */
-      template<class DOFINFO>
+      template <class DOFINFO>
       void assemble(const DOFINFO &info);
 
       /**
        * Assemble both local matrices in the info objects into the global
        * matrices.
        */
-      template<class DOFINFO>
+      template <class DOFINFO>
       void assemble(const DOFINFO &info1,
                     const DOFINFO &info2);
     private:
@@ -449,14 +449,14 @@ namespace MeshWorker
       /**
        * Assemble the matrix DoFInfo::M1[0] into the global matrix.
        */
-      template<class DOFINFO>
+      template <class DOFINFO>
       void assemble(const DOFINFO &info);
 
       /**
        * Assemble both local matrices in the info objects into the global
        * matrix.
        */
-      template<class DOFINFO>
+      template <class DOFINFO>
       void assemble(const DOFINFO &info1,
                     const DOFINFO &info2);
 
index d0100eba5d1016916d61e617f060e3b4fdbfa237..308c1124182c890343f026c51070a024e1a85aef 100644 (file)
@@ -24,7 +24,7 @@
 
 DEAL_II_NAMESPACE_OPEN
 
-template<int,int> class FEValuesBase;
+template <int,int> class FEValuesBase;
 
 namespace MeshWorker
 {
index 0fc198aac069bf7dd0973c7e2a0268668107d497..41d4afadd041eefbb795dc04906a18219209acbc 100644 (file)
@@ -33,7 +33,7 @@ DEAL_II_NAMESPACE_OPEN
  *
  * @author Denis Davydov, 2016.
  */
-template<class VectorType = Vector<double> >
+template <class VectorType = Vector<double> >
 class MGCoarseGridApplySmoother :  public MGCoarseGridBase<VectorType>
 {
 public:
@@ -85,7 +85,7 @@ private:
  *
  * @author Guido Kanschat, 1999, Ralf Hartmann, 2002.
  */
-template<typename SolverType, class VectorType = Vector<double> >
+template <typename SolverType, class VectorType = Vector<double> >
 class MGCoarseGridLACIteration :  public MGCoarseGridBase<VectorType>
 {
 public:
@@ -98,7 +98,7 @@ public:
    * Constructor. Store solver, matrix and preconditioning method for later
    * use.
    */
-  template<typename MatrixType, typename PreconditionerType>
+  template <typename MatrixType, typename PreconditionerType>
   MGCoarseGridLACIteration (SolverType &,
                             const MatrixType &,
                             const PreconditionerType &);
@@ -111,7 +111,7 @@ public:
   /**
    * Initialize new data.
    */
-  template<typename MatrixType, typename PreconditionerType>
+  template <typename MatrixType, typename PreconditionerType>
   void initialize (SolverType &,
                    const MatrixType &,
                    const PreconditionerType &);
@@ -162,10 +162,10 @@ private:
  * This class provides a wrapper for a deal.II iterative solver with a given
  * matrix and preconditioner as a coarse grid operator.
  */
-template<class VectorType,
-         class SolverType,
-         class MatrixType,
-         class PreconditionerType>
+template <class VectorType,
+          class SolverType,
+          class MatrixType,
+          class PreconditionerType>
 class MGCoarseGridIterativeSolver :  public MGCoarseGridBase<VectorType>
 {
 public:
@@ -243,7 +243,7 @@ private:
  *
  * @author Guido Kanschat, 2003, 2012
  */
-template<typename number = double, class VectorType = Vector<number> >
+template <typename number = double, class VectorType = Vector<number> >
 class MGCoarseGridHouseholder : public MGCoarseGridBase<VectorType>
 {
 public:
@@ -276,7 +276,7 @@ private:
  *
  * @author Guido Kanschat, 2003, 2012
  */
-template<typename number = double, class VectorType = Vector<number> >
+template <typename number = double, class VectorType = Vector<number> >
 class MGCoarseGridSVD : public MGCoarseGridBase<VectorType>
 {
 public:
@@ -311,13 +311,13 @@ private:
 
 #ifndef DOXYGEN
 /* ------------------ Functions for MGCoarseGridApplySmoother -----------*/
-template<class VectorType>
+template <class VectorType>
 MGCoarseGridApplySmoother<VectorType>::MGCoarseGridApplySmoother ()
   : coarse_smooth(nullptr)
 {
 }
 
-template<class VectorType>
+template <class VectorType>
 MGCoarseGridApplySmoother<VectorType>::MGCoarseGridApplySmoother (const MGSmootherBase<VectorType> &coarse_smooth)
   : coarse_smooth(nullptr)
 {
@@ -325,7 +325,7 @@ MGCoarseGridApplySmoother<VectorType>::MGCoarseGridApplySmoother (const MGSmooth
 }
 
 
-template<class VectorType>
+template <class VectorType>
 void
 MGCoarseGridApplySmoother<VectorType>::initialize (const MGSmootherBase<VectorType> &coarse_smooth_)
 {
@@ -335,7 +335,7 @@ MGCoarseGridApplySmoother<VectorType>::initialize (const MGSmootherBase<VectorTy
 }
 
 
-template<class VectorType>
+template <class VectorType>
 void
 MGCoarseGridApplySmoother<VectorType>::clear()
 {
@@ -343,7 +343,7 @@ MGCoarseGridApplySmoother<VectorType>::clear()
 }
 
 
-template<class VectorType>
+template <class VectorType>
 void
 MGCoarseGridApplySmoother<VectorType>::operator() (const unsigned int level,
                                                    VectorType         &dst,
@@ -356,7 +356,7 @@ MGCoarseGridApplySmoother<VectorType>::operator() (const unsigned int level,
 
 DEAL_II_DISABLE_EXTRA_DIAGNOSTICS
 
-template<typename SolverType, class VectorType>
+template <typename SolverType, class VectorType>
 MGCoarseGridLACIteration<SolverType, VectorType>
 ::MGCoarseGridLACIteration()
   :
@@ -366,8 +366,8 @@ MGCoarseGridLACIteration<SolverType, VectorType>
 {}
 
 
-template<typename SolverType, class VectorType>
-template<typename MatrixType, typename PreconditionerType>
+template <typename SolverType, class VectorType>
+template <typename MatrixType, typename PreconditionerType>
 MGCoarseGridLACIteration<SolverType, VectorType>
 ::MGCoarseGridLACIteration (SolverType               &s,
                             const MatrixType         &m,
@@ -380,7 +380,7 @@ MGCoarseGridLACIteration<SolverType, VectorType>
 }
 
 
-template<typename SolverType, class VectorType>
+template <typename SolverType, class VectorType>
 MGCoarseGridLACIteration<SolverType, VectorType>
 ::~MGCoarseGridLACIteration()
 {
@@ -388,8 +388,8 @@ MGCoarseGridLACIteration<SolverType, VectorType>
 }
 
 
-template<typename SolverType, class VectorType>
-template<typename MatrixType, typename PreconditionerType>
+template <typename SolverType, class VectorType>
+template <typename MatrixType, typename PreconditionerType>
 void
 MGCoarseGridLACIteration<SolverType, VectorType>
 ::initialize (SolverType               &s,
@@ -406,7 +406,7 @@ MGCoarseGridLACIteration<SolverType, VectorType>
 }
 
 
-template<typename SolverType, class VectorType>
+template <typename SolverType, class VectorType>
 void
 MGCoarseGridLACIteration<SolverType, VectorType>
 ::clear()
@@ -421,7 +421,7 @@ MGCoarseGridLACIteration<SolverType, VectorType>
 }
 
 
-template<typename SolverType, class VectorType>
+template <typename SolverType, class VectorType>
 void
 MGCoarseGridLACIteration<SolverType, VectorType>
 ::operator() (const unsigned int /* level */,
@@ -435,8 +435,8 @@ MGCoarseGridLACIteration<SolverType, VectorType>
 }
 
 
-template<typename SolverType, class VectorType>
-template<typename MatrixType>
+template <typename SolverType, class VectorType>
+template <typename MatrixType>
 void
 MGCoarseGridLACIteration<SolverType, VectorType>
 ::set_matrix(const MatrixType &m)
@@ -534,7 +534,7 @@ MGCoarseGridIterativeSolver<VectorType, SolverType, MatrixType, PreconditionerTy
 
 /* ------------------ Functions for MGCoarseGridHouseholder ------------ */
 
-template<typename number, class VectorType>
+template <typename number, class VectorType>
 MGCoarseGridHouseholder<number, VectorType>::MGCoarseGridHouseholder
 (const FullMatrix<number> *A)
 {
@@ -543,7 +543,7 @@ MGCoarseGridHouseholder<number, VectorType>::MGCoarseGridHouseholder
 
 
 
-template<typename number, class VectorType>
+template <typename number, class VectorType>
 void
 MGCoarseGridHouseholder<number, VectorType>::initialize(const FullMatrix<number> &A)
 {
@@ -552,7 +552,7 @@ MGCoarseGridHouseholder<number, VectorType>::initialize(const FullMatrix<number>
 
 
 
-template<typename number, class VectorType>
+template <typename number, class VectorType>
 void
 MGCoarseGridHouseholder<number, VectorType>::operator() (const unsigned int /*level*/,
                                                          VectorType         &dst,
@@ -565,7 +565,7 @@ MGCoarseGridHouseholder<number, VectorType>::operator() (const unsigned int /*le
 
 
 
-template<typename number, class VectorType>
+template <typename number, class VectorType>
 void
 MGCoarseGridSVD<number, VectorType>::initialize (const FullMatrix<number> &A,
                                                  double                    threshold)
@@ -576,7 +576,7 @@ MGCoarseGridSVD<number, VectorType>::initialize (const FullMatrix<number> &A,
 }
 
 
-template<typename number, class VectorType>
+template <typename number, class VectorType>
 void
 MGCoarseGridSVD<number, VectorType>::operator() (
   const unsigned int /*level*/,
@@ -587,7 +587,7 @@ MGCoarseGridSVD<number, VectorType>::operator() (
 }
 
 
-template<typename number, class VectorType>
+template <typename number, class VectorType>
 void
 MGCoarseGridSVD<number, VectorType>::log() const
 {
index 0c00827513ee17457ada4f04d02dd7091dc9ca2d..fbb7bd685d79f44ee96c3414360ecb3cfa4709db 100644 (file)
@@ -177,7 +177,7 @@ namespace mg
    * @author Guido Kanschat,
    * @date 2003, 2009, 2010
    */
-  template<class RelaxationType, typename VectorType>
+  template <class RelaxationType, typename VectorType>
   class SmootherRelaxation : public MGLevelObject<RelaxationType>, public MGSmoother<VectorType>
   {
   public:
@@ -282,7 +282,7 @@ namespace mg
  *
  * @author Guido Kanschat, 2003
  */
-template<typename MatrixType, class RelaxationType, typename VectorType>
+template <typename MatrixType, class RelaxationType, typename VectorType>
 class MGSmootherRelaxation : public MGSmoother<VectorType>
 {
 public:
@@ -431,7 +431,7 @@ private:
  *
  * @author Guido Kanschat, 2009
  */
-template<typename MatrixType, typename PreconditionerType, typename VectorType>
+template <typename MatrixType, typename PreconditionerType, typename VectorType>
 class MGSmootherPrecondition : public MGSmoother<VectorType>
 {
 public:
index 677ed652dfa5786a0c51d0bf3af2571dd55328fd..7e57874db7717575c6fa6554c0709ccb41673ae6 100644 (file)
@@ -214,7 +214,7 @@ public:
    * This function is a front-end for the same function in
    * MGTransferBlockBase.
    */
-  template<int dim, int spacedim>
+  template <int dim, int spacedim>
   void build_matrices (const DoFHandler<dim,spacedim> &dof,
                        const DoFHandler<dim,spacedim> &mg_dof,
                        const std::vector<bool> &selected);
@@ -336,7 +336,7 @@ public:
    * @arg mg_selected: Number of the component for which the transfer matrices
    * should be built.
    */
-  template<int dim, int spacedim>
+  template <int dim, int spacedim>
   void build_matrices (const DoFHandler<dim,spacedim> &dof,
                        const DoFHandler<dim,spacedim> &mg_dof,
                        unsigned int selected);
index 8f072ff8cd44ae1d79a65b874297aa9039b01052..a8e13d7b256afacbbe9c23c4dd2426adf1329e44 100644 (file)
@@ -338,7 +338,7 @@ private:
    */
   unsigned int debug;
 
-  template<int dim, class OtherVectorType, class TRANSFER> friend class PreconditionMG;
+  template <int dim, class OtherVectorType, class TRANSFER> friend class PreconditionMG;
 };
 
 
@@ -354,7 +354,7 @@ private:
  *
  * @author Guido Kanschat, 1999, 2000, 2001, 2002
  */
-template<int dim, typename VectorType, class TRANSFER>
+template <int dim, typename VectorType, class TRANSFER>
 class PreconditionMG : public Subscriptor
 {
 public:
@@ -377,7 +377,7 @@ public:
    *
    * This is the operator used by LAC iterative solvers.
    */
-  template<class OtherVectorType>
+  template <class OtherVectorType>
   void vmult (OtherVectorType       &dst,
               const OtherVectorType &src) const;
 
@@ -385,7 +385,7 @@ public:
    * Preconditioning operator. Calls the @p vcycle function of the @p MG
    * object passed to the constructor.
    */
-  template<class OtherVectorType>
+  template <class OtherVectorType>
   void vmult_add (OtherVectorType       &dst,
                   const OtherVectorType &src) const;
 
@@ -394,7 +394,7 @@ public:
    *
    * Not implemented, but the definition may be needed.
    */
-  template<class OtherVectorType>
+  template <class OtherVectorType>
   void Tvmult (OtherVectorType       &dst,
                const OtherVectorType &src) const;
 
@@ -403,7 +403,7 @@ public:
    *
    * Not implemented, but the definition may be needed.
    */
-  template<class OtherVectorType>
+  template <class OtherVectorType>
   void Tvmult_add (OtherVectorType       &dst,
                    const OtherVectorType &src) const;
 
@@ -533,7 +533,7 @@ Multigrid<VectorType>::get_minlevel () const
 /* --------------------------- inline functions --------------------- */
 
 
-template<int dim, typename VectorType, class TRANSFER>
+template <int dim, typename VectorType, class TRANSFER>
 PreconditionMG<dim, VectorType, TRANSFER>
 ::PreconditionMG(const DoFHandler<dim>  &dof_handler,
                  Multigrid<VectorType>  &mg,
@@ -544,15 +544,15 @@ PreconditionMG<dim, VectorType, TRANSFER>
   transfer(&transfer)
 {}
 
-template<int dim, typename VectorType, class TRANSFER>
+template <int dim, typename VectorType, class TRANSFER>
 inline bool
 PreconditionMG<dim, VectorType, TRANSFER>::empty () const
 {
   return false;
 }
 
-template<int dim, typename VectorType, class TRANSFER>
-template<class OtherVectorType>
+template <int dim, typename VectorType, class TRANSFER>
+template <class OtherVectorType>
 void
 PreconditionMG<dim, VectorType, TRANSFER>::vmult
 (OtherVectorType       &dst,
@@ -569,7 +569,7 @@ PreconditionMG<dim, VectorType, TRANSFER>::vmult
 }
 
 
-template<int dim, typename VectorType, class TRANSFER>
+template <int dim, typename VectorType, class TRANSFER>
 IndexSet
 PreconditionMG<dim, VectorType, TRANSFER>::locally_owned_range_indices() const
 {
@@ -577,7 +577,7 @@ PreconditionMG<dim, VectorType, TRANSFER>::locally_owned_range_indices() const
 }
 
 
-template<int dim, typename VectorType, class TRANSFER>
+template <int dim, typename VectorType, class TRANSFER>
 IndexSet
 PreconditionMG<dim, VectorType, TRANSFER>::locally_owned_domain_indices() const
 {
@@ -585,7 +585,7 @@ PreconditionMG<dim, VectorType, TRANSFER>::locally_owned_domain_indices() const
 }
 
 
-template<int dim, typename VectorType, class TRANSFER>
+template <int dim, typename VectorType, class TRANSFER>
 MPI_Comm
 PreconditionMG<dim, VectorType, TRANSFER>::get_mpi_communicator() const
 {
@@ -598,8 +598,8 @@ PreconditionMG<dim, VectorType, TRANSFER>::get_mpi_communicator() const
 }
 
 
-template<int dim, typename VectorType, class TRANSFER>
-template<class OtherVectorType>
+template <int dim, typename VectorType, class TRANSFER>
+template <class OtherVectorType>
 void
 PreconditionMG<dim, VectorType, TRANSFER>::vmult_add
 (OtherVectorType       &dst,
@@ -615,8 +615,8 @@ PreconditionMG<dim, VectorType, TRANSFER>::vmult_add
 }
 
 
-template<int dim, typename VectorType, class TRANSFER>
-template<class OtherVectorType>
+template <int dim, typename VectorType, class TRANSFER>
+template <class OtherVectorType>
 void
 PreconditionMG<dim, VectorType, TRANSFER>::Tvmult
 (OtherVectorType &,
@@ -626,8 +626,8 @@ PreconditionMG<dim, VectorType, TRANSFER>::Tvmult
 }
 
 
-template<int dim, typename VectorType, class TRANSFER>
-template<class OtherVectorType>
+template <int dim, typename VectorType, class TRANSFER>
+template <class OtherVectorType>
 void
 PreconditionMG<dim, VectorType, TRANSFER>::Tvmult_add
 (OtherVectorType &,
index 3ed3c435d795543ede53b2bce663916e56691430..62ee0a1c0720589776b0d363a026006053bd2975 100644 (file)
@@ -49,7 +49,7 @@ DEAL_II_NAMESPACE_OPEN
  * @ingroup output
  * @author Guido Kanschat, 2000
  */
-template<int dim, typename SolverType, class VectorType = Vector<double> >
+template <int dim, typename SolverType, class VectorType = Vector<double> >
 class DoFPrintSolverStep : public SolverType
 {
 public:
@@ -87,7 +87,7 @@ private:
 
 /* ----------------------- template functions --------------- */
 
-template<int dim, typename SolverType, class VectorType>
+template <int dim, typename SolverType, class VectorType>
 DoFPrintSolverStep<dim, SolverType, VectorType>::DoFPrintSolverStep
 (SolverControl            &control,
  VectorMemory<VectorType> &mem,
@@ -99,7 +99,7 @@ DoFPrintSolverStep<dim, SolverType, VectorType>::DoFPrintSolverStep
 {}
 
 
-template<int dim, typename SolverType, class VectorType>
+template <int dim, typename SolverType, class VectorType>
 void
 DoFPrintSolverStep<dim, SolverType, VectorType>::print_vectors
 (const unsigned int  step,
index 7d9d3b87737a3da7d45a41b465171a58bfe4753e..a2377cbd4a4941b60065dd8cb26530d62696f483 100644 (file)
@@ -37,9 +37,9 @@ DEAL_II_NAMESPACE_OPEN
 template <int dim> class Quadrature;
 
 
-template<typename number> class Vector;
-template<typename number> class FullMatrix;
-template<typename number> class SparseMatrix;
+template <typename number> class Vector;
+template <typename number> class FullMatrix;
+template <typename number> class SparseMatrix;
 
 template <typename number> class BlockSparseMatrix;
 template <typename Number> class BlockVector;
index b0549b9ec17e13f3a5943169dbedc9626d29f943..a0f976eac19511f6822c7ddb44b2231740ec05fe 100644 (file)
@@ -288,9 +288,9 @@ DEAL_II_NAMESPACE_OPEN
  * @author Ralf Hartmann, 1999, Oliver Kayser-Herold and Wolfgang Bangerth,
  * 2006, Wolfgang Bangerth 2014
  */
-template<int dim,
-         typename VectorType = Vector<double>,
-         typename DoFHandlerType = DoFHandler<dim> >
+template <int dim,
+          typename VectorType = Vector<double>,
+          typename DoFHandlerType = DoFHandler<dim> >
 class SolutionTransfer
 {
 #ifndef DEAL_II_MSVC
index 61f9611a954f83d80e70f3fbab62b5af6b13f920..7f37701f316675a27d9305f08b10c3883af3268e 100644 (file)
@@ -1598,7 +1598,7 @@ namespace VectorTools
    * @see
    * @ref GlossBoundaryIndicator "Glossary entry on boundary indicators"
    */
-  template<int dim>
+  template <int dim>
   void project_boundary_values_div_conforming
   (const DoFHandler<dim>      &dof_handler,
    const unsigned int          first_vector_component,
@@ -1615,7 +1615,7 @@ namespace VectorTools
    * @see
    * @ref GlossBoundaryIndicator "Glossary entry on boundary indicators"
    */
-  template<int dim>
+  template <int dim>
   void project_boundary_values_div_conforming
   (const hp::DoFHandler<dim>             &dof_handler,
    const unsigned int                     first_vector_component,
index e1ae90362bb61d0bf51004aec7415ca87f966f70..97843c82798a085e2c5c1556771dad0909279d57 100644 (file)
@@ -368,8 +368,8 @@ namespace VectorTools
   }
 
 
-  template<int dim, int spacedim, typename VectorType,
-           template <int,int> class DoFHandlerType>
+  template <int dim, int spacedim, typename VectorType,
+            template <int,int> class DoFHandlerType>
   void
   interpolate_based_on_material_id
   (const Mapping<dim,spacedim>        &mapping,
@@ -3539,7 +3539,7 @@ namespace VectorTools
     // This function computes the
     // projection of the boundary
     // function on edges for 3D.
-    template<typename cell_iterator>
+    template <typename cell_iterator>
     void
     compute_edge_projection (const cell_iterator &cell,
                              const unsigned int   face,
@@ -3685,7 +3685,7 @@ namespace VectorTools
     // dummy implementation of above
     // function for all other
     // dimensions
-    template<int dim, typename cell_iterator>
+    template <int dim, typename cell_iterator>
     void
     compute_edge_projection (const cell_iterator &,
                              const unsigned int,
@@ -3703,7 +3703,7 @@ namespace VectorTools
     // projection of the boundary
     // function on the interior of
     // faces.
-    template<int dim, typename cell_iterator>
+    template <int dim, typename cell_iterator>
     void
     compute_face_projection_curl_conforming (const cell_iterator &cell,
                                              const unsigned int   face,
@@ -4494,7 +4494,7 @@ namespace VectorTools
 
   namespace internals
   {
-    template<typename cell_iterator>
+    template <typename cell_iterator>
     void
     compute_edge_projection_l2 (const cell_iterator &cell,
                                 const unsigned int   face,
@@ -4722,7 +4722,7 @@ namespace VectorTools
     }
 
 
-    template<int dim, typename cell_iterator>
+    template <int dim, typename cell_iterator>
     void
     compute_edge_projection_l2 (const cell_iterator &,
                                 const unsigned int,
@@ -4738,7 +4738,7 @@ namespace VectorTools
       Assert (false, ExcInternalError ());
     }
 
-    template<int dim, typename cell_iterator>
+    template <int dim, typename cell_iterator>
     void
     compute_face_projection_curl_conforming_l2
     (const cell_iterator   &cell,
@@ -5471,7 +5471,7 @@ namespace VectorTools
     }
 
     // dummy implementation of above function for all other dimensions
-    template<int dim, typename cell_iterator>
+    template <int dim, typename cell_iterator>
     void
     compute_face_projection_div_conforming (const cell_iterator &,
                                             const unsigned int,
@@ -5486,7 +5486,7 @@ namespace VectorTools
 
     // This function computes the projection of the boundary function on the
     // boundary in 3d.
-    template<typename cell_iterator>
+    template <typename cell_iterator>
     void
     compute_face_projection_div_conforming
     (const cell_iterator                       &cell,
@@ -5565,7 +5565,7 @@ namespace VectorTools
     // dummy implementation of above
     // function for all other
     // dimensions
-    template<int dim, typename cell_iterator>
+    template <int dim, typename cell_iterator>
     void
     compute_face_projection_div_conforming (const cell_iterator &,
                                             const unsigned int,
@@ -6779,13 +6779,13 @@ namespace VectorTools
 
     namespace
     {
-      template<typename number>
+      template <typename number>
       double mean_to_double(const number &mean_value)
       {
         return mean_value;
       }
 
-      template<typename number>
+      template <typename number>
       double mean_to_double(const std::complex<number> &mean_value)
       {
         // we need to return double as a norm, but mean value is a complex
@@ -7918,8 +7918,8 @@ namespace VectorTools
   }
 
 
-  template<int dim, int spacedim, template <int,int> class DoFHandlerType,
-           typename VectorType>
+  template <int dim, int spacedim, template <int,int> class DoFHandlerType,
+            typename VectorType>
   void get_position_vector(const DoFHandlerType<dim,spacedim> &dh,
                            VectorType                         &vector,
                            const ComponentMask                &mask)
index 93ab0ab6e8d7fc19b6c3c5af7367812f663890d2..246fd36d03f78505e0c00be84cd31fcfa512d063 100644 (file)
@@ -57,7 +57,7 @@ namespace Physics
        *
        * @param[in] angle The rotation angle (about the z-axis) in radians
        */
-      template<typename Number>
+      template <typename Number>
       Tensor<2,2,Number>
       rotation_matrix_2d (const Number &angle);
 
@@ -90,7 +90,7 @@ namespace Physics
        * @param[in] axis  A unit vector that defines the axis of rotation
        * @param[in] angle The rotation angle in radians
        */
-      template<typename Number>
+      template <typename Number>
       Tensor<2,3,Number>
       rotation_matrix_3d (const Point<3,Number> &axis,
                           const Number          &angle);
@@ -780,7 +780,7 @@ namespace Physics
      *
      * @dealiiHolzapfelA{75,2.55} @dealiiWriggersA{23,3.11}
      */
-    template<int dim, typename Number>
+    template <int dim, typename Number>
     Tensor<1,dim,Number>
     nansons_formula (const Tensor<1,dim,Number> &N,
                      const Tensor<2,dim,Number> &F);
@@ -908,7 +908,7 @@ namespace internal
 
 
 
-template<typename Number>
+template <typename Number>
 Tensor<2,2,Number>
 Physics::Transformations::Rotations::rotation_matrix_2d (const Number &angle)
 {
@@ -925,7 +925,7 @@ Physics::Transformations::Rotations::rotation_matrix_2d (const Number &angle)
 
 
 
-template<typename Number>
+template <typename Number>
 Tensor<2,3,Number>
 Physics::Transformations::Rotations::rotation_matrix_3d (const Point<3,Number> &axis,
                                                          const Number          &angle)
@@ -1287,7 +1287,7 @@ Physics::Transformations::Piola::pull_back (const SymmetricTensor<4,dim,Number>
 
 
 
-template<int dim, typename Number>
+template <int dim, typename Number>
 inline Tensor<1,dim,Number>
 Physics::Transformations::nansons_formula (const Tensor<1,dim,Number> &N,
                                            const Tensor<2,dim,Number> &F)
index 36cc260b59c3444fd9f1fc61aa9719ea1cb84bd8..4d2a2af3372254fe6fbc796cf032c0afea17a305 100644 (file)
@@ -459,7 +459,7 @@ namespace DataOutBase
 // DataOutFilter class member functions
 //----------------------------------------------------------------------//
 
-template<int dim>
+template <int dim>
 void DataOutBase::DataOutFilter::write_point(const unsigned int &index, const Point<dim> &p)
 {
   Map3DPoint::const_iterator  it;
@@ -514,7 +514,7 @@ void DataOutBase::DataOutFilter::fill_cell_data(const unsigned int &local_node_o
     }
 }
 
-template<int dim>
+template <int dim>
 void
 DataOutBase::DataOutFilter::write_cell(
   unsigned int index,
@@ -679,7 +679,7 @@ namespace
 
 
 
-  template<int dim, int spacedim>
+  template <int dim, int spacedim>
   static
   void
   compute_sizes(const std::vector<DataOutBase::Patch<dim, spacedim> > &patches,
@@ -701,7 +701,7 @@ namespace
    *
    * @ingroup output
    */
-  template<typename FlagsType>
+  template <typename FlagsType>
   class StreamBase
   {
   public:
@@ -836,7 +836,7 @@ namespace
      * some output formats require
      * this number to be printed.
      */
-    template<typename data>
+    template <typename data>
     void write_dataset (const unsigned int       index,
                         const std::vector<data> &values);
   };
@@ -956,7 +956,7 @@ namespace
      * some output formats require
      * this number to be printed.
      */
-    template<typename data>
+    template <typename data>
     void write_dataset (const unsigned int       index,
                         const std::vector<data> &values);
   };
@@ -1071,7 +1071,7 @@ namespace
   {}
 
 
-  template<int dim>
+  template <int dim>
   void
   DXStream::write_point (const unsigned int,
                          const Point<dim> &p)
@@ -1094,7 +1094,7 @@ namespace
 
 
 
-  template<int dim>
+  template <int dim>
   void
   DXStream::write_cell (unsigned int,
                         unsigned int start,
@@ -1134,7 +1134,7 @@ namespace
 
 
 
-  template<typename data>
+  template <typename data>
   inline
   void
   DXStream::write_dataset (const unsigned int,
@@ -1164,7 +1164,7 @@ namespace
   {}
 
 
-  template<int dim>
+  template <int dim>
   void
   GmvStream::write_point (const unsigned int,
                           const Point<dim> &p)
@@ -1176,7 +1176,7 @@ namespace
 
 
 
-  template<int dim>
+  template <int dim>
   void
   GmvStream::write_cell (unsigned int,
                          unsigned int s,
@@ -1215,7 +1215,7 @@ namespace
   {}
 
 
-  template<int dim>
+  template <int dim>
   void
   TecplotStream::write_point (const unsigned int,
                               const Point<dim> &p)
@@ -1227,7 +1227,7 @@ namespace
 
 
 
-  template<int dim>
+  template <int dim>
   void
   TecplotStream::write_cell (unsigned int,
                              unsigned int s,
@@ -1263,7 +1263,7 @@ namespace
   {}
 
 
-  template<int dim>
+  template <int dim>
   void
   UcdStream::write_point (const unsigned int index,
                           const Point<dim> &p)
@@ -1281,7 +1281,7 @@ namespace
 
 
 
-  template<int dim>
+  template <int dim>
   void
   UcdStream::write_cell (unsigned int index,
                          unsigned int start,
@@ -1319,7 +1319,7 @@ namespace
 
 
 
-  template<typename data>
+  template <typename data>
   inline
   void
   UcdStream::write_dataset (const unsigned int index,
@@ -1342,7 +1342,7 @@ namespace
   {}
 
 
-  template<int dim>
+  template <int dim>
   void
   VtkStream::write_point (const unsigned int,
                           const Point<dim> &p)
@@ -1357,7 +1357,7 @@ namespace
 
 
 
-  template<int dim>
+  template <int dim>
   void
   VtkStream::write_cell (unsigned int,
                          unsigned int start,
@@ -1392,7 +1392,7 @@ namespace
   {}
 
 
-  template<int dim>
+  template <int dim>
   void
   VtuStream::write_point (const unsigned int,
                           const Point<dim> &p)
@@ -1429,7 +1429,7 @@ namespace
   }
 
 
-  template<int dim>
+  template <int dim>
   void
   VtuStream::write_cell (unsigned int,
                          unsigned int start,
index 7b43271d0046a213976225fca84c036c1a5c88f2..6a91d6daec0e244061cd865fbfa995d472fc466c 100644 (file)
@@ -27,7 +27,7 @@ DEAL_II_NAMESPACE_OPEN
 namespace Functions
 {
 
-  template<int dim>
+  template <int dim>
   FlowFunction<dim>::FlowFunction()
     :
     Function<dim>(dim+1),
@@ -37,12 +37,12 @@ namespace Functions
   {}
 
 
-  template<int dim>
+  template <int dim>
   FlowFunction<dim>::~FlowFunction()
   {}
 
 
-  template<int dim>
+  template <int dim>
   void
   FlowFunction<dim>::pressure_adjustment(double p)
   {
@@ -50,7 +50,7 @@ namespace Functions
   }
 
 
-  template<int dim>
+  template <int dim>
   void FlowFunction<dim>::vector_value_list (
     const std::vector<Point<dim> > &points,
     std::vector<Vector<double> >   &values) const
@@ -75,7 +75,7 @@ namespace Functions
   }
 
 
-  template<int dim>
+  template <int dim>
   void FlowFunction<dim>::vector_value (
     const Point<dim> &point,
     Vector<double> &value) const
@@ -99,7 +99,7 @@ namespace Functions
   }
 
 
-  template<int dim>
+  template <int dim>
   double FlowFunction<dim>::value (
     const Point<dim> &point,
     const unsigned int comp) const
@@ -121,7 +121,7 @@ namespace Functions
   }
 
 
-  template<int dim>
+  template <int dim>
   void FlowFunction<dim>::vector_gradient_list (
     const std::vector<Point<dim> > &points,
     std::vector<std::vector<Tensor<1,dim> > > &values) const
@@ -146,7 +146,7 @@ namespace Functions
   }
 
 
-  template<int dim>
+  template <int dim>
   void FlowFunction<dim>::vector_laplacian_list (
     const std::vector<Point<dim> > &points,
     std::vector<Vector<double> > &values) const
@@ -171,7 +171,7 @@ namespace Functions
   }
 
 
-  template<int dim>
+  template <int dim>
   std::size_t
   FlowFunction<dim>::memory_consumption () const
   {
@@ -182,7 +182,7 @@ namespace Functions
 
 //----------------------------------------------------------------------//
 
-  template<int dim>
+  template <int dim>
   PoisseuilleFlow<dim>::PoisseuilleFlow(const double r,
                                         const double Re)
     :
@@ -192,12 +192,12 @@ namespace Functions
   }
 
 
-  template<int dim>
+  template <int dim>
   PoisseuilleFlow<dim>::~PoisseuilleFlow()
   {}
 
 
-  template<int dim>
+  template <int dim>
   void PoisseuilleFlow<dim>::vector_values (
     const std::vector<Point<dim> > &points,
     std::vector<std::vector<double> > &values) const
@@ -232,7 +232,7 @@ namespace Functions
 
 
 
-  template<int dim>
+  template <int dim>
   void PoisseuilleFlow<dim>::vector_gradients (
     const std::vector<Point<dim> > &points,
     std::vector<std::vector<Tensor<1,dim> > > &values) const
@@ -263,7 +263,7 @@ namespace Functions
 
 
 
-  template<int dim>
+  template <int dim>
   void PoisseuilleFlow<dim>::vector_laplacians (
     const std::vector<Point<dim> > &points,
     std::vector<std::vector<double> > &values) const
@@ -281,19 +281,19 @@ namespace Functions
 
 //----------------------------------------------------------------------//
 
-  template<int dim>
+  template <int dim>
   StokesCosine<dim>::StokesCosine(const double nu, const double r)
     :
     viscosity(nu), reaction(r)
   {}
 
 
-  template<int dim>
+  template <int dim>
   StokesCosine<dim>::~StokesCosine()
   {}
 
 
-  template<int dim>
+  template <int dim>
   void
   StokesCosine<dim>::set_parameters(const double nu, const double r)
   {
@@ -302,7 +302,7 @@ namespace Functions
   }
 
 
-  template<int dim>
+  template <int dim>
   void StokesCosine<dim>::vector_values (
     const std::vector<Point<dim> > &points,
     std::vector<std::vector<double> > &values) const
@@ -349,7 +349,7 @@ namespace Functions
 
 
 
-  template<int dim>
+  template <int dim>
   void StokesCosine<dim>::vector_gradients (
     const std::vector<Point<dim> > &points,
     std::vector<std::vector<Tensor<1,dim> > > &values) const
@@ -413,7 +413,7 @@ namespace Functions
 
 
 
-  template<int dim>
+  template <int dim>
   void StokesCosine<dim>::vector_laplacians (
     const std::vector<Point<dim> > &points,
     std::vector<std::vector<double> > &values) const
index 804cfbf8170683e95e6f26e7881b41c46402c29a..41d0eedb02382d56df2f90d1096d95154998327d 100644 (file)
@@ -29,7 +29,7 @@ namespace Functions
 {
 
 
-  template<int dim>
+  template <int dim>
   double
   SquareFunction<dim>::value (const Point<dim>   &p,
                               const unsigned int) const
@@ -38,7 +38,7 @@ namespace Functions
   }
 
 
-  template<int dim>
+  template <int dim>
   void
   SquareFunction<dim>::vector_value (const Point<dim>   &p,
                                      Vector<double>     &values) const
@@ -48,7 +48,7 @@ namespace Functions
   }
 
 
-  template<int dim>
+  template <int dim>
   void
   SquareFunction<dim>::value_list (const std::vector<Point<dim> > &points,
                                    std::vector<double>            &values,
@@ -65,7 +65,7 @@ namespace Functions
   }
 
 
-  template<int dim>
+  template <int dim>
   double
   SquareFunction<dim>::laplacian (const Point<dim> &,
                                   const unsigned int) const
@@ -74,7 +74,7 @@ namespace Functions
   }
 
 
-  template<int dim>
+  template <int dim>
   void
   SquareFunction<dim>::laplacian_list (const std::vector<Point<dim> > &points,
                                        std::vector<double>            &values,
@@ -89,7 +89,7 @@ namespace Functions
 
 
 
-  template<int dim>
+  template <int dim>
   Tensor<1,dim>
   SquareFunction<dim>::gradient (const Point<dim>   &p,
                                  const unsigned int) const
@@ -98,7 +98,7 @@ namespace Functions
   }
 
 
-  template<int dim>
+  template <int dim>
   void
   SquareFunction<dim>::vector_gradient (
     const Point<dim> &p,
@@ -110,7 +110,7 @@ namespace Functions
 
 
 
-  template<int dim>
+  template <int dim>
   void
   SquareFunction<dim>::gradient_list (const std::vector<Point<dim> > &points,
                                       std::vector<Tensor<1,dim> >    &gradients,
@@ -127,7 +127,7 @@ namespace Functions
 //////////////////////////////////////////////////////////////////////
 
 
-  template<int dim>
+  template <int dim>
   double
   Q1WedgeFunction<dim>::value (const Point<dim>   &p,
                                const unsigned int) const
@@ -138,7 +138,7 @@ namespace Functions
 
 
 
-  template<int dim>
+  template <int dim>
   void
   Q1WedgeFunction<dim>::value_list (const std::vector<Point<dim> > &points,
                                     std::vector<double>            &values,
@@ -156,7 +156,7 @@ namespace Functions
   }
 
 
-  template<int dim>
+  template <int dim>
   void
   Q1WedgeFunction<dim>::vector_value_list (
     const std::vector<Point<dim> > &points,
@@ -175,7 +175,7 @@ namespace Functions
   }
 
 
-  template<int dim>
+  template <int dim>
   double
   Q1WedgeFunction<dim>::laplacian (const Point<dim> &,
                                    const unsigned int) const
@@ -185,7 +185,7 @@ namespace Functions
   }
 
 
-  template<int dim>
+  template <int dim>
   void
   Q1WedgeFunction<dim>::laplacian_list (const std::vector<Point<dim> > &points,
                                         std::vector<double>            &values,
@@ -201,7 +201,7 @@ namespace Functions
 
 
 
-  template<int dim>
+  template <int dim>
   Tensor<1,dim>
   Q1WedgeFunction<dim>::gradient (const Point<dim>   &p,
                                   const unsigned int) const
@@ -215,7 +215,7 @@ namespace Functions
 
 
 
-  template<int dim>
+  template <int dim>
   void
   Q1WedgeFunction<dim>::gradient_list (const std::vector<Point<dim> > &points,
                                        std::vector<Tensor<1,dim> >    &gradients,
@@ -233,7 +233,7 @@ namespace Functions
   }
 
 
-  template<int dim>
+  template <int dim>
   void
   Q1WedgeFunction<dim>::vector_gradient_list (
     const std::vector<Point<dim> > &points,
@@ -256,14 +256,14 @@ namespace Functions
 //////////////////////////////////////////////////////////////////////
 
 
-  template<int dim>
+  template <int dim>
   PillowFunction<dim>::PillowFunction (const double offset)
     :
     offset(offset)
   {}
 
 
-  template<int dim>
+  template <int dim>
   double
   PillowFunction<dim>::value (const Point<dim>   &p,
                               const unsigned int) const
@@ -282,7 +282,7 @@ namespace Functions
     return 0.;
   }
 
-  template<int dim>
+  template <int dim>
   void
   PillowFunction<dim>::value_list (const std::vector<Point<dim> > &points,
                                    std::vector<double>            &values,
@@ -313,7 +313,7 @@ namespace Functions
 
 
 
-  template<int dim>
+  template <int dim>
   double
   PillowFunction<dim>::laplacian (const Point<dim>   &p,
                                   const unsigned int) const
@@ -334,7 +334,7 @@ namespace Functions
     return 0.;
   }
 
-  template<int dim>
+  template <int dim>
   void
   PillowFunction<dim>::laplacian_list (const std::vector<Point<dim> > &points,
                                        std::vector<double>            &values,
@@ -365,7 +365,7 @@ namespace Functions
       }
   }
 
-  template<int dim>
+  template <int dim>
   Tensor<1,dim>
   PillowFunction<dim>::gradient (const Point<dim>   &p,
                                  const unsigned int) const
@@ -391,7 +391,7 @@ namespace Functions
     return result;
   }
 
-  template<int dim>
+  template <int dim>
   void
   PillowFunction<dim>::gradient_list (const std::vector<Point<dim> > &points,
                                       std::vector<Tensor<1,dim> >    &gradients,
@@ -433,7 +433,7 @@ namespace Functions
 
 
 
-  template<int dim>
+  template <int dim>
   double
   CosineFunction<dim>::value (const Point<dim>   &p,
                               const unsigned int) const
@@ -452,7 +452,7 @@ namespace Functions
     return 0.;
   }
 
-  template<int dim>
+  template <int dim>
   void
   CosineFunction<dim>::value_list (const std::vector<Point<dim> > &points,
                                    std::vector<double>            &values,
@@ -466,7 +466,7 @@ namespace Functions
   }
 
 
-  template<int dim>
+  template <int dim>
   void
   CosineFunction<dim>::vector_value_list (
     const std::vector<Point<dim> > &points,
@@ -484,7 +484,7 @@ namespace Functions
   }
 
 
-  template<int dim>
+  template <int dim>
   double
   CosineFunction<dim>::laplacian (const Point<dim>   &p,
                                   const unsigned int) const
@@ -503,7 +503,7 @@ namespace Functions
     return 0.;
   }
 
-  template<int dim>
+  template <int dim>
   void
   CosineFunction<dim>::laplacian_list (const std::vector<Point<dim> > &points,
                                        std::vector<double>            &values,
@@ -516,7 +516,7 @@ namespace Functions
       values[i] = laplacian(points[i]);
   }
 
-  template<int dim>
+  template <int dim>
   Tensor<1,dim>
   CosineFunction<dim>::gradient (const Point<dim>   &p,
                                  const unsigned int) const
@@ -542,7 +542,7 @@ namespace Functions
     return result;
   }
 
-  template<int dim>
+  template <int dim>
   void
   CosineFunction<dim>::gradient_list (const std::vector<Point<dim> > &points,
                                       std::vector<Tensor<1,dim> >    &gradients,
@@ -574,7 +574,7 @@ namespace Functions
       }
   }
 
-  template<int dim>
+  template <int dim>
   SymmetricTensor<2,dim>
   CosineFunction<dim>::hessian (const Point<dim>   &p,
                                 const unsigned int) const
@@ -621,7 +621,7 @@ namespace Functions
     return result;
   }
 
-  template<int dim>
+  template <int dim>
   void
   CosineFunction<dim>::hessian_list (const std::vector<Point<dim> >       &points,
                                      std::vector<SymmetricTensor<2,dim> > &hessians,
@@ -683,7 +683,7 @@ namespace Functions
   {}
 
 
-  template<int dim>
+  template <int dim>
   double
   CosineGradFunction<dim>::value (
     const Point<dim>   &p,
@@ -707,7 +707,7 @@ namespace Functions
   }
 
 
-  template<int dim>
+  template <int dim>
   void
   CosineGradFunction<dim>::vector_value (
     const Point<dim> &p,
@@ -734,7 +734,7 @@ namespace Functions
   }
 
 
-  template<int dim>
+  template <int dim>
   void
   CosineGradFunction<dim>::value_list (
     const std::vector<Point<dim> > &points,
@@ -768,7 +768,7 @@ namespace Functions
   }
 
 
-  template<int dim>
+  template <int dim>
   void
   CosineGradFunction<dim>::vector_value_list (
     const std::vector<Point<dim> > &points,
@@ -801,7 +801,7 @@ namespace Functions
   }
 
 
-  template<int dim>
+  template <int dim>
   double
   CosineGradFunction<dim>::laplacian (
     const Point<dim>   &p,
@@ -811,7 +811,7 @@ namespace Functions
   }
 
 
-  template<int dim>
+  template <int dim>
   Tensor<1,dim>
   CosineGradFunction<dim>::gradient (
     const Point<dim> &p,
@@ -844,7 +844,7 @@ namespace Functions
   }
 
 
-  template<int dim>
+  template <int dim>
   void
   CosineGradFunction<dim>::gradient_list (
     const std::vector<Point<dim> > &points,
@@ -884,7 +884,7 @@ namespace Functions
   }
 
 
-  template<int dim>
+  template <int dim>
   void
   CosineGradFunction<dim>::vector_gradient_list (
     const std::vector<Point<dim> > &points,
@@ -940,7 +940,7 @@ namespace Functions
 
 //////////////////////////////////////////////////////////////////////
 
-  template<int dim>
+  template <int dim>
   double
   ExpFunction<dim>::value (const Point<dim>   &p,
                            const unsigned int) const
@@ -959,7 +959,7 @@ namespace Functions
     return 0.;
   }
 
-  template<int dim>
+  template <int dim>
   void
   ExpFunction<dim>::value_list (const std::vector<Point<dim> > &points,
                                 std::vector<double>            &values,
@@ -988,7 +988,7 @@ namespace Functions
       }
   }
 
-  template<int dim>
+  template <int dim>
   double
   ExpFunction<dim>::laplacian (const Point<dim>   &p,
                                const unsigned int) const
@@ -1007,7 +1007,7 @@ namespace Functions
     return 0.;
   }
 
-  template<int dim>
+  template <int dim>
   void
   ExpFunction<dim>::laplacian_list (const std::vector<Point<dim> > &points,
                                     std::vector<double>            &values,
@@ -1036,7 +1036,7 @@ namespace Functions
       }
   }
 
-  template<int dim>
+  template <int dim>
   Tensor<1,dim>
   ExpFunction<dim>::gradient (const Point<dim>   &p,
                               const unsigned int) const
@@ -1062,7 +1062,7 @@ namespace Functions
     return result;
   }
 
-  template<int dim>
+  template <int dim>
   void
   ExpFunction<dim>::gradient_list (const std::vector<Point<dim> > &points,
                                    std::vector<Tensor<1,dim> >    &gradients,
@@ -1687,7 +1687,7 @@ namespace Functions
 
 //////////////////////////////////////////////////////////////////////
 
-  template<int dim>
+  template <int dim>
   JumpFunction<dim>::JumpFunction(const Point<dim> &direction,
                                   const double      steepness)
     :
@@ -1711,7 +1711,7 @@ namespace Functions
 
 
 
-  template<int dim>
+  template <int dim>
   double
   JumpFunction<dim>::value (const Point<dim>   &p,
                             const unsigned int) const
@@ -1722,7 +1722,7 @@ namespace Functions
 
 
 
-  template<int dim>
+  template <int dim>
   void
   JumpFunction<dim>::value_list (const std::vector<Point<dim> > &p,
                                  std::vector<double>          &values,
@@ -1739,7 +1739,7 @@ namespace Functions
   }
 
 
-  template<int dim>
+  template <int dim>
   double
   JumpFunction<dim>::laplacian (const Point<dim>   &p,
                                 const unsigned int) const
@@ -1750,7 +1750,7 @@ namespace Functions
   }
 
 
-  template<int dim>
+  template <int dim>
   void
   JumpFunction<dim>::laplacian_list (const std::vector<Point<dim> > &p,
                                      std::vector<double>          &values,
@@ -1771,7 +1771,7 @@ namespace Functions
 
 
 
-  template<int dim>
+  template <int dim>
   Tensor<1,dim>
   JumpFunction<dim>::gradient (const Point<dim>   &p,
                                const unsigned int) const
@@ -1786,7 +1786,7 @@ namespace Functions
 
 
 
-  template<int dim>
+  template <int dim>
   void
   JumpFunction<dim>::gradient_list (const std::vector<Point<dim> > &p,
                                     std::vector<Tensor<1,dim> >  &gradients,
@@ -2163,7 +2163,7 @@ namespace Functions
 
 
 
-  template<int dim>
+  template <int dim>
   void
   Monomial<dim>::value_list (const std::vector<Point<dim> > &points,
                              std::vector<double>            &values,
index 1cc4738cf9390ead934af884e36b36e252ddda95..3f3aa2dfcb011e3d80e60244bf18b7e0aa860db8 100644 (file)
@@ -25,7 +25,7 @@ DEAL_II_NAMESPACE_OPEN
 
 namespace Functions
 {
-  template<int dim>
+  template <int dim>
   CutOffFunctionBase<dim>::CutOffFunctionBase (const double r,
                                                const Point<dim> p,
                                                const unsigned int n_components,
@@ -38,7 +38,7 @@ namespace Functions
   {}
 
 
-  template<int dim>
+  template <int dim>
   void
   CutOffFunctionBase<dim>::new_center (const Point<dim> &p)
   {
@@ -46,7 +46,7 @@ namespace Functions
   }
 
 
-  template<int dim>
+  template <int dim>
   void
   CutOffFunctionBase<dim>::new_radius (const double r)
   {
@@ -55,7 +55,7 @@ namespace Functions
 
 //////////////////////////////////////////////////////////////////////
 
-  template<int dim>
+  template <int dim>
   CutOffFunctionLinfty<dim>::CutOffFunctionLinfty (const double r,
                                                    const Point<dim> p,
                                                    const unsigned int n_components,
@@ -65,7 +65,7 @@ namespace Functions
   {}
 
 
-  template<int dim>
+  template <int dim>
   double
   CutOffFunctionLinfty<dim>::value (const Point<dim>   &p,
                                     const unsigned int component) const
@@ -78,7 +78,7 @@ namespace Functions
   }
 
 
-  template<int dim>
+  template <int dim>
   void
   CutOffFunctionLinfty<dim>::value_list (const std::vector<Point<dim> > &points,
                                          std::vector<double>            &values,
@@ -100,7 +100,7 @@ namespace Functions
   }
 
 
-  template<int dim>
+  template <int dim>
   void
   CutOffFunctionLinfty<dim>::vector_value_list (
     const std::vector<Point<dim> > &points,
@@ -124,7 +124,7 @@ namespace Functions
   }
 
 
-  template<int dim>
+  template <int dim>
   CutOffFunctionW1<dim>::CutOffFunctionW1 (const double     r,
                                            const Point<dim> p,
                                            const unsigned int n_components,
@@ -134,7 +134,7 @@ namespace Functions
   {}
 
 
-  template<int dim>
+  template <int dim>
   double
   CutOffFunctionW1<dim>::value (const Point<dim>   &p,
                                 const unsigned int component) const
@@ -150,7 +150,7 @@ namespace Functions
   }
 
 
-  template<int dim>
+  template <int dim>
   void
   CutOffFunctionW1<dim>::value_list (const std::vector<Point<dim> > &points,
                                      std::vector<double>            &values,
@@ -173,7 +173,7 @@ namespace Functions
 
 
 
-  template<int dim>
+  template <int dim>
   void
   CutOffFunctionW1<dim>::vector_value_list (
     const std::vector<Point<dim> > &points,
@@ -198,7 +198,7 @@ namespace Functions
   }
 
 
-  template<int dim>
+  template <int dim>
   CutOffFunctionCinfty<dim>::CutOffFunctionCinfty (const double     r,
                                                    const Point<dim> p,
                                                    const unsigned int n_components,
@@ -208,7 +208,7 @@ namespace Functions
   {}
 
 
-  template<int dim>
+  template <int dim>
   double
   CutOffFunctionCinfty<dim>::value (const Point<dim>   &p,
                                     const unsigned int component) const
@@ -228,7 +228,7 @@ namespace Functions
   }
 
 
-  template<int dim>
+  template <int dim>
   void
   CutOffFunctionCinfty<dim>::value_list (const std::vector<Point<dim> > &points,
                                          std::vector<double>            &values,
@@ -260,7 +260,7 @@ namespace Functions
   }
 
 
-  template<int dim>
+  template <int dim>
   void
   CutOffFunctionCinfty<dim>::vector_value_list (
     const std::vector<Point<dim> > &points,
@@ -293,7 +293,7 @@ namespace Functions
 
 
 
-  template<int dim>
+  template <int dim>
   Tensor<1,dim>
   CutOffFunctionCinfty<dim>::gradient (const Point<dim>   &p,
                                        const unsigned int) const
index 919b5669a0df89433dc185af451bf572a5952308..3160005b8eaf4d734482725d969ff824c7400b2d 100644 (file)
@@ -223,7 +223,7 @@ const unsigned int GeometryInfo<4>::vertex_to_face
 };
 
 
-template<int dim>
+template <int dim>
 unsigned int
 GeometryInfo<dim>::n_children(const RefinementCase<dim> &ref_case)
 {
@@ -234,7 +234,7 @@ GeometryInfo<dim>::n_children(const RefinementCase<dim> &ref_case)
 }
 
 
-template<>
+template <>
 unsigned int
 GeometryInfo<1>::n_subfaces(const internal::SubfaceCase<1> &)
 {
@@ -244,7 +244,7 @@ GeometryInfo<1>::n_subfaces(const internal::SubfaceCase<1> &)
 
 
 
-template<>
+template <>
 unsigned int
 GeometryInfo<2>::n_subfaces(const internal::SubfaceCase<2> &subface_case)
 {
@@ -253,7 +253,7 @@ GeometryInfo<2>::n_subfaces(const internal::SubfaceCase<2> &subface_case)
 
 
 
-template<>
+template <>
 unsigned int
 GeometryInfo<3>::n_subfaces(const internal::SubfaceCase<3> &subface_case)
 {
@@ -263,7 +263,7 @@ GeometryInfo<3>::n_subfaces(const internal::SubfaceCase<3> &subface_case)
 }
 
 
-template<>
+template <>
 double
 GeometryInfo<1>::subface_ratio(const internal::SubfaceCase<1> &,
                                const unsigned int)
@@ -272,7 +272,7 @@ GeometryInfo<1>::subface_ratio(const internal::SubfaceCase<1> &,
 }
 
 
-template<>
+template <>
 double
 GeometryInfo<2>::subface_ratio(const internal::SubfaceCase<2> &subface_case,
                                const unsigned int)
@@ -314,7 +314,7 @@ GeometryInfo<2>::subface_ratio(const internal::SubfaceCase<2> &subface_case,
 }
 
 
-template<>
+template <>
 double
 GeometryInfo<3>::subface_ratio(const internal::SubfaceCase<3> &subface_case,
                                const unsigned int subface_no)
@@ -374,7 +374,7 @@ GeometryInfo<3>::subface_ratio(const internal::SubfaceCase<3> &subface_case,
 
 
 
-template<>
+template <>
 RefinementCase<0>
 GeometryInfo<1>::face_refinement_case(const RefinementCase<1> &,
                                       const unsigned int,
@@ -388,7 +388,7 @@ GeometryInfo<1>::face_refinement_case(const RefinementCase<1> &,
 }
 
 
-template<>
+template <>
 RefinementCase<1>
 GeometryInfo<2>::face_refinement_case(const RefinementCase<2> &cell_refinement_case,
                                       const unsigned int face_no,
@@ -430,7 +430,7 @@ GeometryInfo<2>::face_refinement_case(const RefinementCase<2> &cell_refinement_c
 }
 
 
-template<>
+template <>
 RefinementCase<2>
 GeometryInfo<3>::face_refinement_case(const RefinementCase<3> &cell_refinement_case,
                                       const unsigned int face_no,
@@ -523,7 +523,7 @@ GeometryInfo<3>::face_refinement_case(const RefinementCase<3> &cell_refinement_c
 
 
 
-template<>
+template <>
 RefinementCase<1>
 GeometryInfo<1>::line_refinement_case(const RefinementCase<1> &cell_refinement_case,
                                       const unsigned int line_no)
@@ -540,7 +540,7 @@ GeometryInfo<1>::line_refinement_case(const RefinementCase<1> &cell_refinement_c
 }
 
 
-template<>
+template <>
 RefinementCase<1>
 GeometryInfo<2>::line_refinement_case(const RefinementCase<2> &cell_refinement_case,
                                       const unsigned int line_no)
@@ -550,7 +550,7 @@ GeometryInfo<2>::line_refinement_case(const RefinementCase<2> &cell_refinement_c
 }
 
 
-template<>
+template <>
 RefinementCase<1>
 GeometryInfo<3>::line_refinement_case(const RefinementCase<3> &cell_refinement_case,
                                       const unsigned int line_no)
@@ -586,7 +586,7 @@ GeometryInfo<3>::line_refinement_case(const RefinementCase<3> &cell_refinement_c
 
 
 
-template<>
+template <>
 RefinementCase<1>
 GeometryInfo<1>::min_cell_refinement_case_for_face_refinement(const RefinementCase<0> &,
     const unsigned int,
@@ -601,7 +601,7 @@ GeometryInfo<1>::min_cell_refinement_case_for_face_refinement(const RefinementCa
 }
 
 
-template<>
+template <>
 RefinementCase<2>
 GeometryInfo<2>::min_cell_refinement_case_for_face_refinement(const RefinementCase<1> &face_refinement_case,
     const unsigned int face_no,
@@ -622,7 +622,7 @@ GeometryInfo<2>::min_cell_refinement_case_for_face_refinement(const RefinementCa
 }
 
 
-template<>
+template <>
 RefinementCase<3>
 GeometryInfo<3>::min_cell_refinement_case_for_face_refinement(const RefinementCase<2> &face_refinement_case,
     const unsigned int face_no,
@@ -688,7 +688,7 @@ GeometryInfo<3>::min_cell_refinement_case_for_face_refinement(const RefinementCa
 
 
 
-template<>
+template <>
 RefinementCase<1>
 GeometryInfo<1>::min_cell_refinement_case_for_line_refinement(const unsigned int line_no)
 {
@@ -699,7 +699,7 @@ GeometryInfo<1>::min_cell_refinement_case_for_line_refinement(const unsigned int
 }
 
 
-template<>
+template <>
 RefinementCase<2>
 GeometryInfo<2>::min_cell_refinement_case_for_line_refinement(const unsigned int line_no)
 {
@@ -712,7 +712,7 @@ GeometryInfo<2>::min_cell_refinement_case_for_line_refinement(const unsigned int
 }
 
 
-template<>
+template <>
 RefinementCase<3>
 GeometryInfo<3>::min_cell_refinement_case_for_line_refinement(const unsigned int line_no)
 {
@@ -1471,7 +1471,7 @@ GeometryInfo<3>::face_to_cell_lines (const unsigned int face,
 
 
 
-template<int dim>
+template <int dim>
 unsigned int
 GeometryInfo<dim>::face_to_cell_lines (const unsigned int,
                                        const unsigned int,
index ea52665cab3be4f3230ca84611a675c65b2ac205..194c513e69894f43d114f156b960a534ba59dd70 100644 (file)
 DEAL_II_NAMESPACE_OPEN
 
 
-template<int dim>
+template <int dim>
 PolynomialsNedelec<dim>::PolynomialsNedelec (const unsigned int k) :
   my_degree (k), polynomial_space (create_polynomials (k)),
   n_pols (compute_n_pols (k))
 {
 }
 
-template<int dim>
+template <int dim>
 std::vector<std::vector< Polynomials::Polynomial<double> > >
 PolynomialsNedelec<dim>::create_polynomials (const unsigned int k)
 {
@@ -48,7 +48,7 @@ PolynomialsNedelec<dim>::create_polynomials (const unsigned int k)
 // Compute the values, gradients
 // and double gradients of the
 // polynomial at the given point.
-template<int dim>
+template <int dim>
 void
 PolynomialsNedelec<dim>::compute (const Point<dim> &unit_point,
                                   std::vector<Tensor<1,dim> > &values,
@@ -1383,7 +1383,7 @@ PolynomialsNedelec<dim>::compute (const Point<dim> &unit_point,
 }
 
 
-template<int dim>
+template <int dim>
 unsigned int
 PolynomialsNedelec<dim>::compute_n_pols (unsigned int k)
 {
index cfb1768689337a8081954ee32d722c9c68ad1512..159899cf659abbb2ea62c91807078887dfd8101a 100644 (file)
@@ -285,7 +285,7 @@ Quadrature<dim>::memory_consumption () const
 
 
 //---------------------------------------------------------------------------
-template<int dim>
+template <int dim>
 QAnisotropic<dim>::QAnisotropic(const Quadrature<1> &qx)
   : Quadrature<dim>(qx.size())
 {
@@ -301,7 +301,7 @@ QAnisotropic<dim>::QAnisotropic(const Quadrature<1> &qx)
 
 
 
-template<int dim>
+template <int dim>
 QAnisotropic<dim>::QAnisotropic(const Quadrature<1> &qx,
                                 const Quadrature<1> &qy)
   : Quadrature<dim>(qx.size()
@@ -321,7 +321,7 @@ QAnisotropic<dim>::QAnisotropic(const Quadrature<1> &qx,
 
 
 
-template<int dim>
+template <int dim>
 QAnisotropic<dim>::QAnisotropic(const Quadrature<1> &qx,
                                 const Quadrature<1> &qy,
                                 const Quadrature<1> &qz)
@@ -1526,7 +1526,7 @@ QIterated<1>::uses_both_endpoints (const Quadrature<1> &base_quadrature)
 }
 
 
-// template<>
+// template <>
 // void
 // QIterated<1>::fill(Quadrature<1>& dst,
 //                 const Quadrature<1> &base_quadrature,
index 0b8fcb4fb3211666f961bbd52855aba4f108b358..de6dfef91785cb95ed91133fab2eaf2ad2537b35 100644 (file)
@@ -693,7 +693,7 @@ QGaussLog<1>::get_quadrature_weights(const unsigned int n)
 }
 
 
-template<>
+template <>
 QGaussLogR<1>::QGaussLogR(const unsigned int n,
                           const Point<1> origin,
                           const double alpha,
@@ -765,7 +765,7 @@ QGaussLogR<1>::QGaussLogR(const unsigned int n,
 }
 
 
-template<>
+template <>
 unsigned int QGaussOneOverR<2>::quad_size(const Point<2> singularity,
                                           const unsigned int n)
 {
@@ -784,7 +784,7 @@ unsigned int QGaussOneOverR<2>::quad_size(const Point<2> singularity,
   return (8*n*n);
 }
 
-template<>
+template <>
 QGaussOneOverR<2>::QGaussOneOverR(const unsigned int n,
                                   const Point<2> singularity,
                                   const bool factor_out_singularity) :
@@ -834,7 +834,7 @@ QGaussOneOverR<2>::QGaussOneOverR(const unsigned int n,
 }
 
 
-template<>
+template <>
 QGaussOneOverR<2>::QGaussOneOverR(const unsigned int n,
                                   const unsigned int vertex_index,
                                   const bool factor_out_singularity) :
index 424a72c7b97c7125d8663f718efaff96a5131e85..8c7a96c3d1b52b11158362c97e623d142fc6e12a 100644 (file)
@@ -698,7 +698,7 @@ compute (const Point<dim>            &p,
 
 
 
-template<int dim>
+template <int dim>
 unsigned int
 AnisotropicPolynomials<dim>::n() const
 {
index 285f4217c599c20b580c732b9ce9409bb195b6f5..ca1e80bab5980dd8bf4a88221525eb665b8aaa8d 100644 (file)
@@ -43,7 +43,7 @@ namespace parallel
   namespace distributed
   {
 
-    template<int dim, typename VectorType, typename DoFHandlerType>
+    template <int dim, typename VectorType, typename DoFHandlerType>
     SolutionTransfer<dim, VectorType, DoFHandlerType>::SolutionTransfer (const DoFHandlerType &dof)
       :
       dof_handler(&dof, typeid(*this).name()),
@@ -56,13 +56,13 @@ namespace parallel
 
 
 
-    template<int dim, typename VectorType, typename DoFHandlerType>
+    template <int dim, typename VectorType, typename DoFHandlerType>
     SolutionTransfer<dim, VectorType, DoFHandlerType>::~SolutionTransfer ()
     {}
 
 
 
-    template<int dim, typename VectorType, typename DoFHandlerType>
+    template <int dim, typename VectorType, typename DoFHandlerType>
     void
     SolutionTransfer<dim, VectorType, DoFHandlerType>::
     prepare_for_coarsening_and_refinement (const std::vector<const VectorType *> &all_in)
@@ -73,7 +73,7 @@ namespace parallel
 
 
 
-    template<int dim, typename VectorType, typename DoFHandlerType>
+    template <int dim, typename VectorType, typename DoFHandlerType>
     void
     SolutionTransfer<dim, VectorType, DoFHandlerType>::register_data_attach (const std::size_t size)
     {
@@ -99,7 +99,7 @@ namespace parallel
 
 
 
-    template<int dim, typename VectorType, typename DoFHandlerType>
+    template <int dim, typename VectorType, typename DoFHandlerType>
     void
     SolutionTransfer<dim, VectorType, DoFHandlerType>::
     prepare_for_coarsening_and_refinement (const VectorType &in)
@@ -110,7 +110,7 @@ namespace parallel
 
 
 
-    template<int dim, typename VectorType, typename DoFHandlerType>
+    template <int dim, typename VectorType, typename DoFHandlerType>
     void
     SolutionTransfer<dim, VectorType, DoFHandlerType>::prepare_serialization (const VectorType &in)
     {
@@ -120,7 +120,7 @@ namespace parallel
 
 
 
-    template<int dim, typename VectorType, typename DoFHandlerType>
+    template <int dim, typename VectorType, typename DoFHandlerType>
     void
     SolutionTransfer<dim, VectorType, DoFHandlerType>::prepare_serialization
     (const std::vector<const VectorType *> &all_in)
@@ -130,7 +130,7 @@ namespace parallel
 
 
 
-    template<int dim, typename VectorType, typename DoFHandlerType>
+    template <int dim, typename VectorType, typename DoFHandlerType>
     void
     SolutionTransfer<dim, VectorType, DoFHandlerType>::deserialize (VectorType &in)
     {
@@ -140,7 +140,7 @@ namespace parallel
 
 
 
-    template<int dim, typename VectorType, typename DoFHandlerType>
+    template <int dim, typename VectorType, typename DoFHandlerType>
     void
     SolutionTransfer<dim, VectorType, DoFHandlerType>::deserialize (std::vector<VectorType *> &all_in)
     {
@@ -153,7 +153,7 @@ namespace parallel
     }
 
 
-    template<int dim, typename VectorType, typename DoFHandlerType>
+    template <int dim, typename VectorType, typename DoFHandlerType>
     void
     SolutionTransfer<dim, VectorType, DoFHandlerType>::interpolate (std::vector<VectorType *> &all_out)
     {
@@ -187,7 +187,7 @@ namespace parallel
 
 
 
-    template<int dim, typename VectorType, typename DoFHandlerType>
+    template <int dim, typename VectorType, typename DoFHandlerType>
     void
     SolutionTransfer<dim, VectorType, DoFHandlerType>::interpolate (VectorType &out)
     {
@@ -197,7 +197,7 @@ namespace parallel
 
 
 
-    template<int dim, typename VectorType, typename DoFHandlerType>
+    template <int dim, typename VectorType, typename DoFHandlerType>
     unsigned int
     SolutionTransfer<dim, VectorType, DoFHandlerType>::get_data_size() const
     {
@@ -205,7 +205,7 @@ namespace parallel
     }
 
 
-    template<int dim, typename VectorType, typename DoFHandlerType>
+    template <int dim, typename VectorType, typename DoFHandlerType>
     void
     SolutionTransfer<dim, VectorType, DoFHandlerType>::
     pack_callback(const typename Triangulation<dim,DoFHandlerType::space_dimension>::cell_iterator &cell_,
@@ -229,7 +229,7 @@ namespace parallel
     }
 
 
-    template<int dim, typename VectorType, typename DoFHandlerType>
+    template <int dim, typename VectorType, typename DoFHandlerType>
     void
     SolutionTransfer<dim, VectorType, DoFHandlerType>::unpack_callback
     (const typename Triangulation<dim,DoFHandlerType::space_dimension>::cell_iterator &cell_,
index 76634f4d627832a526b3f46d0eb5203f9ba573b8..5aa1a4107f9995cf882bbdd8a3c6e5d54a1deb0d 100644 (file)
@@ -3465,7 +3465,7 @@ namespace parallel
 
 
 
-    template<int dim, int spacedim>
+    template <int dim, int spacedim>
     std::vector<bool>
     Triangulation<dim,spacedim>
     ::mark_locally_active_vertices_on_level (const int level) const
@@ -3520,7 +3520,7 @@ namespace parallel
 
 
 
-    template<int dim, int spacedim>
+    template <int dim, int spacedim>
     void
     Triangulation<dim,spacedim>::add_periodicity
     (const std::vector<GridTools::PeriodicFacePair<cell_iterator> > &
index 3cce7dc7b11306b19af947a6d3786e74ad8f99b3..db82856becd93477ebb833c666903788cda5ed35 100644 (file)
 DEAL_II_NAMESPACE_OPEN
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 const unsigned int DoFHandler<dim,spacedim>::dimension;
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 const unsigned int DoFHandler<dim,spacedim>::space_dimension;
 
 template <int dim, int spacedim>
@@ -62,7 +62,7 @@ namespace internal
 
 namespace internal
 {
-  template<int dim, int spacedim>
+  template <int dim, int spacedim>
   std::string policy_to_string(const dealii::internal::DoFHandler::Policy::PolicyBase<dim,spacedim> &policy)
   {
     std::string policy_name;
@@ -366,7 +366,7 @@ namespace internal
           }
       }
 
-      template<int spacedim>
+      template <int spacedim>
       static
       void reserve_space_mg (DoFHandler<1, spacedim> &dof_handler)
       {
@@ -422,7 +422,7 @@ namespace internal
             }
       }
 
-      template<int spacedim>
+      template <int spacedim>
       static
       void reserve_space_mg (DoFHandler<2, spacedim> &dof_handler)
       {
@@ -481,7 +481,7 @@ namespace internal
             }
       }
 
-      template<int spacedim>
+      template <int spacedim>
       static
       void reserve_space_mg (DoFHandler<3, spacedim> &dof_handler)
       {
@@ -543,7 +543,7 @@ namespace internal
 
 
 
-      template<int spacedim>
+      template <int spacedim>
       static
       types::global_dof_index
       get_dof_index (
@@ -558,7 +558,7 @@ namespace internal
         return mg_level.dof_object.get_dof_index (dof_handler, obj_index, fe_index, local_index);
       }
 
-      template<int spacedim>
+      template <int spacedim>
       static
       types::global_dof_index
       get_dof_index (const DoFHandler<2, spacedim> &dof_handler, internal::DoFHandler::DoFLevel<2> &, internal::DoFHandler::DoFFaces<2> &mg_faces, const unsigned int obj_index, const unsigned int fe_index, const unsigned int local_index, const int2type<1>)
@@ -566,7 +566,7 @@ namespace internal
         return mg_faces.lines.get_dof_index (dof_handler, obj_index, fe_index, local_index);
       }
 
-      template<int spacedim>
+      template <int spacedim>
       static
       types::global_dof_index
       get_dof_index (const DoFHandler<2, spacedim> &dof_handler, internal::DoFHandler::DoFLevel<2> &mg_level, internal::DoFHandler::DoFFaces<2> &, const unsigned int obj_index, const unsigned int fe_index, const unsigned int local_index, const int2type<2>)
@@ -574,7 +574,7 @@ namespace internal
         return mg_level.dof_object.get_dof_index (dof_handler, obj_index, fe_index, local_index);
       }
 
-      template<int spacedim>
+      template <int spacedim>
       static
       types::global_dof_index
       get_dof_index (const DoFHandler<3, spacedim> &dof_handler, internal::DoFHandler::DoFLevel<3> &, internal::DoFHandler::DoFFaces<3> &mg_faces, const unsigned int obj_index, const unsigned int fe_index, const unsigned int local_index, const int2type<1>)
@@ -582,7 +582,7 @@ namespace internal
         return mg_faces.lines.get_dof_index (dof_handler, obj_index, fe_index, local_index);
       }
 
-      template<int spacedim>
+      template <int spacedim>
       static
       types::global_dof_index
       get_dof_index (const DoFHandler<3, spacedim> &dof_handler, internal::DoFHandler::DoFLevel<3> &, internal::DoFHandler::DoFFaces<3> &mg_faces, const unsigned int obj_index, const unsigned int fe_index, const unsigned int local_index, const int2type<2>)
@@ -590,7 +590,7 @@ namespace internal
         return mg_faces.quads.get_dof_index (dof_handler, obj_index, fe_index, local_index);
       }
 
-      template<int spacedim>
+      template <int spacedim>
       static
       types::global_dof_index
       get_dof_index (const DoFHandler<3, spacedim> &dof_handler, internal::DoFHandler::DoFLevel<3> &mg_level, internal::DoFHandler::DoFFaces<3> &, const unsigned int obj_index, const unsigned int fe_index, const unsigned int local_index, const int2type<3>)
@@ -598,42 +598,42 @@ namespace internal
         return mg_level.dof_object.get_dof_index (dof_handler, obj_index, fe_index, local_index);
       }
 
-      template<int spacedim>
+      template <int spacedim>
       static
       void set_dof_index (const DoFHandler<1, spacedim> &dof_handler, internal::DoFHandler::DoFLevel<1> &mg_level, internal::DoFHandler::DoFFaces<1> &, const unsigned int obj_index, const unsigned int fe_index, const unsigned int local_index, const types::global_dof_index global_index, const int2type<1>)
       {
         mg_level.dof_object.set_dof_index (dof_handler, obj_index, fe_index, local_index, global_index);
       }
 
-      template<int spacedim>
+      template <int spacedim>
       static
       void set_dof_index (const DoFHandler<2, spacedim> &dof_handler, internal::DoFHandler::DoFLevel<2> &, internal::DoFHandler::DoFFaces<2> &mg_faces, const unsigned int obj_index, const unsigned int fe_index, const unsigned int local_index, const types::global_dof_index global_index, const int2type<1>)
       {
         mg_faces.lines.set_dof_index (dof_handler, obj_index, fe_index, local_index, global_index);
       }
 
-      template<int spacedim>
+      template <int spacedim>
       static
       void set_dof_index (const DoFHandler<2, spacedim> &dof_handler, internal::DoFHandler::DoFLevel<2> &mg_level, internal::DoFHandler::DoFFaces<2> &, const unsigned int obj_index, const unsigned int fe_index, const unsigned int local_index, const types::global_dof_index global_index, const int2type<2>)
       {
         mg_level.dof_object.set_dof_index (dof_handler, obj_index, fe_index, local_index, global_index);
       }
 
-      template<int spacedim>
+      template <int spacedim>
       static
       void set_dof_index (const DoFHandler<3, spacedim> &dof_handler, internal::DoFHandler::DoFLevel<3> &, internal::DoFHandler::DoFFaces<3> &mg_faces, const unsigned int obj_index, const unsigned int fe_index, const unsigned int local_index, const types::global_dof_index global_index, const int2type<1>)
       {
         mg_faces.lines.set_dof_index (dof_handler, obj_index, fe_index, local_index, global_index);
       }
 
-      template<int spacedim>
+      template <int spacedim>
       static
       void set_dof_index (const DoFHandler<3, spacedim> &dof_handler, internal::DoFHandler::DoFLevel<3> &, internal::DoFHandler::DoFFaces<3> &mg_faces, const unsigned int obj_index, const unsigned int fe_index, const unsigned int local_index, const types::global_dof_index global_index, const int2type<2>)
       {
         mg_faces.quads.set_dof_index (dof_handler, obj_index, fe_index, local_index, global_index);
       }
 
-      template<int spacedim>
+      template <int spacedim>
       static
       void set_dof_index (const DoFHandler<3, spacedim> &dof_handler, internal::DoFHandler::DoFLevel<3> &mg_level, internal::DoFHandler::DoFFaces<3> &, const unsigned int obj_index, const unsigned int fe_index, const unsigned int local_index, const types::global_dof_index global_index, const int2type<3>)
       {
@@ -645,7 +645,7 @@ namespace internal
 
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 DoFHandler<dim,spacedim>::DoFHandler (const Triangulation<dim,spacedim> &tria)
   :
   tria(&tria, typeid(*this).name()),
@@ -669,7 +669,7 @@ DoFHandler<dim,spacedim>::DoFHandler (const Triangulation<dim,spacedim> &tria)
 }
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 DoFHandler<dim,spacedim>::DoFHandler ()
   :
   tria(nullptr, typeid(*this).name()),
@@ -690,7 +690,7 @@ DoFHandler<dim,spacedim>::~DoFHandler ()
 }
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void
 DoFHandler<dim,spacedim>::
 initialize(const Triangulation<dim,spacedim> &t,
@@ -969,7 +969,7 @@ types::global_dof_index DoFHandler<1,2>::n_boundary_dofs (const std::set<types::
 
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 types::global_dof_index DoFHandler<dim,spacedim>::n_boundary_dofs () const
 {
   std::set<int> boundary_dofs;
@@ -1043,7 +1043,7 @@ DoFHandler<dim,spacedim>::n_boundary_dofs (const std::set<types::boundary_id> &b
 
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 std::size_t
 DoFHandler<dim,spacedim>::memory_consumption () const
 {
@@ -1073,7 +1073,7 @@ DoFHandler<dim,spacedim>::memory_consumption () const
 
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void DoFHandler<dim,spacedim>::distribute_dofs (const FiniteElement<dim,spacedim> &ff)
 {
   selected_fe = &ff;
@@ -1109,7 +1109,7 @@ void DoFHandler<dim,spacedim>::distribute_dofs (const FiniteElement<dim,spacedim
 }
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void DoFHandler<dim, spacedim>::distribute_mg_dofs (const FiniteElement<dim, spacedim> &fe)
 {
   (void)fe;
@@ -1138,7 +1138,7 @@ void DoFHandler<dim, spacedim>::distribute_mg_dofs (const FiniteElement<dim, spa
 
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void DoFHandler<dim, spacedim>::reserve_space ()
 {
   //TODO: move this to distribute_mg_dofs and remove function
@@ -1146,7 +1146,7 @@ void DoFHandler<dim, spacedim>::reserve_space ()
 
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void DoFHandler<dim, spacedim>::clear_mg_space ()
 {
   mg_levels.clear ();
@@ -1160,7 +1160,7 @@ void DoFHandler<dim, spacedim>::clear_mg_space ()
 }
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void DoFHandler<dim,spacedim>::initialize_local_block_info ()
 {
   block_info_object.initialize_local(*this);
@@ -1168,7 +1168,7 @@ void DoFHandler<dim,spacedim>::initialize_local_block_info ()
 
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void DoFHandler<dim,spacedim>::clear ()
 {
   // release lock to old fe
@@ -1228,7 +1228,7 @@ DoFHandler<dim,spacedim>::renumber_dofs (const unsigned int,
 }
 
 
-template<>
+template <>
 void DoFHandler<1>::renumber_dofs (const unsigned int level,
                                    const std::vector<types::global_dof_index> &new_numbers)
 {
@@ -1264,7 +1264,7 @@ void DoFHandler<1>::renumber_dofs (const unsigned int level,
 
 
 
-template<>
+template <>
 void DoFHandler<2>::renumber_dofs (const unsigned int  level,
                                    const std::vector<types::global_dof_index>  &new_numbers)
 {
@@ -1324,7 +1324,7 @@ void DoFHandler<2>::renumber_dofs (const unsigned int  level,
 
 
 
-template<>
+template <>
 void DoFHandler<3>::renumber_dofs (const unsigned int  level,
                                    const std::vector<types::global_dof_index>  &new_numbers)
 {
@@ -1466,7 +1466,7 @@ DoFHandler<dim,spacedim>::max_couplings_between_boundary_dofs () const
 
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void DoFHandler<dim,spacedim>::clear_space ()
 {
   levels.clear ();
@@ -1480,8 +1480,8 @@ void DoFHandler<dim,spacedim>::clear_space ()
 
 
 
-template<int dim, int spacedim>
-template<int structdim>
+template <int dim, int spacedim>
+template <int structdim>
 types::global_dof_index
 DoFHandler<dim, spacedim>::get_dof_index (const unsigned int obj_level,
                                           const unsigned int obj_index,
@@ -1496,8 +1496,8 @@ DoFHandler<dim, spacedim>::get_dof_index (const unsigned int obj_level,
 
 
 
-template<int dim, int spacedim>
-template<int structdim>
+template <int dim, int spacedim>
+template <int structdim>
 void DoFHandler<dim, spacedim>::set_dof_index (const unsigned int obj_level,
                                                const unsigned int obj_index,
                                                const unsigned int fe_index,
@@ -1516,7 +1516,7 @@ void DoFHandler<dim, spacedim>::set_dof_index (const unsigned int obj_level,
 
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 DoFHandler<dim, spacedim>::MGVertexDoFs::MGVertexDoFs ()
   :
   coarsest_level (numbers::invalid_unsigned_int),
@@ -1527,7 +1527,7 @@ DoFHandler<dim, spacedim>::MGVertexDoFs::MGVertexDoFs ()
 
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 DoFHandler<dim, spacedim>::MGVertexDoFs::~MGVertexDoFs ()
 {
   delete[] indices;
@@ -1536,7 +1536,7 @@ DoFHandler<dim, spacedim>::MGVertexDoFs::~MGVertexDoFs ()
 
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void DoFHandler<dim, spacedim>::MGVertexDoFs::init (const unsigned int cl,
                                                     const unsigned int fl,
                                                     const unsigned int dofs_per_vertex)
@@ -1572,7 +1572,7 @@ void DoFHandler<dim, spacedim>::MGVertexDoFs::init (const unsigned int cl,
 
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 unsigned int DoFHandler<dim, spacedim>::MGVertexDoFs::get_coarsest_level () const
 {
   return coarsest_level;
@@ -1580,7 +1580,7 @@ unsigned int DoFHandler<dim, spacedim>::MGVertexDoFs::get_coarsest_level () cons
 
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 unsigned int DoFHandler<dim, spacedim>::MGVertexDoFs::get_finest_level () const
 {
   return finest_level;
index 6c03ad4e018acfb9e14c9093b2bf7b0c8d2f5f68..6b9633a1090d79371800a753cb48278b50ca0af5 100644 (file)
@@ -484,7 +484,7 @@ namespace DoFTools
 
 
 
-  template<typename DoFHandlerType>
+  template <typename DoFHandlerType>
   void
   extract_level_dofs (const unsigned int    level,
                       const DoFHandlerType &dof,
@@ -536,7 +536,7 @@ namespace DoFTools
 
 
 
-  template<typename DoFHandlerType>
+  template <typename DoFHandlerType>
   void
   extract_level_dofs (const unsigned int    level,
                       const DoFHandlerType &dof,
@@ -2081,7 +2081,7 @@ namespace DoFTools
   }
 
 
-  template<int dim, int spacedim>
+  template <int dim, int spacedim>
   void
   map_dofs_to_support_points(const hp::MappingCollection<dim, spacedim> &mapping,
                              const hp::DoFHandler<dim, spacedim>        &dof_handler,
@@ -2121,7 +2121,7 @@ namespace DoFTools
   }
 
 
-  template<int dim, int spacedim>
+  template <int dim, int spacedim>
   void
   map_dofs_to_support_points(const hp::MappingCollection<dim, spacedim> &mapping,
                              const hp::DoFHandler<dim, spacedim>        &dof_handler,
@@ -2181,7 +2181,7 @@ namespace DoFTools
   }
 
 
-  template<int dim, int spacedim>
+  template <int dim, int spacedim>
   void
   convert_couplings_to_blocks
   (const DoFHandler<dim,spacedim>  &dof_handler,
@@ -2207,7 +2207,7 @@ namespace DoFTools
   }
 
 
-  template<int dim, int spacedim>
+  template <int dim, int spacedim>
   void
   convert_couplings_to_blocks (const hp::DoFHandler<dim,spacedim> &dof_handler,
                                const Table<2, Coupling>           &table,
index 2c8347ea576bb0f90d8dc486c67f86b177e7ce72..1deb21d6ed7678d19ddb0ecf95bfbad610d48093 100644 (file)
@@ -2066,7 +2066,7 @@ namespace DoFTools
     // Build up a (possibly rotated) interpolation matrix that is used in
     // set_periodicity_constraints with the help of user supplied matrix
     // and first_vector_components.
-    template<int dim, int spacedim>
+    template <int dim, int spacedim>
     FullMatrix<double> compute_transformation(
       const FiniteElement<dim, spacedim> &fe,
       const FullMatrix<double>           &matrix,
@@ -2382,7 +2382,7 @@ namespace DoFTools
 
 
 
-  template<typename DoFHandlerType>
+  template <typename DoFHandlerType>
   void
   make_periodicity_constraints
   (const std::vector<GridTools::PeriodicFacePair<typename DoFHandlerType::cell_iterator> >
@@ -2428,7 +2428,7 @@ namespace DoFTools
   // High level interface variants:
 
 
-  template<typename DoFHandlerType>
+  template <typename DoFHandlerType>
   void
   make_periodicity_constraints (const DoFHandlerType     &dof_handler,
                                 const types::boundary_id  b_id1,
@@ -2459,7 +2459,7 @@ namespace DoFTools
 
 
 
-  template<typename DoFHandlerType>
+  template <typename DoFHandlerType>
   void
   make_periodicity_constraints (const DoFHandlerType            &dof_handler,
                                 const types::boundary_id         b_id,
index 7eae662ddae16e0d6af01b637c75051c88a12267..2127f9a59a07107cdc07b5c80e548b0393b95962 100644 (file)
@@ -68,7 +68,7 @@ FiniteElementData (const std::vector<unsigned int> &dofs_per_object,
 
 
 
-template<int dim>
+template <int dim>
 bool FiniteElementData<dim>::operator== (const FiniteElementData<dim> &f) const
 {
   return ((dofs_per_vertex == f.dofs_per_vertex) &&
index 0eeaaeb43734f9e7a70b1de5ced16e0d5864618c..27316601e1c39a20ba7eed56b384fab3a3102855 100644 (file)
@@ -66,7 +66,7 @@ namespace
   };
 
 
-  template<int dim>
+  template <int dim>
   void generate_unit_points (const unsigned int,
                              std::vector<Point<dim> > &);
 
index 7a10f5db894064cb2293a5e0914530019e2aa175..d5a640f3051780c4361bced2002e358f92a03b41 100644 (file)
@@ -1321,7 +1321,7 @@ namespace FETools
 
 
 
-  template<int dim, int spacedim>
+  template <int dim, int spacedim>
   void compute_component_wise(
     const FiniteElement<dim,spacedim> &element,
     std::vector<unsigned int> &renumbering,
@@ -1363,7 +1363,7 @@ namespace FETools
 
 
 
-  template<int dim, int spacedim>
+  template <int dim, int spacedim>
   void compute_block_renumbering (
     const FiniteElement<dim,spacedim> &element,
     std::vector<types::global_dof_index> &renumbering,
@@ -1611,7 +1611,7 @@ namespace FETools
 
 
 
-  template<int dim, int spacedim>
+  template <int dim, int spacedim>
   FullMatrix<double>
   compute_node_matrix(const FiniteElement<dim,spacedim> &fe)
   {
@@ -1666,7 +1666,7 @@ namespace FETools
 
 
   /*
-    template<>
+    template <>
     void
     compute_embedding_matrices(const FiniteElement<1,2> &,
                                std::vector<std::vector<FullMatrix<double> > > &,
@@ -1676,7 +1676,7 @@ namespace FETools
     }
 
 
-    template<>
+    template <>
     void
     compute_embedding_matrices(const FiniteElement<1,3> &,
                                std::vector<std::vector<FullMatrix<double> > > &,
@@ -1687,7 +1687,7 @@ namespace FETools
 
 
 
-    template<>
+    template <>
     void
     compute_embedding_matrices(const FiniteElement<2,3>&,
                                std::vector<std::vector<FullMatrix<double> > >&,
@@ -1700,7 +1700,7 @@ namespace FETools
 
   namespace
   {
-    template<int dim, typename number, int spacedim>
+    template <int dim, typename number, int spacedim>
     void
     compute_embedding_for_shape_function (
       const unsigned int i,
@@ -1758,7 +1758,7 @@ namespace FETools
 
 
 
-    template<int dim, typename number, int spacedim>
+    template <int dim, typename number, int spacedim>
     void
     compute_embedding_matrices_for_refinement_case (
       const FiniteElement<dim, spacedim> &fe,
index ff16ef76b096a6be66aa50180141b6a95aeee8d7..425e9864874b970791d7488667c70573d2049a5c 100644 (file)
@@ -39,7 +39,7 @@ Mapping<dim, spacedim>::get_vertices (
 }
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 Point<dim-1>
 Mapping<dim,spacedim>::
 project_real_point_to_unit_point_on_face (
index d16141702dfdd0784b437308496c575b2c90ad30..216d11aeb2030b5d091418b7a7b4d55dbd6a826c 100644 (file)
@@ -160,7 +160,7 @@ MappingC1<2>::MappingC1Generic::add_line_support_points (const Triangulation<2>:
 
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void
 MappingC1<dim,spacedim>::MappingC1Generic::add_line_support_points (const typename Triangulation<dim>::cell_iterator &,
     std::vector<Point<dim> > &) const
@@ -194,7 +194,7 @@ MappingC1<2>::MappingC1Generic::add_quad_support_points (const Triangulation<2>:
 
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void
 MappingC1<dim,spacedim>::MappingC1Generic::add_quad_support_points (const typename Triangulation<dim>::cell_iterator &,
     std::vector<Point<dim> > &) const
@@ -204,7 +204,7 @@ MappingC1<dim,spacedim>::MappingC1Generic::add_quad_support_points (const typena
 
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 Mapping<dim, spacedim> *
 MappingC1<dim,spacedim>::clone () const
 {
index 09f7ade5c3ff5cece2a01f62f39b399f98e89909..a8b4236af7f04d78fca2e28750d0f43f09bb2c9b 100644 (file)
 DEAL_II_NAMESPACE_OPEN
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 const unsigned int MappingCartesian<dim,spacedim>::invalid_face_number;
 
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 MappingCartesian<dim, spacedim>::InternalData::InternalData (const Quadrature<dim> &q)
   :
   cell_extents (numbers::signaling_nan<Tensor<1,dim> >()),
@@ -48,7 +48,7 @@ MappingCartesian<dim, spacedim>::InternalData::InternalData (const Quadrature<di
 
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 std::size_t
 MappingCartesian<dim, spacedim>::InternalData::memory_consumption () const
 {
@@ -69,7 +69,7 @@ MappingCartesian<dim,spacedim>::preserves_vertex_locations () const
 
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 UpdateFlags
 MappingCartesian<dim, spacedim>::requires_update_flags (const UpdateFlags in) const
 {
@@ -87,7 +87,7 @@ MappingCartesian<dim, spacedim>::requires_update_flags (const UpdateFlags in) co
 
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 typename Mapping<dim, spacedim>::InternalDataBase *
 MappingCartesian<dim, spacedim>::get_data (const UpdateFlags      update_flags,
                                            const Quadrature<dim> &q) const
@@ -104,7 +104,7 @@ MappingCartesian<dim, spacedim>::get_data (const UpdateFlags      update_flags,
 
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 typename Mapping<dim, spacedim>::InternalDataBase *
 MappingCartesian<dim, spacedim>::get_face_data (const UpdateFlags update_flags,
                                                 const Quadrature<dim-1>& quadrature) const
@@ -126,7 +126,7 @@ MappingCartesian<dim, spacedim>::get_face_data (const UpdateFlags update_flags,
 
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 typename Mapping<dim, spacedim>::InternalDataBase *
 MappingCartesian<dim, spacedim>::get_subface_data (const UpdateFlags update_flags,
                                                    const Quadrature<dim-1> &quadrature) const
@@ -149,7 +149,7 @@ MappingCartesian<dim, spacedim>::get_subface_data (const UpdateFlags update_flag
 
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void
 MappingCartesian<dim, spacedim>::compute_fill (const typename Triangulation<dim,spacedim>::cell_iterator &cell,
                                                const unsigned int        face_no,
@@ -333,7 +333,7 @@ MappingCartesian<dim, spacedim>::compute_fill (const typename Triangulation<dim,
 
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 CellSimilarity::Similarity
 MappingCartesian<dim, spacedim>::
 fill_fe_values (const typename Triangulation<dim,spacedim>::cell_iterator &cell,
@@ -427,7 +427,7 @@ fill_fe_values (const typename Triangulation<dim,spacedim>::cell_iterator &cell,
 
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void
 MappingCartesian<dim, spacedim>::
 fill_fe_face_values (const typename Triangulation<dim,spacedim>::cell_iterator &cell,
@@ -516,7 +516,7 @@ fill_fe_face_values (const typename Triangulation<dim,spacedim>::cell_iterator &
 
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void
 MappingCartesian<dim, spacedim>::
 fill_fe_subface_values (const typename Triangulation<dim,spacedim>::cell_iterator &cell,
@@ -613,7 +613,7 @@ fill_fe_subface_values (const typename Triangulation<dim,spacedim>::cell_iterato
 
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void
 MappingCartesian<dim,spacedim>::
 transform (const ArrayView<const Tensor<1,dim> >                  &input,
@@ -668,7 +668,7 @@ transform (const ArrayView<const Tensor<1,dim> >                  &input,
 
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void
 MappingCartesian<dim,spacedim>::
 transform (const ArrayView<const DerivativeForm<1, dim,spacedim> > &input,
@@ -769,7 +769,7 @@ transform (const ArrayView<const DerivativeForm<1, dim,spacedim> > &input,
 
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void
 MappingCartesian<dim,spacedim>::
 transform (const ArrayView<const Tensor<2, dim> >                 &input,
@@ -870,7 +870,7 @@ transform (const ArrayView<const Tensor<2, dim> >                 &input,
 }
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void
 MappingCartesian<dim,spacedim>::
 transform (const ArrayView<const  DerivativeForm<2, dim, spacedim> > &input,
@@ -908,7 +908,7 @@ transform (const ArrayView<const  DerivativeForm<2, dim, spacedim> > &input,
 
 }
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void
 MappingCartesian<dim,spacedim>::
 transform (const ArrayView<const  Tensor<3,dim> >                 &input,
@@ -1028,7 +1028,7 @@ MappingCartesian<dim, spacedim>::transform_unit_to_real_cell (
 
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 Point<dim>
 MappingCartesian<dim, spacedim>::transform_real_to_unit_cell (
   const typename Triangulation<dim,spacedim>::cell_iterator &cell,
@@ -1062,7 +1062,7 @@ MappingCartesian<dim, spacedim>::transform_real_to_unit_cell (
 }
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 Mapping<dim, spacedim> *
 MappingCartesian<dim, spacedim>::clone () const
 {
index 57af759726ddb14c46ae95092aaa9d647fa7de97..a91a96b8613a28a95475719568d0fde4a3c79393 100644 (file)
@@ -54,7 +54,7 @@
 DEAL_II_NAMESPACE_OPEN
 
 
-template<int dim, int spacedim, typename VectorType, typename DoFHandlerType>
+template <int dim, int spacedim, typename VectorType, typename DoFHandlerType>
 MappingFEField<dim,spacedim,VectorType,DoFHandlerType>::InternalData::InternalData
 (const FiniteElement<dim,spacedim> &fe,
  const ComponentMask                mask)
@@ -67,7 +67,7 @@ MappingFEField<dim,spacedim,VectorType,DoFHandlerType>::InternalData::InternalDa
 
 
 
-template<int dim, int spacedim, typename VectorType, typename DoFHandlerType>
+template <int dim, int spacedim, typename VectorType, typename DoFHandlerType>
 std::size_t
 MappingFEField<dim,spacedim,VectorType,DoFHandlerType>::InternalData::memory_consumption () const
 {
@@ -77,7 +77,7 @@ MappingFEField<dim,spacedim,VectorType,DoFHandlerType>::InternalData::memory_con
 
 
 
-template<int dim, int spacedim, typename DoFHandlerType, typename VectorType>
+template <int dim, int spacedim, typename DoFHandlerType, typename VectorType>
 double &
 MappingFEField<dim,spacedim,DoFHandlerType,VectorType>::InternalData::shape
 (const unsigned int qpoint,
@@ -90,7 +90,7 @@ MappingFEField<dim,spacedim,DoFHandlerType,VectorType>::InternalData::shape
 }
 
 
-template<int dim, int spacedim, typename DoFHandlerType, typename VectorType>
+template <int dim, int spacedim, typename DoFHandlerType, typename VectorType>
 const Tensor<1,dim> &
 MappingFEField<dim,spacedim,DoFHandlerType,VectorType>::InternalData::derivative
 (const unsigned int qpoint,
@@ -104,7 +104,7 @@ MappingFEField<dim,spacedim,DoFHandlerType,VectorType>::InternalData::derivative
 
 
 
-template<int dim, int spacedim, typename DoFHandlerType, typename VectorType>
+template <int dim, int spacedim, typename DoFHandlerType, typename VectorType>
 Tensor<1,dim> &
 MappingFEField<dim,spacedim,DoFHandlerType,VectorType>::InternalData::derivative
 (const unsigned int qpoint,
@@ -199,7 +199,7 @@ MappingFEField<dim,spacedim,DoFHandlerType,VectorType>::InternalData::fourth_der
 
 
 
-template<int dim, int spacedim, typename VectorType, typename DoFHandlerType>
+template <int dim, int spacedim, typename VectorType, typename DoFHandlerType>
 MappingFEField<dim,spacedim,VectorType,DoFHandlerType>::MappingFEField
 (const DoFHandlerType            &euler_dof_handler,
  const VectorType    &euler_vector,
@@ -222,7 +222,7 @@ MappingFEField<dim,spacedim,VectorType,DoFHandlerType>::MappingFEField
 }
 
 
-template<int dim, int spacedim, typename VectorType, typename DoFHandlerType>
+template <int dim, int spacedim, typename VectorType, typename DoFHandlerType>
 MappingFEField<dim,spacedim,VectorType,DoFHandlerType>::MappingFEField
 (const MappingFEField<dim,spacedim,VectorType,DoFHandlerType> &mapping)
   :
@@ -235,7 +235,7 @@ MappingFEField<dim,spacedim,VectorType,DoFHandlerType>::MappingFEField
 
 
 
-template<int dim, int spacedim, typename DoFHandlerType, typename VectorType>
+template <int dim, int spacedim, typename DoFHandlerType, typename VectorType>
 inline
 const double &
 MappingFEField<dim,spacedim,DoFHandlerType,VectorType>::InternalData::shape
@@ -259,7 +259,7 @@ MappingFEField<dim,spacedim,DoFHandlerType,VectorType>::preserves_vertex_locatio
 
 
 
-template<int dim, int spacedim, typename VectorType, typename DoFHandlerType>
+template <int dim, int spacedim, typename VectorType, typename DoFHandlerType>
 void
 MappingFEField<dim,spacedim,VectorType,DoFHandlerType>::
 compute_shapes_virtual (const std::vector<Point<dim> >                    &unit_points,
@@ -292,7 +292,7 @@ compute_shapes_virtual (const std::vector<Point<dim> >                    &unit_
 }
 
 
-template<int dim, int spacedim, typename VectorType, typename DoFHandlerType>
+template <int dim, int spacedim, typename VectorType, typename DoFHandlerType>
 UpdateFlags
 MappingFEField<dim,spacedim,VectorType,DoFHandlerType>::requires_update_flags (const UpdateFlags in) const
 {
@@ -351,7 +351,7 @@ MappingFEField<dim,spacedim,VectorType,DoFHandlerType>::requires_update_flags (c
 
 
 
-template<int dim, int spacedim, typename VectorType, typename DoFHandlerType>
+template <int dim, int spacedim, typename VectorType, typename DoFHandlerType>
 void
 MappingFEField<dim,spacedim,VectorType,DoFHandlerType>::compute_data
 (const UpdateFlags      update_flags,
@@ -403,7 +403,7 @@ MappingFEField<dim,spacedim,VectorType,DoFHandlerType>::compute_data
 }
 
 
-template<int dim, int spacedim, typename VectorType, typename DoFHandlerType>
+template <int dim, int spacedim, typename VectorType, typename DoFHandlerType>
 void
 MappingFEField<dim,spacedim,VectorType,DoFHandlerType>::compute_face_data
 (const UpdateFlags      update_flags,
@@ -473,7 +473,7 @@ MappingFEField<dim,spacedim,VectorType,DoFHandlerType>::compute_face_data
 }
 
 
-template<int dim, int spacedim, typename VectorType, typename DoFHandlerType>
+template <int dim, int spacedim, typename VectorType, typename DoFHandlerType>
 typename
 MappingFEField<dim,spacedim,VectorType,DoFHandlerType>::InternalData *
 MappingFEField<dim,spacedim,VectorType,DoFHandlerType>::get_data (const UpdateFlags      update_flags,
@@ -487,7 +487,7 @@ MappingFEField<dim,spacedim,VectorType,DoFHandlerType>::get_data (const UpdateFl
 
 
 
-template<int dim, int spacedim, typename VectorType, typename DoFHandlerType>
+template <int dim, int spacedim, typename VectorType, typename DoFHandlerType>
 typename Mapping<dim,spacedim>::InternalDataBase *
 MappingFEField<dim,spacedim,VectorType,DoFHandlerType>::get_face_data
 (const UpdateFlags        update_flags,
@@ -502,7 +502,7 @@ MappingFEField<dim,spacedim,VectorType,DoFHandlerType>::get_face_data
 }
 
 
-template<int dim, int spacedim, typename VectorType, typename DoFHandlerType>
+template <int dim, int spacedim, typename VectorType, typename DoFHandlerType>
 typename Mapping<dim,spacedim>::InternalDataBase *
 MappingFEField<dim,spacedim,VectorType,DoFHandlerType>::get_subface_data
 (const UpdateFlags        update_flags,
@@ -1215,7 +1215,7 @@ namespace internal
    * 'data_set' to differentiate whether we will work on a face (and if so,
    * which one) or subface.
    */
-  template<int dim, int spacedim, typename VectorType, typename DoFHandlerType>
+  template <int dim, int spacedim, typename VectorType, typename DoFHandlerType>
   void
   do_fill_fe_face_values (const dealii::Mapping<dim,spacedim>                               &mapping,
                           const typename dealii::Triangulation<dim,spacedim>::cell_iterator &cell,
@@ -1294,7 +1294,7 @@ namespace internal
 
 // Note that the CellSimilarity flag is modifiable, since MappingFEField can need to
 // recalculate data even when cells are similar.
-template<int dim, int spacedim, typename VectorType, typename DoFHandlerType>
+template <int dim, int spacedim, typename VectorType, typename DoFHandlerType>
 CellSimilarity::Similarity
 MappingFEField<dim,spacedim,VectorType,DoFHandlerType>::
 fill_fe_values (const typename Triangulation<dim,spacedim>::cell_iterator &cell,
@@ -1474,7 +1474,7 @@ fill_fe_values (const typename Triangulation<dim,spacedim>::cell_iterator &cell,
 
 
 
-template<int dim, int spacedim, typename VectorType, typename DoFHandlerType>
+template <int dim, int spacedim, typename VectorType, typename DoFHandlerType>
 void
 MappingFEField<dim,spacedim,VectorType,DoFHandlerType>::
 fill_fe_face_values (const typename Triangulation<dim,spacedim>::cell_iterator &cell,
@@ -1507,7 +1507,7 @@ fill_fe_face_values (const typename Triangulation<dim,spacedim>::cell_iterator &
 }
 
 
-template<int dim, int spacedim, typename VectorType, typename DoFHandlerType>
+template <int dim, int spacedim, typename VectorType, typename DoFHandlerType>
 void
 MappingFEField<dim,spacedim,VectorType,DoFHandlerType>::
 fill_fe_subface_values (const typename Triangulation<dim,spacedim>::cell_iterator &cell,
@@ -1544,7 +1544,7 @@ fill_fe_subface_values (const typename Triangulation<dim,spacedim>::cell_iterato
 
 namespace
 {
-  template<int dim, int spacedim, int rank, typename VectorType, typename DoFHandlerType>
+  template <int dim, int spacedim, int rank, typename VectorType, typename DoFHandlerType>
   void
   transform_fields(const ArrayView<const Tensor<rank,dim> >                &input,
                    const MappingType                                        mapping_type,
@@ -1606,7 +1606,7 @@ namespace
   }
 
 
-  template<int dim, int spacedim, int rank, typename VectorType, typename DoFHandlerType>
+  template <int dim, int spacedim, int rank, typename VectorType, typename DoFHandlerType>
   void
   transform_differential_forms
   (const ArrayView<const DerivativeForm<rank, dim,spacedim> >  &input,
@@ -1642,7 +1642,7 @@ namespace
 
 
 
-template<int dim, int spacedim, typename VectorType, typename DoFHandlerType>
+template <int dim, int spacedim, typename VectorType, typename DoFHandlerType>
 void
 MappingFEField<dim,spacedim,VectorType,DoFHandlerType>::
 transform (const ArrayView<const Tensor<1,dim> >                  &input,
@@ -1657,7 +1657,7 @@ transform (const ArrayView<const Tensor<1,dim> >                  &input,
 
 
 
-template<int dim, int spacedim, typename VectorType, typename DoFHandlerType>
+template <int dim, int spacedim, typename VectorType, typename DoFHandlerType>
 void
 MappingFEField<dim,spacedim,VectorType,DoFHandlerType>::
 transform (const ArrayView<const DerivativeForm<1, dim, spacedim> > &input,
@@ -1672,7 +1672,7 @@ transform (const ArrayView<const DerivativeForm<1, dim, spacedim> > &input,
 
 
 
-template<int dim, int spacedim, typename VectorType, typename DoFHandlerType>
+template <int dim, int spacedim, typename VectorType, typename DoFHandlerType>
 void
 MappingFEField<dim,spacedim,VectorType,DoFHandlerType>::
 transform (const ArrayView<const Tensor<2, dim> >                 &input,
@@ -1690,7 +1690,7 @@ transform (const ArrayView<const Tensor<2, dim> >                 &input,
 
 
 
-template<int dim, int spacedim, typename VectorType, typename DoFHandlerType>
+template <int dim, int spacedim, typename VectorType, typename DoFHandlerType>
 void
 MappingFEField<dim,spacedim,VectorType,DoFHandlerType>::
 transform (const ArrayView<const DerivativeForm<2, dim, spacedim> >  &input,
@@ -1739,7 +1739,7 @@ transform (const ArrayView<const DerivativeForm<2, dim, spacedim> >  &input,
 
 
 
-template<int dim, int spacedim, typename VectorType, typename DoFHandlerType>
+template <int dim, int spacedim, typename VectorType, typename DoFHandlerType>
 void
 MappingFEField<dim,spacedim,VectorType,DoFHandlerType>::
 transform (const ArrayView<const Tensor<3,dim> >                  &input,
@@ -1759,7 +1759,7 @@ transform (const ArrayView<const Tensor<3,dim> >                  &input,
 
 
 
-template<int dim, int spacedim, typename VectorType, typename DoFHandlerType>
+template <int dim, int spacedim, typename VectorType, typename DoFHandlerType>
 Point<spacedim>
 MappingFEField<dim,spacedim,VectorType,DoFHandlerType>::
 transform_unit_to_real_cell (const typename Triangulation<dim,spacedim>::cell_iterator &cell,
@@ -1778,7 +1778,7 @@ transform_unit_to_real_cell (const typename Triangulation<dim,spacedim>::cell_it
 }
 
 
-template<int dim, int spacedim, typename VectorType, typename DoFHandlerType>
+template <int dim, int spacedim, typename VectorType, typename DoFHandlerType>
 Point<spacedim>
 MappingFEField<dim,spacedim,VectorType,DoFHandlerType>::
 do_transform_unit_to_real_cell (const InternalData &data) const
@@ -1797,7 +1797,7 @@ do_transform_unit_to_real_cell (const InternalData &data) const
 
 
 
-template<int dim, int spacedim, typename VectorType, typename DoFHandlerType>
+template <int dim, int spacedim, typename VectorType, typename DoFHandlerType>
 Point<dim>
 MappingFEField<dim,spacedim,VectorType,DoFHandlerType>::
 transform_real_to_unit_cell (const typename Triangulation<dim,spacedim>::cell_iterator &cell,
@@ -1840,7 +1840,7 @@ transform_real_to_unit_cell (const typename Triangulation<dim,spacedim>::cell_it
 }
 
 
-template<int dim, int spacedim, typename VectorType, typename DoFHandlerType>
+template <int dim, int spacedim, typename VectorType, typename DoFHandlerType>
 Point<dim>
 MappingFEField<dim,spacedim,VectorType,DoFHandlerType>::
 do_transform_real_to_unit_cell
@@ -1948,7 +1948,7 @@ failure:
 }
 
 
-template<int dim, int spacedim, typename VectorType, typename DoFHandlerType>
+template <int dim, int spacedim, typename VectorType, typename DoFHandlerType>
 unsigned int
 MappingFEField<dim,spacedim,VectorType,DoFHandlerType>::get_degree() const
 {
@@ -1956,7 +1956,7 @@ MappingFEField<dim,spacedim,VectorType,DoFHandlerType>::get_degree() const
 }
 
 
-template<int dim, int spacedim, typename VectorType, typename DoFHandlerType>
+template <int dim, int spacedim, typename VectorType, typename DoFHandlerType>
 ComponentMask
 MappingFEField<dim,spacedim,VectorType,DoFHandlerType>::get_component_mask() const
 {
@@ -1964,7 +1964,7 @@ MappingFEField<dim,spacedim,VectorType,DoFHandlerType>::get_component_mask() con
 }
 
 
-template<int dim, int spacedim, typename VectorType, typename DoFHandlerType>
+template <int dim, int spacedim, typename VectorType, typename DoFHandlerType>
 Mapping<dim,spacedim> *
 MappingFEField<dim,spacedim,VectorType,DoFHandlerType>::clone () const
 {
@@ -1972,7 +1972,7 @@ MappingFEField<dim,spacedim,VectorType,DoFHandlerType>::clone () const
 }
 
 
-template<int dim, int spacedim, typename VectorType, typename DoFHandlerType>
+template <int dim, int spacedim, typename VectorType, typename DoFHandlerType>
 void
 MappingFEField<dim,spacedim,VectorType,DoFHandlerType>::update_internal_dofs
 (const typename Triangulation<dim,spacedim>::cell_iterator  &cell,
index 39d0b99c49cf044f498bcf2dcceab43df3b3fd5a..2c8297ca8c440da734ed1c0b6a3284eac7100364 100644 (file)
 
 DEAL_II_NAMESPACE_OPEN
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 MappingManifold<dim,spacedim>::InternalData::InternalData ()
 {}
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 std::size_t
 MappingManifold<dim,spacedim>::InternalData::memory_consumption () const
 {
@@ -173,19 +173,19 @@ initialize_face (const UpdateFlags      update_flags,
 
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 MappingManifold<dim,spacedim>::MappingManifold ()
 {}
 
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 MappingManifold<dim,spacedim>::MappingManifold (const MappingManifold<dim,spacedim> &)
 {}
 
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 Mapping<dim,spacedim> *
 MappingManifold<dim,spacedim>::clone () const
 {
@@ -194,7 +194,7 @@ MappingManifold<dim,spacedim>::clone () const
 
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 Point<dim>
 MappingManifold<dim,spacedim>::
 transform_real_to_unit_cell (const typename Triangulation<dim,spacedim>::cell_iterator &,
@@ -206,7 +206,7 @@ transform_real_to_unit_cell (const typename Triangulation<dim,spacedim>::cell_it
 
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 Point<spacedim>
 MappingManifold<dim,spacedim>::
 transform_unit_to_real_cell (const typename Triangulation<dim,spacedim>::cell_iterator &cell,
@@ -237,7 +237,7 @@ class MappingManifold<3,4>
 
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 UpdateFlags
 MappingManifold<dim,spacedim>::requires_update_flags (const UpdateFlags in) const
 {
@@ -304,7 +304,7 @@ MappingManifold<dim,spacedim>::requires_update_flags (const UpdateFlags in) cons
 
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 typename MappingManifold<dim,spacedim>::InternalData *
 MappingManifold<dim,spacedim>::get_data (const UpdateFlags update_flags,
                                          const Quadrature<dim> &q) const
@@ -317,7 +317,7 @@ MappingManifold<dim,spacedim>::get_data (const UpdateFlags update_flags,
 
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 typename MappingManifold<dim,spacedim>::InternalData *
 MappingManifold<dim,spacedim>::get_face_data (const UpdateFlags        update_flags,
                                               const Quadrature<dim-1> &quadrature) const
@@ -332,7 +332,7 @@ MappingManifold<dim,spacedim>::get_face_data (const UpdateFlags        update_fl
 
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 typename MappingManifold<dim,spacedim>::InternalData *
 MappingManifold<dim,spacedim>::get_subface_data (const UpdateFlags update_flags,
                                                  const Quadrature<dim-1>& quadrature) const
@@ -356,7 +356,7 @@ namespace internal
      * are no Manifolds associated to faces. The mapping argument is
      * only used to help the compiler infer dim and spacedim.
      */
-    template<int spacedim>
+    template <int spacedim>
     const dealii::Manifold<1, spacedim> &
     get_face_manifold(const MappingManifold<1,spacedim> &,
                       const typename dealii::Triangulation<1,spacedim>::cell_iterator &cell,
@@ -371,7 +371,7 @@ namespace internal
      * Some specialization for face Manifolds. The mapping argument is
      * only used to help the compiler infer dim and spacedim.
      */
-    template<int dim, int spacedim>
+    template <int dim, int spacedim>
     const dealii::Manifold<dim,spacedim> &
     get_face_manifold(const MappingManifold<dim,spacedim> &,
                       const typename dealii::Triangulation<dim,spacedim>::cell_iterator &cell,
@@ -501,7 +501,7 @@ namespace internal
 
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 CellSimilarity::Similarity
 MappingManifold<dim,spacedim>::
 fill_fe_values (const typename Triangulation<dim,spacedim>::cell_iterator &cell,
@@ -809,7 +809,7 @@ namespace internal
      * using the 'data_set' to differentiate whether we will
      * work on a face (and if so, which one) or subface.
      */
-    template<int dim, int spacedim>
+    template <int dim, int spacedim>
     void
     do_fill_fe_face_values (const dealii::MappingManifold<dim,spacedim>                       &mapping,
                             const typename dealii::Triangulation<dim,spacedim>::cell_iterator &cell,
@@ -840,7 +840,7 @@ namespace internal
 
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void
 MappingManifold<dim,spacedim>::
 fill_fe_face_values (const typename Triangulation<dim,spacedim>::cell_iterator &cell,
@@ -869,7 +869,7 @@ fill_fe_face_values (const typename Triangulation<dim,spacedim>::cell_iterator &
 
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void
 MappingManifold<dim,spacedim>::
 fill_fe_subface_values (const typename Triangulation<dim,spacedim>::cell_iterator &cell,
@@ -1188,7 +1188,7 @@ namespace
 
 
 
-  template<int dim, int spacedim, int rank>
+  template <int dim, int spacedim, int rank>
   void
   transform_differential_forms(const ArrayView<const DerivativeForm<rank, dim,spacedim> >   &input,
                                const MappingType                                             mapping_type,
@@ -1221,7 +1221,7 @@ namespace
 
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void
 MappingManifold<dim,spacedim>::
 transform (const ArrayView<const Tensor<1, dim> >                  &input,
@@ -1234,7 +1234,7 @@ transform (const ArrayView<const Tensor<1, dim> >                  &input,
 
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void
 MappingManifold<dim,spacedim>::
 transform (const ArrayView<const DerivativeForm<1, dim,spacedim> >  &input,
@@ -1247,7 +1247,7 @@ transform (const ArrayView<const DerivativeForm<1, dim,spacedim> >  &input,
 
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void
 MappingManifold<dim,spacedim>::
 transform (const ArrayView<const Tensor<2, dim> >                  &input,
@@ -1273,7 +1273,7 @@ transform (const ArrayView<const Tensor<2, dim> >                  &input,
 
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void
 MappingManifold<dim,spacedim>::
 transform (const ArrayView<const  DerivativeForm<2, dim, spacedim> > &input,
@@ -1322,7 +1322,7 @@ transform (const ArrayView<const  DerivativeForm<2, dim, spacedim> > &input,
 
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void
 MappingManifold<dim,spacedim>::
 transform (const ArrayView<const  Tensor<3,dim> >                  &input,
index dadfad5fe8361b8df19e3eaa2c3242350ec5e652..340f7ba76c10e9bee844fb74558d2a6cffe410d6 100644 (file)
@@ -32,7 +32,7 @@
 DEAL_II_NAMESPACE_OPEN
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 MappingQ<dim,spacedim>::InternalData::InternalData ()
   :
   use_mapping_q1_on_current_cell(false)
@@ -40,7 +40,7 @@ MappingQ<dim,spacedim>::InternalData::InternalData ()
 
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 std::size_t
 MappingQ<dim,spacedim>::InternalData::memory_consumption () const
 {
@@ -52,7 +52,7 @@ MappingQ<dim,spacedim>::InternalData::memory_consumption () const
 
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 MappingQ<dim,spacedim>::MappingQ (const unsigned int degree,
                                   const bool use_mapping_q_on_all_cells)
   :
@@ -83,7 +83,7 @@ MappingQ<dim,spacedim>::MappingQ (const unsigned int degree,
 
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 MappingQ<dim,spacedim>::MappingQ (const MappingQ<dim,spacedim> &mapping)
   :
   polynomial_degree (mapping.polynomial_degree),
@@ -102,7 +102,7 @@ MappingQ<dim,spacedim>::MappingQ (const MappingQ<dim,spacedim> &mapping)
 
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 unsigned int
 MappingQ<dim,spacedim>::get_degree() const
 {
@@ -121,7 +121,7 @@ MappingQ<dim,spacedim>::preserves_vertex_locations () const
 
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 UpdateFlags
 MappingQ<dim,spacedim>::requires_update_flags (const UpdateFlags in) const
 {
@@ -132,7 +132,7 @@ MappingQ<dim,spacedim>::requires_update_flags (const UpdateFlags in) const
 
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 typename MappingQ<dim,spacedim>::InternalData *
 MappingQ<dim,spacedim>::get_data (const UpdateFlags update_flags,
                                   const Quadrature<dim> &quadrature) const
@@ -156,7 +156,7 @@ MappingQ<dim,spacedim>::get_data (const UpdateFlags update_flags,
 
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 typename MappingQ<dim,spacedim>::InternalData *
 MappingQ<dim,spacedim>::get_face_data (const UpdateFlags update_flags,
                                        const Quadrature<dim-1>& quadrature) const
@@ -180,7 +180,7 @@ MappingQ<dim,spacedim>::get_face_data (const UpdateFlags update_flags,
 
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 typename MappingQ<dim,spacedim>::InternalData *
 MappingQ<dim,spacedim>::get_subface_data (const UpdateFlags update_flags,
                                           const Quadrature<dim-1>& quadrature) const
@@ -205,7 +205,7 @@ MappingQ<dim,spacedim>::get_subface_data (const UpdateFlags update_flags,
 
 // Note that the CellSimilarity flag is modifiable, since MappingQ can need to
 // recalculate data even when cells are similar.
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 CellSimilarity::Similarity
 MappingQ<dim,spacedim>::
 fill_fe_values (const typename Triangulation<dim,spacedim>::cell_iterator &cell,
@@ -260,7 +260,7 @@ fill_fe_values (const typename Triangulation<dim,spacedim>::cell_iterator &cell,
 
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void
 MappingQ<dim,spacedim>::
 fill_fe_face_values (const typename Triangulation<dim,spacedim>::cell_iterator &cell,
@@ -301,7 +301,7 @@ fill_fe_face_values (const typename Triangulation<dim,spacedim>::cell_iterator &
 }
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void
 MappingQ<dim,spacedim>::
 fill_fe_subface_values (const typename Triangulation<dim,spacedim>::cell_iterator &cell,
@@ -346,7 +346,7 @@ fill_fe_subface_values (const typename Triangulation<dim,spacedim>::cell_iterato
 
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void
 MappingQ<dim,spacedim>::
 transform (const ArrayView<const Tensor<1,dim> >                  &input,
@@ -370,7 +370,7 @@ transform (const ArrayView<const Tensor<1,dim> >                  &input,
 
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void
 MappingQ<dim,spacedim>::
 transform (const ArrayView<const DerivativeForm<1, dim, spacedim> >  &input,
@@ -394,7 +394,7 @@ transform (const ArrayView<const DerivativeForm<1, dim, spacedim> >  &input,
 
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void
 MappingQ<dim,spacedim>::
 transform (const ArrayView<const Tensor<2, dim> >                 &input,
@@ -418,7 +418,7 @@ transform (const ArrayView<const Tensor<2, dim> >                 &input,
 
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void
 MappingQ<dim,spacedim>::
 transform (const ArrayView<const DerivativeForm<2, dim,spacedim> >  &input,
@@ -442,7 +442,7 @@ transform (const ArrayView<const DerivativeForm<2, dim,spacedim> >  &input,
 
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void MappingQ<dim,spacedim>::
 transform (const ArrayView<const Tensor<3, dim> >                 &input,
            const MappingType                                       mapping_type,
@@ -465,7 +465,7 @@ transform (const ArrayView<const Tensor<3, dim> >                 &input,
 
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 Point<spacedim>
 MappingQ<dim,spacedim>::
 transform_unit_to_real_cell (const typename Triangulation<dim,spacedim>::cell_iterator &cell,
@@ -482,7 +482,7 @@ transform_unit_to_real_cell (const typename Triangulation<dim,spacedim>::cell_it
 
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 Point<dim>
 MappingQ<dim,spacedim>::
 transform_real_to_unit_cell (const typename Triangulation<dim,spacedim>::cell_iterator &cell,
@@ -500,7 +500,7 @@ transform_real_to_unit_cell (const typename Triangulation<dim,spacedim>::cell_it
 
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 Mapping<dim,spacedim> *
 MappingQ<dim,spacedim>::clone () const
 {
index b8cd975c96a375ecca059bcca186d6dddbef9243..8484d8bfa4f659f27a90a7bfd3f3c208dc1d32fc 100644 (file)
@@ -40,7 +40,7 @@ DEAL_II_NAMESPACE_OPEN
 
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 MappingQ1<dim,spacedim>::MappingQ1 ()
   :
   MappingQGeneric<dim,spacedim> (1)
@@ -48,7 +48,7 @@ MappingQ1<dim,spacedim>::MappingQ1 ()
 
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 MappingQ1<dim,spacedim> *
 MappingQ1<dim,spacedim>::clone () const
 {
@@ -58,7 +58,7 @@ MappingQ1<dim,spacedim>::clone () const
 //---------------------------------------------------------------------------
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 MappingQGeneric<dim,spacedim>
 StaticMappingQ1<dim,spacedim>::mapping = MappingQGeneric<dim,spacedim>(1);
 
index 9360e8ae5080065c18000aaf2b92dd4de569425c..b8c9f1c0a3e9b9d104ef34c5b7140b7d0454c021 100644 (file)
@@ -96,7 +96,7 @@ get_vertices
 
 
 
-template<int dim, class VectorType, int spacedim>
+template <int dim, class VectorType, int spacedim>
 std::vector<Point<spacedim> >
 MappingQ1Eulerian<dim,VectorType,spacedim>::
 compute_mapping_support_points(const typename Triangulation<dim,spacedim>::cell_iterator &cell) const
@@ -124,7 +124,7 @@ MappingQ1Eulerian<dim, VectorType, spacedim>::clone () const
 
 
 
-template<int dim, class VectorType, int spacedim>
+template <int dim, class VectorType, int spacedim>
 CellSimilarity::Similarity
 MappingQ1Eulerian<dim,VectorType,spacedim>::
 fill_fe_values (const typename Triangulation<dim,spacedim>::cell_iterator &cell,
index 39250e5d7a71546276c339d85fab5305dea6b441..defebfd2f2f9037b2ee4c4a0fe5be5bc004ecbf2 100644 (file)
@@ -227,7 +227,7 @@ compute_mapping_support_points (const typename Triangulation<dim,spacedim>::cell
 
 
 
-template<int dim, class VectorType, int spacedim>
+template <int dim, class VectorType, int spacedim>
 CellSimilarity::Similarity
 MappingQEulerian<dim,VectorType,spacedim>::
 fill_fe_values (const typename Triangulation<dim,spacedim>::cell_iterator &cell,
index aea160c36931089a0d20d17a7cd0e72eafd8913f..97f3d31512eb7720ff111b04e1c69225348cc833 100644 (file)
@@ -67,7 +67,7 @@ namespace internal
       // expanded before the compiler eliminates code due to the 'if (dim ==
       // spacedim)' statement (see the body of the general
       // transform_real_to_unit_cell).
-      template<int spacedim>
+      template <int spacedim>
       Point<1>
       transform_real_to_unit_cell
       (const std::array<Point<spacedim>, GeometryInfo<1>::vertices_per_cell> &vertices,
@@ -79,7 +79,7 @@ namespace internal
 
 
 
-      template<int spacedim>
+      template <int spacedim>
       Point<2>
       transform_real_to_unit_cell
       (const std::array<Point<spacedim>, GeometryInfo<2>::vertices_per_cell> &vertices,
@@ -175,7 +175,7 @@ namespace internal
 
 
 
-      template<int spacedim>
+      template <int spacedim>
       Point<3>
       transform_real_to_unit_cell
       (const std::array<Point<spacedim>, GeometryInfo<3>::vertices_per_cell> &/*vertices*/,
@@ -590,7 +590,7 @@ namespace internal
 
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 MappingQGeneric<dim,spacedim>::InternalData::InternalData (const unsigned int polynomial_degree)
   :
   polynomial_degree (polynomial_degree),
@@ -600,7 +600,7 @@ MappingQGeneric<dim,spacedim>::InternalData::InternalData (const unsigned int po
 
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 std::size_t
 MappingQGeneric<dim,spacedim>::InternalData::memory_consumption () const
 {
@@ -764,7 +764,7 @@ initialize_face (const UpdateFlags      update_flags,
 
 
 
-template<>
+template <>
 void
 MappingQGeneric<1,1>::InternalData::
 compute_shape_function_values (const std::vector<Point<1> > &unit_points)
@@ -782,7 +782,7 @@ compute_shape_function_values (const std::vector<Point<1> > &unit_points)
     }
 }
 
-template<>
+template <>
 void
 MappingQGeneric<2,2>::InternalData::
 compute_shape_function_values (const std::vector<Point<2> > &unit_points)
@@ -800,7 +800,7 @@ compute_shape_function_values (const std::vector<Point<2> > &unit_points)
     }
 }
 
-template<>
+template <>
 void
 MappingQGeneric<3,3>::InternalData::
 compute_shape_function_values (const std::vector<Point<3> > &unit_points)
@@ -818,7 +818,7 @@ compute_shape_function_values (const std::vector<Point<3> > &unit_points)
     }
 }
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void
 MappingQGeneric<dim,spacedim>::InternalData::
 compute_shape_function_values (const std::vector<Point<dim> > &unit_points)
@@ -841,7 +841,7 @@ namespace
    * For the definition of the <tt>support_point_weights_on_quad(hex)</tt> please
    * refer to equation (8) of the `mapping' report.
    */
-  template<int dim>
+  template <int dim>
   Table<2,double>
   compute_laplace_vector(const unsigned int polynomial_degree)
   {
@@ -1092,7 +1092,7 @@ namespace
 
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 MappingQGeneric<dim,spacedim>::MappingQGeneric (const unsigned int p)
   :
   polynomial_degree(p),
@@ -1107,7 +1107,7 @@ MappingQGeneric<dim,spacedim>::MappingQGeneric (const unsigned int p)
 
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 MappingQGeneric<dim,spacedim>::MappingQGeneric (const MappingQGeneric<dim,spacedim> &mapping)
   :
   polynomial_degree(mapping.polynomial_degree),
@@ -1120,7 +1120,7 @@ MappingQGeneric<dim,spacedim>::MappingQGeneric (const MappingQGeneric<dim,spaced
 
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 Mapping<dim,spacedim> *
 MappingQGeneric<dim,spacedim>::clone () const
 {
@@ -1130,7 +1130,7 @@ MappingQGeneric<dim,spacedim>::clone () const
 
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 unsigned int
 MappingQGeneric<dim,spacedim>::get_degree() const
 {
@@ -1139,7 +1139,7 @@ MappingQGeneric<dim,spacedim>::get_degree() const
 
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 Point<spacedim>
 MappingQGeneric<dim,spacedim>::
 transform_unit_to_real_cell (const typename Triangulation<dim,spacedim>::cell_iterator &cell,
@@ -1189,7 +1189,7 @@ namespace
    * support points (stored in data.mapping_support_points), compute
    * the mapped location of that point in real space.
    */
-  template<int dim, int spacedim>
+  template <int dim, int spacedim>
   Point<spacedim>
   compute_mapped_location_of_point (const typename MappingQGeneric<dim,spacedim>::InternalData &data)
   {
@@ -1508,7 +1508,7 @@ namespace
 // use template specialization to make sure we pick up the right function to
 // call:
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 Point<dim>
 MappingQGeneric<dim,spacedim>::
 transform_real_to_unit_cell_internal
@@ -1521,7 +1521,7 @@ transform_real_to_unit_cell_internal
   return Point<dim>();
 }
 
-template<>
+template <>
 Point<1>
 MappingQGeneric<1,1>::
 transform_real_to_unit_cell_internal
@@ -1547,7 +1547,7 @@ transform_real_to_unit_cell_internal
   return do_transform_real_to_unit_cell_internal<1>(cell, p, initial_p_unit, *mdata);
 }
 
-template<>
+template <>
 Point<2>
 MappingQGeneric<2, 2>::
 transform_real_to_unit_cell_internal
@@ -1573,7 +1573,7 @@ transform_real_to_unit_cell_internal
   return do_transform_real_to_unit_cell_internal<2>(cell, p, initial_p_unit, *mdata);
 }
 
-template<>
+template <>
 Point<3>
 MappingQGeneric<3, 3>::
 transform_real_to_unit_cell_internal
@@ -1599,7 +1599,7 @@ transform_real_to_unit_cell_internal
   return do_transform_real_to_unit_cell_internal<3>(cell, p, initial_p_unit, *mdata);
 }
 
-template<>
+template <>
 Point<1>
 MappingQGeneric<1, 2>::
 transform_real_to_unit_cell_internal
@@ -1625,7 +1625,7 @@ transform_real_to_unit_cell_internal
   return do_transform_real_to_unit_cell_internal_codim1<1>(cell, p, initial_p_unit, *mdata);
 }
 
-template<>
+template <>
 Point<2>
 MappingQGeneric<2, 3>::
 transform_real_to_unit_cell_internal
@@ -1651,7 +1651,7 @@ transform_real_to_unit_cell_internal
   return do_transform_real_to_unit_cell_internal_codim1<2>(cell, p, initial_p_unit, *mdata);
 }
 
-template<>
+template <>
 Point<1>
 MappingQGeneric<1, 3>::
 transform_real_to_unit_cell_internal
@@ -1665,7 +1665,7 @@ transform_real_to_unit_cell_internal
 
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 Point<dim>
 MappingQGeneric<dim,spacedim>::
 transform_real_to_unit_cell (const typename Triangulation<dim,spacedim>::cell_iterator &cell,
@@ -1797,7 +1797,7 @@ transform_real_to_unit_cell (const typename Triangulation<dim,spacedim>::cell_it
 
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 UpdateFlags
 MappingQGeneric<dim,spacedim>::requires_update_flags (const UpdateFlags in) const
 {
@@ -1857,7 +1857,7 @@ MappingQGeneric<dim,spacedim>::requires_update_flags (const UpdateFlags in) cons
 
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 typename MappingQGeneric<dim,spacedim>::InternalData *
 MappingQGeneric<dim,spacedim>::get_data (const UpdateFlags update_flags,
                                          const Quadrature<dim> &q) const
@@ -1870,7 +1870,7 @@ MappingQGeneric<dim,spacedim>::get_data (const UpdateFlags update_flags,
 
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 typename MappingQGeneric<dim,spacedim>::InternalData *
 MappingQGeneric<dim,spacedim>::get_face_data (const UpdateFlags        update_flags,
                                               const Quadrature<dim-1> &quadrature) const
@@ -1885,7 +1885,7 @@ MappingQGeneric<dim,spacedim>::get_face_data (const UpdateFlags        update_fl
 
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 typename MappingQGeneric<dim,spacedim>::InternalData *
 MappingQGeneric<dim,spacedim>::get_subface_data (const UpdateFlags update_flags,
                                                  const Quadrature<dim-1>& quadrature) const
@@ -2445,7 +2445,7 @@ namespace internal
 
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 CellSimilarity::Similarity
 MappingQGeneric<dim,spacedim>::
 fill_fe_values (const typename Triangulation<dim,spacedim>::cell_iterator &cell,
@@ -2801,7 +2801,7 @@ namespace internal
      * using the 'data_set' to differentiate whether we will
      * work on a face (and if so, which one) or subface.
      */
-    template<int dim, int spacedim>
+    template <int dim, int spacedim>
     void
     do_fill_fe_face_values (const dealii::MappingQGeneric<dim,spacedim>                             &mapping,
                             const typename dealii::Triangulation<dim,spacedim>::cell_iterator &cell,
@@ -2853,7 +2853,7 @@ namespace internal
 
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void
 MappingQGeneric<dim,spacedim>::
 fill_fe_face_values (const typename Triangulation<dim,spacedim>::cell_iterator &cell,
@@ -2897,7 +2897,7 @@ fill_fe_face_values (const typename Triangulation<dim,spacedim>::cell_iterator &
 
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void
 MappingQGeneric<dim,spacedim>::
 fill_fe_subface_values (const typename Triangulation<dim,spacedim>::cell_iterator &cell,
@@ -3231,7 +3231,7 @@ namespace
 
 
 
-  template<int dim, int spacedim, int rank>
+  template <int dim, int spacedim, int rank>
   void
   transform_differential_forms(const ArrayView<const DerivativeForm<rank, dim,spacedim> >   &input,
                                const MappingType                                             mapping_type,
@@ -3264,7 +3264,7 @@ namespace
 
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void
 MappingQGeneric<dim,spacedim>::
 transform (const ArrayView<const Tensor<1, dim> >                  &input,
@@ -3277,7 +3277,7 @@ transform (const ArrayView<const Tensor<1, dim> >                  &input,
 
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void
 MappingQGeneric<dim,spacedim>::
 transform (const ArrayView<const DerivativeForm<1, dim,spacedim> >  &input,
@@ -3290,7 +3290,7 @@ transform (const ArrayView<const DerivativeForm<1, dim,spacedim> >  &input,
 
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void
 MappingQGeneric<dim,spacedim>::
 transform (const ArrayView<const Tensor<2, dim> >                  &input,
@@ -3316,7 +3316,7 @@ transform (const ArrayView<const Tensor<2, dim> >                  &input,
 
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void
 MappingQGeneric<dim,spacedim>::
 transform (const ArrayView<const  DerivativeForm<2, dim, spacedim> > &input,
@@ -3365,7 +3365,7 @@ transform (const ArrayView<const  DerivativeForm<2, dim, spacedim> > &input,
 
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void
 MappingQGeneric<dim,spacedim>::
 transform (const ArrayView<const  Tensor<3,dim> >                  &input,
@@ -3615,7 +3615,7 @@ add_quad_support_points(const typename Triangulation<dim,spacedim>::cell_iterato
 
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 std::vector<Point<spacedim> >
 MappingQGeneric<dim,spacedim>::
 compute_mapping_support_points(const typename Triangulation<dim,spacedim>::cell_iterator &cell) const
index 2f148fa0980166f09863e6029b7404fe2baf5b0a..40356f743f636d18905b1b45671b59bb16d1095f 100644 (file)
@@ -84,7 +84,7 @@ namespace GridGenerator
 
 
 
-    template<int spacedim>
+    template <int spacedim>
     void
     colorize_subdivided_hyper_rectangle (Triangulation<1,spacedim> &tria,
                                          const Point<spacedim> &,
@@ -584,7 +584,7 @@ namespace GridGenerator
 
 
 
-  template<>
+  template <>
   void
   torus<2,3> (Triangulation<2,3>  &tria,
               const double R,
@@ -722,7 +722,7 @@ namespace GridGenerator
     tria.set_all_manifold_ids(0);
   }
 
-  template<>
+  template <>
   void
   torus<3,3> (Triangulation<3,3>  &tria,
               const double R,
@@ -776,7 +776,7 @@ namespace GridGenerator
 
 
 
-  template<>
+  template <>
   void
   parallelogram (Triangulation<3> &,
                  const Point<3>   ( &/*corners*/)[3],
@@ -785,7 +785,7 @@ namespace GridGenerator
     Assert (false, ExcNotImplemented());
   }
 
-  template<>
+  template <>
   void
   parallelogram (Triangulation<1> &,
                  const Point<1>   ( &/*corners*/)[1],
@@ -795,7 +795,7 @@ namespace GridGenerator
   }
 
 // Implementation for 2D only
-  template<>
+  template <>
   void
   parallelogram (Triangulation<2>  &tria,
                  const Point<2> (&corners)[2],
@@ -811,7 +811,7 @@ namespace GridGenerator
 
 
 
-  template<int dim>
+  template <int dim>
   void
   parallelepiped (Triangulation<dim>  &tria,
                   const Point<dim>   (&corners) [dim],
@@ -827,7 +827,7 @@ namespace GridGenerator
                                colorize);
   }
 
-  template<int dim>
+  template <int dim>
   void
   subdivided_parallelepiped (Triangulation<dim>  &tria,
                              const unsigned int      n_subdivisions,
@@ -846,7 +846,7 @@ namespace GridGenerator
                                colorize);
   }
 
-  template<int dim>
+  template <int dim>
   void
   subdivided_parallelepiped (Triangulation<dim>  &tria,
 #ifndef _MSC_VER
index 67535e8c572ddfb9c36531b700a3c09f5fdce8b8..7a12b1fe0ea91c087e32b072118f531f4cb83948 100644 (file)
@@ -94,7 +94,7 @@ void GridIn<dim, spacedim>::attach_triangulation (Triangulation<dim, spacedim> &
 
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void GridIn<dim, spacedim>::read_vtk(std::istream &in)
 {
   Assert((dim == 2)||(dim == 3), ExcNotImplemented());
@@ -381,7 +381,7 @@ void GridIn<dim, spacedim>::read_vtk(std::istream &in)
 
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void GridIn<dim, spacedim>::read_unv(std::istream &in)
 {
   Assert(tria != nullptr, ExcNoTriangulationSelected());
index e1f9f0338b4b04ffcf8dfda39d0c4c5e2b5060e1..1aff505e355150ba44f64b4a66510e3817aafbc6 100644 (file)
@@ -1100,7 +1100,7 @@ GridReordering<dim,spacedim>::reorder_cells (std::vector<CellData<dim> > &cells,
 
 
 
-template<>
+template <>
 void
 GridReordering<1>::invert_all_cells_of_negative_grid(const std::vector<Point<1> > &,
                                                      std::vector<CellData<1> > &)
@@ -1110,7 +1110,7 @@ GridReordering<1>::invert_all_cells_of_negative_grid(const std::vector<Point<1>
 
 
 
-template<>
+template <>
 void
 GridReordering<1,2>::invert_all_cells_of_negative_grid(const std::vector<Point<2> > &,
                                                        std::vector<CellData<1> > &)
@@ -1120,7 +1120,7 @@ GridReordering<1,2>::invert_all_cells_of_negative_grid(const std::vector<Point<2
 
 
 
-template<>
+template <>
 void
 GridReordering<1,3>::invert_all_cells_of_negative_grid(const std::vector<Point<3> > &,
                                                        std::vector<CellData<1> > &)
@@ -1129,7 +1129,7 @@ GridReordering<1,3>::invert_all_cells_of_negative_grid(const std::vector<Point<3
 }
 
 
-template<>
+template <>
 void
 GridReordering<2>::invert_all_cells_of_negative_grid(const std::vector<Point<2> > &all_vertices,
                                                      std::vector<CellData<2> >    &cells)
@@ -1185,7 +1185,7 @@ GridReordering<2>::invert_all_cells_of_negative_grid(const std::vector<Point<2>
 
 
 
-template<>
+template <>
 void
 GridReordering<2,3>::invert_all_cells_of_negative_grid(const std::vector<Point<3> > &,
                                                        std::vector<CellData<2> > &)
@@ -1195,7 +1195,7 @@ GridReordering<2,3>::invert_all_cells_of_negative_grid(const std::vector<Point<3
 
 
 
-template<>
+template <>
 void
 GridReordering<3>::invert_all_cells_of_negative_grid(const std::vector<Point<3> > &all_vertices,
                                                      std::vector<CellData<3> > &cells)
index 46d4a95b1c90c0f210c134d4524a066373eb07a8..7cca5a7bb530c8807bd4db442e95c75241390220 100644 (file)
@@ -638,7 +638,7 @@ namespace GridTools
     transform (Rotate2d(angle), triangulation);
   }
 
-  template<int dim>
+  template <int dim>
   void
   rotate (const double      angle,
           const unsigned int axis,
@@ -1122,7 +1122,7 @@ namespace GridTools
   }
 
 
-  template<int dim, template<int, int> class MeshType, int spacedim>
+  template <int dim, template <int, int> class MeshType, int spacedim>
 #ifndef _MSC_VER
   std::vector<typename MeshType<dim, spacedim>::active_cell_iterator>
 #else
@@ -1264,7 +1264,7 @@ next_cell:
 
   namespace
   {
-    template <int dim, template<int, int> class MeshType, int spacedim>
+    template <int dim, template <int, int> class MeshType, int spacedim>
     void find_active_cell_around_point_internal
     (const MeshType<dim,spacedim> &mesh,
 #ifndef _MSC_VER
@@ -1320,7 +1320,7 @@ next_cell:
     }
   }
 
-  template <int dim, template<int, int> class MeshType, int spacedim>
+  template <int dim, template <int, int> class MeshType, int spacedim>
 #ifndef _MSC_VER
   typename MeshType<dim, spacedim>::active_cell_iterator
 #else
@@ -1586,7 +1586,7 @@ next_cell:
   namespace
   {
 
-    template<class MeshType>
+    template <class MeshType>
     bool
     contains_locally_owned_cells (const std::vector<typename MeshType::active_cell_iterator> &cells)
     {
@@ -1599,7 +1599,7 @@ next_cell:
       return false;
     }
 
-    template<class MeshType>
+    template <class MeshType>
     bool
     contains_artificial_cells (const std::vector<typename MeshType::active_cell_iterator> &cells)
     {
@@ -1871,7 +1871,7 @@ next_cell:
 
 
 
-  template< class MeshType>
+  template < class MeshType>
   std::pair< Point<MeshType::space_dimension>, Point<MeshType::space_dimension> >
   compute_bounding_box
   ( const MeshType                                                                    &mesh,
@@ -3906,7 +3906,7 @@ next_cell:
    *   matrix.point1 + offset - point2
    * is parallel to the unit vector in <direction>
    */
-  template<int spacedim>
+  template <int spacedim>
   inline bool orthogonal_equality (const Point<spacedim>    &point1,
                                    const Point<spacedim>    &point2,
                                    const int                 direction,
@@ -3953,9 +3953,9 @@ next_cell:
    * documentation of make_periodicity_constraints and
    * collect_periodic_faces for details
    */
-  template<int dim> struct OrientationLookupTable {};
+  template <int dim> struct OrientationLookupTable {};
 
-  template<> struct OrientationLookupTable<1>
+  template <> struct OrientationLookupTable<1>
   {
     typedef std::array<unsigned int, GeometryInfo<1>::vertices_per_face> MATCH_T;
     static inline std::bitset<3> lookup (const MATCH_T &)
@@ -3965,7 +3965,7 @@ next_cell:
     }
   };
 
-  template<> struct OrientationLookupTable<2>
+  template <> struct OrientationLookupTable<2>
   {
     typedef std::array<unsigned int, GeometryInfo<2>::vertices_per_face> MATCH_T;
     static inline std::bitset<3> lookup (const MATCH_T &matching)
@@ -3986,7 +3986,7 @@ next_cell:
     }
   };
 
-  template<> struct OrientationLookupTable<3>
+  template <> struct OrientationLookupTable<3>
   {
     typedef std::array<unsigned int, GeometryInfo<3>::vertices_per_face> MATCH_T;
     static inline std::bitset<3> lookup (const MATCH_T &matching)
@@ -4021,7 +4021,7 @@ next_cell:
 
 
 
-  template<typename FaceIterator>
+  template <typename FaceIterator>
   inline bool
   orthogonal_equality (std::bitset<3>     &orientation,
                        const FaceIterator &face1,
@@ -4069,7 +4069,7 @@ next_cell:
 
 
 
-  template<typename FaceIterator>
+  template <typename FaceIterator>
   inline bool
   orthogonal_equality (const FaceIterator &face1,
                        const FaceIterator &face2,
@@ -4087,7 +4087,7 @@ next_cell:
   /*
    * Internally used in collect_periodic_faces
    */
-  template<typename CellIterator>
+  template <typename CellIterator>
   void
   match_periodic_face_pairs
   (std::set<std::pair<CellIterator, unsigned int> > &pairs1,
@@ -4150,7 +4150,7 @@ next_cell:
 
 
 
-  template<typename MeshType>
+  template <typename MeshType>
   void
   collect_periodic_faces
   (const MeshType                        &mesh,
@@ -4211,7 +4211,7 @@ next_cell:
 
 
 
-  template<typename MeshType>
+  template <typename MeshType>
   void
   collect_periodic_faces
   (const MeshType                        &mesh,
@@ -4357,7 +4357,7 @@ next_cell:
       }
   }
 
-  template<int dim, int spacedim>
+  template <int dim, int spacedim>
   std::pair<unsigned int, double>
   get_longest_direction(typename Triangulation<dim, spacedim>::active_cell_iterator cell)
   {
@@ -4387,7 +4387,7 @@ next_cell:
   }
 
 
-  template<int dim, int spacedim>
+  template <int dim, int spacedim>
   void
   remove_hanging_nodes( Triangulation<dim,spacedim> &tria,
                         const bool isotropic,
@@ -4422,7 +4422,7 @@ next_cell:
       }
   }
 
-  template<int dim, int spacedim>
+  template <int dim, int spacedim>
   void
   remove_anisotropy(  Triangulation<dim,spacedim> &tria,
                       const double max_ratio,
@@ -4453,7 +4453,7 @@ next_cell:
   }
 
 
-  template<int dim, int spacedim>
+  template <int dim, int spacedim>
   void regularize_corner_cells (Triangulation<dim,spacedim> &tria,
                                 const double limit_angle_fraction)
   {
index 1de1e07e8ca4370840f85ad528e2f993e0403495..da34a01a1cc71b134330a2639c574e654602ede8 100644 (file)
@@ -187,7 +187,7 @@ normal_vector (const Triangulation<2, 2>::face_iterator &face,
 
 
 
-template<>
+template <>
 Tensor<1,3>
 Manifold<3, 3>::
 normal_vector (const Triangulation<3, 3>::face_iterator &face,
index 85a1c2b50276e58313ba82cd9dddd82e5185663d..9b22a89875bd5a8a31a82be5f551f8c4fdccc178 100644 (file)
@@ -11991,7 +11991,7 @@ Triangulation<dim,spacedim>::update_periodic_face_map ()
 
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void
 Triangulation<dim, spacedim>::clear_despite_subscriptions()
 {
@@ -13553,7 +13553,7 @@ Triangulation<dim, spacedim>::memory_consumption () const
 
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 Triangulation<dim, spacedim>::DistortedCellList::~DistortedCellList () noexcept
 {
   // don't do anything here. the compiler will automatically convert
index 5ec673b029f5487436a80e557f2560a24f6dbc30..59f3f1fa2355290e7ea9afdc692cd1c1b25fe757 100644 (file)
@@ -1511,8 +1511,8 @@ bool CellAccessor<3>::point_inside (const Point<3> &p) const
 // 1) project point onto manifold and
 // 2) transform to the unit cell with a Q1 mapping
 // 3) then check if inside unit cell
-template<int dim, int spacedim>
-template<int dim_,int spacedim_ >
+template <int dim, int spacedim>
+template <int dim_,int spacedim_ >
 bool CellAccessor<dim,spacedim>::
 point_inside_codim(const Point<spacedim_> &p) const
 {
index b5d3e57f06d829da23422a1556eacae7b2a5d075..b7b1d36c0c9822783870e0b545a6a9ddb293320c 100644 (file)
@@ -90,7 +90,7 @@ get_new_point_on_line (const typename Triangulation<dim,spacedim>::line_iterator
 
 
 
-template<>
+template <>
 Point<3>
 CylinderBoundary<3>::
 get_new_point_on_quad (const Triangulation<3>::quad_iterator &quad) const
@@ -110,7 +110,7 @@ get_new_point_on_quad (const Triangulation<3>::quad_iterator &quad) const
                     point_on_axis);
 }
 
-template<>
+template <>
 Point<3>
 CylinderBoundary<2,3>::
 get_new_point_on_quad (const Triangulation<2,3>::quad_iterator &quad) const
@@ -271,7 +271,7 @@ CylinderBoundary<dim,spacedim>::get_radius () const
 
 //======================================================================//
 
-template<int dim>
+template <int dim>
 ConeBoundary<dim>::ConeBoundary (const double radius_0,
                                  const double radius_1,
                                  const Point<dim> x_0,
@@ -285,7 +285,7 @@ ConeBoundary<dim>::ConeBoundary (const double radius_0,
 
 
 
-template<int dim>
+template <int dim>
 double ConeBoundary<dim>::get_radius (Point<dim> x) const
 {
   for (unsigned int i = 0; i < dim; ++i)
@@ -297,7 +297,7 @@ double ConeBoundary<dim>::get_radius (Point<dim> x) const
 
 
 
-template<int dim>
+template <int dim>
 void
 ConeBoundary<dim>::
 get_intermediate_points_between_points (const Point<dim> &p0,
@@ -327,7 +327,7 @@ get_intermediate_points_between_points (const Point<dim> &p0,
     }
 }
 
-template<int dim>
+template <int dim>
 Point<dim>
 ConeBoundary<dim>::
 get_new_point_on_line (const typename Triangulation<dim>::line_iterator &line) const
@@ -366,7 +366,7 @@ get_new_point_on_quad (const Triangulation<3>::quad_iterator &quad) const
 
 
 
-template<int dim>
+template <int dim>
 Point<dim>
 ConeBoundary<dim>::
 get_new_point_on_quad (const typename Triangulation<dim>::quad_iterator &) const
@@ -378,7 +378,7 @@ get_new_point_on_quad (const typename Triangulation<dim>::quad_iterator &) const
 
 
 
-template<int dim>
+template <int dim>
 void
 ConeBoundary<dim>::
 get_intermediate_points_on_line (const typename Triangulation<dim>::line_iterator &line,
@@ -393,7 +393,7 @@ get_intermediate_points_on_line (const typename Triangulation<dim>::line_iterato
 
 
 
-template<>
+template <>
 void
 ConeBoundary<3>::
 get_intermediate_points_on_quad (const Triangulation<3>::quad_iterator &quad,
@@ -441,7 +441,7 @@ get_intermediate_points_on_quad (const typename Triangulation<dim>::quad_iterato
 
 
 
-template<>
+template <>
 void
 ConeBoundary<1>::
 get_normals_at_vertices (const Triangulation<1>::face_iterator &,
@@ -452,7 +452,7 @@ get_normals_at_vertices (const Triangulation<1>::face_iterator &,
 
 
 
-template<int dim>
+template <int dim>
 void
 ConeBoundary<dim>::
 get_normals_at_vertices (const typename Triangulation<dim>::face_iterator &face,
@@ -1400,7 +1400,7 @@ TorusBoundary<2,3>::get_surf_norm(const Point<3> &p) const
 
 
 
-template<>
+template <>
 void
 TorusBoundary<2,3>::
 get_intermediate_points_on_line (const Triangulation<2, 3>::line_iterator   &line,
@@ -1451,7 +1451,7 @@ get_intermediate_points_on_line (const Triangulation<2, 3>::line_iterator   &lin
 
 
 
-template<>
+template <>
 void
 TorusBoundary<2,3>::
 get_intermediate_points_on_quad (const Triangulation< 2, 3 >::quad_iterator &quad,
@@ -1511,7 +1511,7 @@ get_intermediate_points_on_quad (const Triangulation< 2, 3 >::quad_iterator &qua
 
 
 
-template<>
+template <>
 void
 TorusBoundary<2,3>::
 get_normals_at_vertices (const Triangulation<2,3 >::face_iterator &face,
index e5f768fce792da09c12b4bad432dbb8aa09bb5c7..8be5359d5576dbb3bd9aa4ef2e105bb3bd8c89af 100644 (file)
@@ -30,7 +30,7 @@ namespace internal
 {
   namespace Triangulation
   {
-    template<class G>
+    template <class G>
     void
     TriaObjects<G>::reserve_space (const unsigned int new_objects_in_pairs,
                                    const unsigned int new_objects_single)
@@ -307,7 +307,7 @@ namespace internal
     }
 
 
-    template<>
+    template <>
     void
     TriaObjects<TriaObject<1> >::monitor_memory (const unsigned int) const
     {
@@ -326,7 +326,7 @@ namespace internal
     }
 
 
-    template<>
+    template <>
     void
     TriaObjects<TriaObject<2> >::monitor_memory (const unsigned int) const
     {
@@ -426,7 +426,7 @@ namespace internal
     }
 
 
-    template<typename G>
+    template <typename G>
     std::size_t
     TriaObjects<G>::memory_consumption () const
     {
index e9fa9c081ba219da3be8f6b5cb5ab8b85959e6c7..e68dc9d3fc01f3d09dc737e9de3147cb60642487 100644 (file)
@@ -225,7 +225,7 @@ namespace internal
          * same in all space
          * dimensions.
          */
-        template<int dim, int spacedim>
+        template <int dim, int spacedim>
         static
         void
         reserve_space_vertices (DoFHandler<dim,spacedim> &dof_handler)
@@ -1648,18 +1648,18 @@ namespace internal
 
 namespace hp
 {
-  template<int dim, int spacedim>
+  template <int dim, int spacedim>
   const unsigned int DoFHandler<dim,spacedim>::dimension;
 
-  template<int dim, int spacedim>
+  template <int dim, int spacedim>
   const types::global_dof_index DoFHandler<dim,spacedim>::invalid_dof_index;
 
-  template<int dim, int spacedim>
+  template <int dim, int spacedim>
   const unsigned int DoFHandler<dim,spacedim>::default_fe_index;
 
 
 
-  template<int dim, int spacedim>
+  template <int dim, int spacedim>
   DoFHandler<dim,spacedim>::DoFHandler (const Triangulation<dim,spacedim> &tria)
     :
     tria(&tria, typeid(*this).name()),
@@ -1688,7 +1688,7 @@ namespace hp
   }
 
 
-  template<int dim, int spacedim>
+  template <int dim, int spacedim>
   DoFHandler<dim,spacedim>::~DoFHandler ()
   {
     // unsubscribe as a listener to refinement
@@ -1959,7 +1959,7 @@ namespace hp
   }
 
 
-  template<int dim, int spacedim>
+  template <int dim, int spacedim>
   types::global_dof_index DoFHandler<dim,spacedim>::n_boundary_dofs () const
   {
     Assert (finite_elements != nullptr, ExcNoFESelected());
@@ -1997,7 +1997,7 @@ namespace hp
 
 
 
-  template<int dim, int spacedim>
+  template <int dim, int spacedim>
   types::global_dof_index
   DoFHandler<dim,spacedim>::n_boundary_dofs (const std::set<types::boundary_id> &boundary_ids) const
   {
@@ -2061,7 +2061,7 @@ namespace hp
 
 
 
-  template<int dim, int spacedim>
+  template <int dim, int spacedim>
   std::size_t
   DoFHandler<dim,spacedim>::memory_consumption () const
   {
@@ -2083,7 +2083,7 @@ namespace hp
 
 
 
-  template<int dim, int spacedim>
+  template <int dim, int spacedim>
   void
   DoFHandler<dim,spacedim>::
   compute_vertex_dof_identities (std::vector<types::global_dof_index> &new_dof_indices) const
@@ -2217,7 +2217,7 @@ namespace hp
   {}
 
 
-  template<int dim, int spacedim>
+  template <int dim, int spacedim>
   void
   DoFHandler<dim,spacedim>::
   compute_line_dof_identities (std::vector<types::global_dof_index> &new_dof_indices) const
@@ -2569,7 +2569,7 @@ namespace hp
 
 
 
-  template<int dim, int spacedim>
+  template <int dim, int spacedim>
   void DoFHandler<dim,spacedim>::distribute_dofs (const hp::FECollection<dim,spacedim> &ff)
   {
     Assert (tria->n_levels() > 0, ExcInvalidTriangulation());
@@ -2731,7 +2731,7 @@ namespace hp
 
 
 
-  template<int dim, int spacedim>
+  template <int dim, int spacedim>
   void DoFHandler<dim,spacedim>::clear ()
   {
     // release lock to old fe
@@ -2743,7 +2743,7 @@ namespace hp
 
 
 
-  template<int dim, int spacedim>
+  template <int dim, int spacedim>
   void DoFHandler<dim,spacedim>::renumber_dofs (const std::vector<types::global_dof_index> &new_numbers)
   {
     Assert (new_numbers.size() == n_dofs(), ExcRenumberingIncomplete());
@@ -2792,7 +2792,7 @@ namespace hp
 
 
 
-  template<int dim, int spacedim>
+  template <int dim, int spacedim>
   void
   DoFHandler<dim,spacedim>::
   renumber_dofs_internal (const std::vector<types::global_dof_index> &new_numbers,
@@ -2834,7 +2834,7 @@ namespace hp
 
 
 
-  template<int dim, int spacedim>
+  template <int dim, int spacedim>
   void
   DoFHandler<dim,spacedim>::
   renumber_dofs_internal (const std::vector<types::global_dof_index> &new_numbers,
@@ -2884,7 +2884,7 @@ namespace hp
 
 
 //TODO: Merge the following three functions -- they are identical
-  template<>
+  template <>
   void
   DoFHandler<2,2>::
   renumber_dofs_internal (const std::vector<types::global_dof_index> &new_numbers,
@@ -2936,7 +2936,7 @@ namespace hp
 
 
 
-  template<>
+  template <>
   void
   DoFHandler<2,3>::
   renumber_dofs_internal (const std::vector<types::global_dof_index> &new_numbers,
@@ -2987,7 +2987,7 @@ namespace hp
   }
 
 
-  template<>
+  template <>
   void
   DoFHandler<3,3>::
   renumber_dofs_internal (const std::vector<types::global_dof_index> &new_numbers,
@@ -3038,7 +3038,7 @@ namespace hp
   }
 
 
-  template<>
+  template <>
   void
   DoFHandler<3,3>::
   renumber_dofs_internal (const std::vector<types::global_dof_index> &new_numbers,
@@ -3142,7 +3142,7 @@ namespace hp
 
 
 
-  template<int dim, int spacedim>
+  template <int dim, int spacedim>
   void DoFHandler<dim,spacedim>::create_active_fe_table ()
   {
     // Create sufficiently many
@@ -3225,7 +3225,7 @@ namespace hp
 
 
 
-  template<int dim, int spacedim>
+  template <int dim, int spacedim>
   void
   DoFHandler<dim,spacedim>::post_refinement_action ()
   {
@@ -3335,7 +3335,7 @@ namespace hp
   }
 
 
-  template<int dim, int spacedim>
+  template <int dim, int spacedim>
   void DoFHandler<dim,spacedim>::clear_space ()
   {
     levels.clear ();
index 4a2db5abe3112829008518b0e5310cf78fb1134d..a0a6865f294ae6bcf655207a8ab060d28a9f9e26 100644 (file)
@@ -23,13 +23,13 @@ DEAL_II_NAMESPACE_OPEN
 namespace hp
 {
 
-  template<int dim, int spacedim>
+  template <int dim, int spacedim>
   MappingCollection<dim,spacedim>::MappingCollection ()
   {}
 
 
 
-  template<int dim, int spacedim>
+  template <int dim, int spacedim>
   MappingCollection<dim,spacedim>::
   MappingCollection (const Mapping<dim,spacedim> &mapping)
   {
@@ -39,7 +39,7 @@ namespace hp
 
 
 
-  template<int dim, int spacedim>
+  template <int dim, int spacedim>
   MappingCollection<dim,spacedim>::
   MappingCollection (const MappingCollection<dim,spacedim> &mapping_collection)
     :
@@ -60,7 +60,7 @@ namespace hp
 
 
 
-  template<int dim, int spacedim>
+  template <int dim, int spacedim>
   std::size_t
   MappingCollection<dim,spacedim>::memory_consumption () const
   {
@@ -70,7 +70,7 @@ namespace hp
 
 
 
-  template<int dim, int spacedim>
+  template <int dim, int spacedim>
   void
   MappingCollection<dim,spacedim>::push_back (const Mapping<dim,spacedim> &new_mapping)
   {
@@ -92,7 +92,7 @@ namespace hp
      * reference to a static object that will be constructed the first time
      * this function is called.
      */
-    template<int dim, int spacedim>
+    template <int dim, int spacedim>
     MappingQGeneric<dim,spacedim> &
     get_static_mapping_q1()
     {
@@ -101,7 +101,7 @@ namespace hp
     }
   }
 
-  template<int dim, int spacedim>
+  template <int dim, int spacedim>
   MappingCollection<dim,spacedim>
   StaticMappingQ1<dim,spacedim>::mapping_collection
     = MappingCollection<dim,spacedim>(get_static_mapping_q1<dim,spacedim>());
index f5e9f7731a812e3b484430f2815e1f8000a22e01..bd084adf8e61cbbd803648281efe51a2bf08cec1 100644 (file)
@@ -1446,7 +1446,7 @@ namespace internals
 {
 #define SCRATCH_INITIALIZER(Number,Name)                                \
   ConstraintMatrixData<Number>::ScratchData scratch_data_initializer_##Name; \
-  template<> Threads::ThreadLocalStorage<ConstraintMatrixData<Number>::ScratchData> \
+  template <> Threads::ThreadLocalStorage<ConstraintMatrixData<Number>::ScratchData> \
   ConstraintMatrixData<Number>::scratch_data(scratch_data_initializer_##Name)
 
   SCRATCH_INITIALIZER(double,double);
index b131585a77643e5b91959f26e75d0f32e6f091ef..f2865134c5617c470784f36c69ab1f079233bcc4 100644 (file)
@@ -22,7 +22,7 @@ DEAL_II_NAMESPACE_OPEN
 
 using namespace LAPACKSupport;
 
-template<typename number>
+template <typename number>
 TridiagonalMatrix<number>::TridiagonalMatrix(
   size_type size,
   bool symmetric)
@@ -35,7 +35,7 @@ TridiagonalMatrix<number>::TridiagonalMatrix(
 {}
 
 
-template<typename number>
+template <typename number>
 void
 TridiagonalMatrix<number>::reinit(
   size_type size,
@@ -49,7 +49,7 @@ TridiagonalMatrix<number>::reinit(
 }
 
 
-template<typename number>
+template <typename number>
 bool
 TridiagonalMatrix<number>::all_zero() const
 {
@@ -73,7 +73,7 @@ TridiagonalMatrix<number>::all_zero() const
 }
 
 
-template<typename number>
+template <typename number>
 void
 TridiagonalMatrix<number>::vmult (
   Vector<number>       &w,
@@ -127,7 +127,7 @@ TridiagonalMatrix<number>::vmult (
 }
 
 
-template<typename number>
+template <typename number>
 void
 TridiagonalMatrix<number>::vmult_add (
   Vector<number>       &w,
@@ -137,7 +137,7 @@ TridiagonalMatrix<number>::vmult_add (
 }
 
 
-template<typename number>
+template <typename number>
 void
 TridiagonalMatrix<number>::Tvmult (
   Vector<number>       &w,
@@ -181,7 +181,7 @@ TridiagonalMatrix<number>::Tvmult (
 }
 
 
-template<typename number>
+template <typename number>
 void
 TridiagonalMatrix<number>::Tvmult_add (
   Vector<number>       &w,
@@ -191,7 +191,7 @@ TridiagonalMatrix<number>::Tvmult_add (
 }
 
 
-template<typename number>
+template <typename number>
 number
 TridiagonalMatrix<number>::matrix_scalar_product(
   const Vector<number> &w,
@@ -218,7 +218,7 @@ TridiagonalMatrix<number>::matrix_scalar_product(
 }
 
 
-template<typename number>
+template <typename number>
 number
 TridiagonalMatrix<number>::matrix_norm_square(
   const Vector<number> &v) const
@@ -227,7 +227,7 @@ TridiagonalMatrix<number>::matrix_norm_square(
 }
 
 
-template<>
+template <>
 void
 TridiagonalMatrix<double>::compute_eigenvalues()
 {
@@ -247,7 +247,7 @@ TridiagonalMatrix<double>::compute_eigenvalues()
 }
 
 
-template<typename number>
+template <typename number>
 number
 TridiagonalMatrix<number>::eigenvalue(const size_type i) const
 {
@@ -258,7 +258,7 @@ TridiagonalMatrix<number>::eigenvalue(const size_type i) const
 
 
 /*
-template<typename number>
+template <typename number>
 TridiagonalMatrix<number>::
 {
 }
index 27577bb9b69d13b279da1af590c8b13cfdd6eeb6..15b11271d1e012e2471ed27e8c77a5b10eab7764 100644 (file)
@@ -433,7 +433,7 @@ namespace TrilinosWrappers
   }
 
 
-  template<typename Preconditioner>
+  template <typename Preconditioner>
   void
   SolverBase::do_solve(const Preconditioner &preconditioner)
   {
@@ -568,7 +568,7 @@ namespace TrilinosWrappers
 
 
 
-  template<>
+  template <>
   void
   SolverBase::set_preconditioner(AztecOO                &solver,
                                  const PreconditionBase &preconditioner)
@@ -586,7 +586,7 @@ namespace TrilinosWrappers
   }
 
 
-  template<>
+  template <>
   void
   SolverBase::set_preconditioner(AztecOO               &solver,
                                  const Epetra_Operator &preconditioner)
index fe3876889d5162381980731e2265849b109a60a1..0776cd0b926cc8afc107d8d82aad2e7f97527e20 100644 (file)
@@ -585,7 +585,7 @@ namespace TrilinosWrappers
 
 
 
-  template<typename SparsityPatternType>
+  template <typename SparsityPatternType>
   void
   SparsityPattern::reinit (const IndexSet            &row_parallel_partitioning,
                            const IndexSet            &col_parallel_partitioning,
@@ -603,7 +603,7 @@ namespace TrilinosWrappers
 
 
 
-  template<typename SparsityPatternType>
+  template <typename SparsityPatternType>
   void
   SparsityPattern::reinit (const IndexSet            &parallel_partitioning,
                            const SparsityPatternType &nontrilinos_sparsity_pattern,
index 2b9c79851af62be799fd04c5f09c72718be62df4..877c41e258763ed8b43328b1d7177fa0f46f90c6 100644 (file)
@@ -34,7 +34,7 @@
 DEAL_II_NAMESPACE_OPEN
 
 
-template<int dim, typename Number>
+template <int dim, typename Number>
 MGTransferMatrixFree<dim,Number>::MGTransferMatrixFree ()
   :
   fe_degree(0),
@@ -45,7 +45,7 @@ MGTransferMatrixFree<dim,Number>::MGTransferMatrixFree ()
 
 
 
-template<int dim, typename Number>
+template <int dim, typename Number>
 MGTransferMatrixFree<dim,Number>::MGTransferMatrixFree (const MGConstrainedDoFs &mg_c)
   :
   fe_degree(0),
index 69e7f14b94d9891c37e5a2b355249493f0bb58c1..a432aeabcdf693e9f1dd819006eee0210c1c5728 100644 (file)
 DEAL_II_NAMESPACE_OPEN
 
 
-template<typename VectorType>
+template <typename VectorType>
 MGTransferPrebuilt<VectorType>::MGTransferPrebuilt ()
 {}
 
 
 
-template<typename VectorType>
+template <typename VectorType>
 MGTransferPrebuilt<VectorType>::MGTransferPrebuilt (const MGConstrainedDoFs &mg_c)
 {
   this->mg_constrained_dofs = &mg_c;
@@ -54,7 +54,7 @@ MGTransferPrebuilt<VectorType>::MGTransferPrebuilt (const MGConstrainedDoFs &mg_
 
 
 
-template<typename VectorType>
+template <typename VectorType>
 MGTransferPrebuilt<VectorType>::MGTransferPrebuilt (const ConstraintMatrix &/*c*/, const MGConstrainedDoFs &mg_c)
 {
   this->mg_constrained_dofs = &mg_c;
index 9a4ab4c21bd86c033b00db2cb0fec93f43dbc17a..b85f72e930d68babca900a1278500eba5f563d3a 100644 (file)
@@ -198,7 +198,7 @@ MGTransferBlockBase::memory_consumption () const
 
 //----------------------------------------------------------------------//
 
-template<typename number>
+template <typename number>
 MGTransferSelect<number>::MGTransferSelect ()
   :
   selected_component (0),
@@ -206,7 +206,7 @@ MGTransferSelect<number>::MGTransferSelect ()
 {}
 
 
-template<typename number>
+template <typename number>
 MGTransferSelect<number>::MGTransferSelect (const ConstraintMatrix &c)
   :
   selected_component (0),
index fdcc6c2984452be382c754f3a632adc63869feac..8f6b8add539f70347bcbea1dd69edab2423c6139 100644 (file)
@@ -35,7 +35,7 @@
 
 DEAL_II_NAMESPACE_OPEN
 
-template<int dim, typename VectorType, typename DoFHandlerType>
+template <int dim, typename VectorType, typename DoFHandlerType>
 SolutionTransfer<dim, VectorType, DoFHandlerType>::
 SolutionTransfer(const DoFHandlerType &dof)
   :
@@ -55,7 +55,7 @@ SolutionTransfer(const DoFHandlerType &dof)
 
 
 
-template<int dim, typename VectorType, typename DoFHandlerType>
+template <int dim, typename VectorType, typename DoFHandlerType>
 SolutionTransfer<dim, VectorType, DoFHandlerType>::~SolutionTransfer()
 {
   clear ();
@@ -63,7 +63,7 @@ SolutionTransfer<dim, VectorType, DoFHandlerType>::~SolutionTransfer()
 
 
 
-template<int dim, typename VectorType, typename DoFHandlerType>
+template <int dim, typename VectorType, typename DoFHandlerType>
 void SolutionTransfer<dim, VectorType, DoFHandlerType>::clear ()
 {
   indices_on_cell.clear();
@@ -75,7 +75,7 @@ void SolutionTransfer<dim, VectorType, DoFHandlerType>::clear ()
 
 
 
-template<int dim, typename VectorType, typename DoFHandlerType>
+template <int dim, typename VectorType, typename DoFHandlerType>
 void SolutionTransfer<dim, VectorType, DoFHandlerType>::prepare_for_pure_refinement()
 {
   Assert(prepared_for!=pure_refinement, ExcAlreadyPrepForRef());
@@ -112,7 +112,7 @@ void SolutionTransfer<dim, VectorType, DoFHandlerType>::prepare_for_pure_refinem
 
 
 
-template<int dim, typename VectorType, typename DoFHandlerType>
+template <int dim, typename VectorType, typename DoFHandlerType>
 void
 SolutionTransfer<dim, VectorType, DoFHandlerType>::refine_interpolate
 (const VectorType &in,
@@ -239,7 +239,7 @@ namespace internal
 
 
 
-template<int dim, typename VectorType, typename DoFHandlerType>
+template <int dim, typename VectorType, typename DoFHandlerType>
 void
 SolutionTransfer<dim, VectorType, DoFHandlerType>::
 prepare_for_coarsening_and_refinement(const std::vector<VectorType> &all_in)
@@ -392,7 +392,7 @@ prepare_for_coarsening_and_refinement(const std::vector<VectorType> &all_in)
 
 
 
-template<int dim, typename VectorType, typename DoFHandlerType>
+template <int dim, typename VectorType, typename DoFHandlerType>
 void
 SolutionTransfer<dim, VectorType, DoFHandlerType>::prepare_for_coarsening_and_refinement
 (const VectorType &in)
@@ -403,7 +403,7 @@ SolutionTransfer<dim, VectorType, DoFHandlerType>::prepare_for_coarsening_and_re
 
 
 
-template<int dim, typename VectorType, typename DoFHandlerType>
+template <int dim, typename VectorType, typename DoFHandlerType>
 void SolutionTransfer<dim, VectorType, DoFHandlerType>::
 interpolate (const std::vector<VectorType> &all_in,
              std::vector<VectorType>       &all_out) const
@@ -534,7 +534,7 @@ interpolate (const std::vector<VectorType> &all_in,
 
 
 
-template<int dim, typename VectorType, typename DoFHandlerType>
+template <int dim, typename VectorType, typename DoFHandlerType>
 void SolutionTransfer<dim, VectorType, DoFHandlerType>::interpolate
 (const VectorType &in,
  VectorType       &out) const
@@ -555,7 +555,7 @@ void SolutionTransfer<dim, VectorType, DoFHandlerType>::interpolate
 
 
 
-template<int dim, typename VectorType, typename DoFHandlerType>
+template <int dim, typename VectorType, typename DoFHandlerType>
 std::size_t
 SolutionTransfer<dim, VectorType, DoFHandlerType>::memory_consumption () const
 {
@@ -572,7 +572,7 @@ SolutionTransfer<dim, VectorType, DoFHandlerType>::memory_consumption () const
 
 
 
-template<int dim, typename VectorType, typename DoFHandlerType>
+template <int dim, typename VectorType, typename DoFHandlerType>
 std::size_t
 SolutionTransfer<dim, VectorType, DoFHandlerType>::Pointerstruct::memory_consumption () const
 {
index 2dac7d1716bda44ab86402da797b32f93e08e724..98284f832632fd4ab6f093917f4e60473fd4eee3 100644 (file)
@@ -286,7 +286,7 @@ namespace OpenCASCADE
     tolerance(tolerance)
   {}
 
-  template<>
+  template <>
   Point<2>
   NURBSPatchManifold<2, 3>::
   pull_back(const Point<3> &space_point) const
@@ -302,7 +302,7 @@ namespace OpenCASCADE
     return Point<2>(u,v);
   }
 
-  template<>
+  template <>
   Point<3>
   NURBSPatchManifold<2, 3>::
   push_forward(const Point<2> &chart_point) const
@@ -310,7 +310,7 @@ namespace OpenCASCADE
     return ::dealii::OpenCASCADE::push_forward(face, chart_point[0], chart_point[1]);
   }
 
-  template<>
+  template <>
   DerivativeForm<1,2,3>
   NURBSPatchManifold<2, 3>::
   push_forward_gradient(const Point<2> &chart_point) const
@@ -332,7 +332,7 @@ namespace OpenCASCADE
     return DX;
   }
 
-  template<>
+  template <>
   std::tuple<double, double, double, double>
   NURBSPatchManifold<2, 3>::
   get_uv_bounds() const
index 92c950fd3bc146b38ea6eb73353c4d08ef2ca4cc..e5e1336151712af6273ab4ff210adb50d0ddcebf 100644 (file)
@@ -56,7 +56,7 @@ void print_formatted (const FullMatrix<number> &A,
 
 
 
-template<int dim>
+template <int dim>
 void test_embedding (const FiniteElement<dim> &fe)
 {
   const std::string refine_case_names[8]=
@@ -98,7 +98,7 @@ void test_embedding (const FiniteElement<dim> &fe)
 }
 
 
-template<int dim>
+template <int dim>
 void test_projection (const FiniteElement<dim> &fe1,
                       const FiniteElement<dim> &fe2,
                       std::ostream &out)
@@ -120,7 +120,7 @@ void test_projection (const FiniteElement<dim> &fe1,
 }
 
 
-template<int dim>
+template <int dim>
 void test_projection (std::ostream &out)
 {
   FE_DGQ<dim> q0(0);
index e17cb7b720178f31080ad5c464b19459524f85cf..2ac4be19520ecce990962e856381d4e03cf7c7b5 100644 (file)
@@ -38,7 +38,7 @@
 #include <vector>
 
 
-template<int dim>
+template <int dim>
 class MyFunction : public Function<dim>
 {
 public:
index afd8728fe9f335853f536994932b94c4d8550f3c..d7a4e70f94fb918ce34f9de8d506329a6d535a62 100644 (file)
@@ -32,7 +32,7 @@
 using namespace Polynomials;
 
 
-template<int dim, class PolynomialType1, class PolynomialType2>
+template <int dim, class PolynomialType1, class PolynomialType2>
 void check_poly(const Point<dim>      &x,
                 const PolynomialType1 &p,
                 const PolynomialType2 &q)
index 3b97d750acd486f499ca862b039dd0b9a8548cf3..f320f3416a339903e9bab483aa25950fdc064b49 100644 (file)
@@ -38,7 +38,7 @@
 
 using namespace dealii;
 
-template<int dim>
+template <int dim>
 class MyFunction : public Function<dim>
 {
 public:
@@ -75,7 +75,7 @@ DeclException3 (ExcWrongValue,
 /**
  * Loop over quadrature points and check that value is the same as given by the function.
  */
-template<int dim,typename DATA>
+template <int dim,typename DATA>
 void check_qph(Triangulation<dim> &tr,
                const CellDataStorage<typename Triangulation<dim,dim>::cell_iterator,DATA> &manager,
                const Quadrature<dim> &rhs_quadrature,
@@ -106,7 +106,7 @@ void check_qph(Triangulation<dim> &tr,
   dof_handler.clear();
 }
 
-template<int dim>
+template <int dim>
 void test()
 {
   const MyFunction<dim> my_func;
index 60b9e87a01938102b34e6635981e3565bea28cad..b1f72a715121aba367d6a7f9fd04587dce3c45d0 100644 (file)
@@ -37,7 +37,7 @@
 
 using namespace dealii;
 
-template<int dim>
+template <int dim>
 class MyFunction : public Function<dim>
 {
 public:
@@ -72,7 +72,7 @@ DeclException3 (ExcWrongValue,
                 << arg1 <<" != "<< arg2 << " with delta = " << arg3 );
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   const MyFunction<dim> my_func;
index fe4e03fe4d44dc573971f498443b48422582c18c..47d01d85b6a1890184889463a480ade290dc2cec 100644 (file)
@@ -63,7 +63,7 @@ write_patches(const std::vector<DataOutBase::Patch<dim,spacedim> > &patches,
 //    WRITE(eps);
 }
 
-template<int dim>
+template <int dim>
 struct PatchInfo
 {
   static double vertices[GeometryInfo<dim>::vertices_per_cell][3];
@@ -198,7 +198,7 @@ create_patches(std::vector<DataOutBase::Patch<dim,spacedim> > &patches)
 }
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void test(std::ostream &out)
 {
   std::vector<DataOutBase::Patch<dim, spacedim> > patches;
index d5b7aee545250b7e5337c62c2322cca340faee60..e3523882c5c72e73fba685cbf621dbbc321ec258 100644 (file)
@@ -73,7 +73,7 @@ void check_cont(unsigned int ncells,
 }
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void check_all(std::ostream &log)
 {
 #if SEPARATE_FILES == 0
index 7ead9c17f22218b4ec435d7acf088041d0e4a10b..393d0f85bfa3b6a110ae1f7016feb9348f23121c 100644 (file)
@@ -71,7 +71,7 @@ void check_cont(unsigned int ncells,
 }
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void check_all(std::ostream &log)
 {
 #if SEPARATE_FILES == 0
index 9479f0cf6674e0f5578c1368e7694dfe3974de97..6391f43cec02fc35621a0fea379ac2a69a059ced 100644 (file)
@@ -53,7 +53,7 @@ void check(DataOutBase::GmvFlags flags,
 }
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void check_all(std::ostream &log)
 {
 #if SEPARATE_FILES == 0
index 88bb86d16e3c30271ea43ad1d1d33efa749d9f04..fffc0abce1ddacaae53e65361de0d4350eb0d189 100644 (file)
@@ -52,7 +52,7 @@ void check(DataOutBase::GnuplotFlags flags,
 }
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void check_all(std::ostream &log)
 {
 #if SEPARATE_FILES == 0
index f82745fc3aea782144c45a8924af97e4724d8dab..6a5518ca62793a0605e66730f0c1f2d8b17e3fac 100644 (file)
@@ -57,7 +57,7 @@ void check(DataOutBase::GnuplotFlags flags,
 }
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void check_all(std::ostream &log)
 {
 #if SEPARATE_FILES == 0
index be16b727520a77e90f59d0c6de76773dcbfd93ab..61d23f55fde61db2a9e9c718de402814f33e5849 100644 (file)
@@ -91,7 +91,7 @@ void check(DataOutBase::GnuplotFlags flags,
 }
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void check_all(std::ostream &log)
 {
 #if SEPARATE_FILES == 0
index b357b234cdbfa3e119fd7a4bb3247183da5c0e6c..094b8d781fc4a615ae9df9fa2efb9def7eb73074 100644 (file)
@@ -71,7 +71,7 @@ void check_cont(unsigned int ncells,
 }
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void check_all(std::ostream &log)
 {
 #if SEPARATE_FILES == 0
index 9cf01272c83b04141321f618a104b876b862db3f..f0dcc591e1597dc3846fad5b7a7390458c6463ed 100644 (file)
@@ -53,7 +53,7 @@ void check(DataOutBase::TecplotFlags flags,
 }
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void check_all(std::ostream &log)
 {
 #if SEPARATE_FILES == 0
index 83a25f1efc872c834aa5c745552accbe71275fca..b2fc629b6fd32546e83217e83cfc7d7da2f54b73 100644 (file)
@@ -50,7 +50,7 @@ void check(DataOutBase::TecplotFlags flags,
 }
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void check_all()
 {
   char name[100];
index 75b89040456348b1d8dcd6ee9f5b29516aced6f6..da259abd5d0409bdbebca318dd0677768dc7dcd3 100644 (file)
@@ -53,7 +53,7 @@ void check(DataOutBase::VtkFlags flags,
 }
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void check_all(std::ostream &log)
 {
 #if SEPARATE_FILES == 0
index 25bb64cf378818a2579e09f0602be492ecef608a..247474555b5160f02f7ee334c26465426b3afb8e 100644 (file)
@@ -56,7 +56,7 @@ void check(DataOutBase::VtkFlags flags,
 }
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void check_all(std::ostream &log)
 {
 #if SEPARATE_FILES == 0
index a2989f7b29cc3bb6890ff7d821c4e87c8a3b399d..fac2b602187e6132086d449983dd27f2c5fbe1a2 100644 (file)
@@ -56,7 +56,7 @@ void check(DataOutBase::VtkFlags flags,
 }
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void check_all(std::ostream &log)
 {
 #if SEPARATE_FILES == 0
index 99bd333bd0c1a7a659a2adfe0dd45e76e20a8193..2ae8c18da1d282995ea61b2d7f875866eb6cbe86 100644 (file)
@@ -56,7 +56,7 @@ void check(DataOutBase::VtkFlags flags,
 }
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void check_all(std::ostream &log)
 {
 #if SEPARATE_FILES == 0
index 52f4e64aa83dd8c083486ae1a0051b0fd411128e..80556a02193cea65002604f63905878f8682961a 100644 (file)
@@ -53,7 +53,7 @@ void check(DataOutBase::VtkFlags flags,
 }
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void check_all(std::ostream &log)
 {
 #if SEPARATE_FILES == 0
index c2cd7a9546645297bc591b21bd54f423e82e2a26..0fe95c9af8b68315b8f7a45d62446ed0a3499646 100644 (file)
@@ -47,7 +47,7 @@ void check(DataOutBase::VtkFlags flags,
 }
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void check_all(std::ostream &log)
 {
   for (unsigned int i = 0; i < 4; ++i)
index d0ff491e863799fba863cf8adf7416451566ae25..33543bea5352f6e617f0d925672c891fccc8da96 100644 (file)
@@ -55,7 +55,7 @@ void check(DataOutBase::VtkFlags flags,
 }
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void check_all(std::ostream &log)
 {
 #if SEPARATE_FILES == 0
index f46e7232f357c58692d2044552caad5512449635..6f7fb0dab49de648cfa1286fe352d84d4bcf7c7c 100644 (file)
@@ -55,7 +55,7 @@ void check(DataOutBase::VtkFlags flags,
 }
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void check_all(std::ostream &log)
 {
 #if SEPARATE_FILES == 0
index b481874a904c8b453cc3b7e661a16e3a03944f82..b02630c0c71b824cb4d286012e4d2376f78eefe5 100644 (file)
@@ -56,7 +56,7 @@ void check(DataOutBase::VtkFlags flags,
 }
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void check_all(std::ostream &log)
 {
 #if SEPARATE_FILES == 0
index 125903b2339f13f89fbb3b4ac6b4ea9d014e1302..d932d6c0cb69f0ba02cd53b425a7f0269cef8e01 100644 (file)
@@ -26,7 +26,7 @@
 typedef typename Sacado::Fad::DFad<double> Sdouble;
 typedef typename Sacado::Fad::DFad<Sdouble> SSdouble;
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void test()
 {
   Tensor<1,dim,SSdouble> x;
index edd6cd52c590d86b6c92fb67bb26da8b1b52deff..48b1549c73d8bbad6d27949e68ac0b420bb66be6 100644 (file)
@@ -20,7 +20,7 @@
 #include <deal.II/base/derivative_form.h>
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void test()
 {
   DerivativeForm<1,dim,spacedim> dF;
index 8bb37415567878842075bb2ad92cad22885ddf4a..2458772f4e33edd5a141fa68585bea6b2c2b7601 100644 (file)
@@ -20,7 +20,7 @@
 #include <deal.II/base/derivative_form.h>
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void test()
 {
   DerivativeForm<1,dim,spacedim,std::complex<double> > dF;
index 88a674b34decab2d85af43fd82c79e69c1154ff3..e6733ede95580de68eb1cce29f78b8227c1f5108 100644 (file)
@@ -20,7 +20,7 @@
 #include <deal.II/base/derivative_form.h>
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void test()
 {
   DerivativeForm<1,dim,spacedim,std::complex<double> > dF;
index 2b10618fb0355c7b4aa84c9b473cc03cfe8e5fcd..85b2276805575e89ae13694f965e8f2a7e596a33 100644 (file)
@@ -30,7 +30,7 @@
 #include <string>
 
 
-template<int dim>
+template <int dim>
 void
 check_derivative_order(const std::vector<Tensor<1,dim> > &gradients,
                        FunctionDerivative<dim> &df,
@@ -67,7 +67,7 @@ check_derivative_order(const std::vector<Tensor<1,dim> > &gradients,
 }
 
 
-template<int dim>
+template <int dim>
 void
 check_hessian_order(const std::vector<double> &values,
                     FunctionDerivative<dim> &df,
@@ -113,7 +113,7 @@ check_hessian_order(const std::vector<double> &values,
 }
 
 
-template<int dim>
+template <int dim>
 void
 check_sine(unsigned int nquad)
 {
index 580d632d38d1c3b508b4d74b7ee10de9c38ca272..1f11f17ab7388640dc3d4d82ddabc312b1aeae8d 100644 (file)
@@ -23,7 +23,7 @@
 // quadrature points in each direction, and the threshold above which
 // we consider values unequal
 
-template<int dim>
+template <int dim>
 void
 check_function_value_consistency(
   const Function<dim> &f,
@@ -60,7 +60,7 @@ check_function_value_consistency(
 }
 
 // Same for gradients
-template<int dim>
+template <int dim>
 void
 check_function_gradient_consistency(
   const Function<dim> &f,
@@ -148,7 +148,7 @@ DerivativeTestFunction<dim>::vector_value_list (
 }
 
 
-template<int dim>
+template <int dim>
 void DerivativeTestFunction<dim>::vector_value (
   const Point<dim> &point,
   Vector<double> &value) const
@@ -157,7 +157,7 @@ void DerivativeTestFunction<dim>::vector_value (
 }
 
 
-template<int dim>
+template <int dim>
 double DerivativeTestFunction<dim>::value (
   const Point<dim> &point,
   const unsigned int comp) const
@@ -169,7 +169,7 @@ double DerivativeTestFunction<dim>::value (
 
 
 // Check whether the difference quotients converge to the gradient
-template<int dim>
+template <int dim>
 void
 check_gradient(
   const Function<dim> &f,
index c93d0a1ac1c267d2dba53273d9abeaf3445a0582..533eeab6002bb29f2e477d0b72179d34382bbab7 100644 (file)
@@ -33,7 +33,7 @@
 
 #include "functions.h"
 
-template<int dim>
+template <int dim>
 void
 check_function(const Functions::FlowFunction<dim> &f,
                unsigned int sub,
index 46d4cef10d1ffccafc87493db5e293fd095aaeef..b31affd490b00a9f14a5ca08bb79d22c6089b881 100644 (file)
@@ -22,7 +22,7 @@
 
 
 // Fill a tensor with values:
-template<int rank, int dim>
+template <int rank, int dim>
 struct FillTensor
 {
   static void fill_tensor(Tensor<rank, dim> &tensor, int base)
@@ -32,7 +32,7 @@ struct FillTensor
   }
 };
 
-template<int dim>
+template <int dim>
 struct FillTensor<1, dim>
 {
   static void fill_tensor(Tensor<1, dim> &tensor, int base)
@@ -45,7 +45,7 @@ struct FillTensor<1, dim>
 
 
 // Print a tensor of arbitrary rank to the console:
-template<int rank, int dim>
+template <int rank, int dim>
 struct PrintTensor
 {
   static void print_tensor(const Tensor<rank, dim> &tensor)
@@ -58,7 +58,7 @@ struct PrintTensor
   }
 };
 
-template<int dim>
+template <int dim>
 struct PrintTensor<1, dim>
 {
   static void print_tensor(const Tensor<1, dim> &tensor)
index ac0def3811f452a70352be0f8eb9e284caca45a8..386c59933afafcbb6efb83c01a0b6a6369b93c97 100644 (file)
@@ -171,7 +171,7 @@ void test_constructor(const unsigned int n_component,
 }
 
 // test different number of vector components
-template<int dim, typename Number>
+template <int dim, typename Number>
 void test_n_components(const std::vector<NUMBER> &component_data)
 {
 #define N_COMPONENT_CASE 3
index bc0cc8698a1b4cee0b99b68ecbc5adbafffca6c5..db120eec2da811a1a3138102b761607555270f9b 100644 (file)
@@ -33,7 +33,7 @@
 #include <fstream>
 #include <string>
 
-template<int dim>
+template <int dim>
 void
 check_function_consistency(
   const Function<dim> &f,
@@ -73,7 +73,7 @@ check_function_consistency(
 }
 
 
-template<int dim>
+template <int dim>
 void
 check_function_derivative(const Functions::FlowFunction<dim> &f,
                           unsigned int sub,
index a258d02270c20a1668ffb6ff3b3ddda5fc0e925e..759b25f8ad3e0011902e49f77383cdaddaf1b5cd 100644 (file)
@@ -24,7 +24,7 @@
 
 
 // reference function f(x) = exp (-Z*r)
-template<int dim>
+template <int dim>
 class ExpFunc : public Function<dim>
 {
 public:
@@ -75,7 +75,7 @@ private:
 
 
 // same as above but using Functions::Spherical
-template<int dim>
+template <int dim>
 class ExpFunc2 : public Functions::Spherical<dim>
 {
 public:
index e4f43e30271b208165490229e62b895a3d13775b..6d7b475ca39cdd32f0bdd48f00e149abffc00fc3 100644 (file)
@@ -46,7 +46,7 @@ ddf2: (subst(srule2,expand(ddf)));
 
 
 
-template<int dim>
+template <int dim>
 class RefFunc : public Function<dim>
 {
 public:
@@ -119,7 +119,7 @@ private:
 
 
 // same as above but using Functions::Spherical
-template<int dim>
+template <int dim>
 class SphFunc : public Functions::Spherical<dim>
 {
 public:
index 8d9573bb1d9a9826886482147b6439b6925577d1..f02ce31e016fbfa95936721e46288234c3bd7350 100644 (file)
@@ -29,7 +29,7 @@ using namespace dealii;
 //
 
 
-template<int dim>
+template <int dim>
 void test_vertices()
 {
   deallog << dim << "D:" << std::endl;
@@ -60,7 +60,7 @@ void test_vertices()
 }
 
 
-template<int dim>
+template <int dim>
 void test_lines()
 {
   deallog << dim << "D:" << std::endl;
index b85187110dc2e47beb72de00d302898972a479fa..b970c4bdac638195858c41e53be409bc39089c01 100644 (file)
@@ -17,7 +17,7 @@
 
 using namespace dealii;
 
-template<typename T>
+template <typename T>
 struct EqualityWithSizeofTest
 {
   EqualityWithSizeofTest()
@@ -34,7 +34,7 @@ struct EqualityWithSizeofTest
 };
 
 
-template<typename T>
+template <typename T>
 struct EqualityWithSizeofTest<T *>
 {
   EqualityWithSizeofTest()
index 8f19773151ab765d14c85c196a2d3bc37efa3d99..e75583f773d59f59a04e8495ba019410a1d968d0 100644 (file)
@@ -33,7 +33,7 @@
 using namespace Polynomials;
 
 
-template<int dim, class PolynomialType>
+template <int dim, class PolynomialType>
 void check_poly(const Point<dim>     &x,
                 const PolynomialType &p)
 {
index 1afbbd6e8b850f2375db4826a416c9b37d1226c0..05c55b61b2041a7e3f7ce02983dc8c934f824ee8 100644 (file)
@@ -30,7 +30,7 @@
 
 using namespace std;
 
-template<int dim, class PolynomialType>
+template <int dim, class PolynomialType>
 void check_point (const Point<dim>     &x,
                   const PolynomialType &p)
 {
@@ -58,7 +58,7 @@ void check_point (const Point<dim>     &x,
 }
 
 
-template<int dim>
+template <int dim>
 void check_bdm ()
 {
   Point<dim> x;
@@ -79,7 +79,7 @@ void check_bdm ()
   check_point(x, p4);
 }
 
-template<int dim>
+template <int dim>
 void check_rt ()
 {
   Point<dim> x;
index 035e1b3894c58353057051d05f907628ede6a5a6..ea2c92fda93b565db4a33f816149e6b65af404a0 100644 (file)
@@ -26,7 +26,7 @@
 #include <deal.II/base/geometry_info.h>
 #include <cmath>
 
-template<int dim>
+template <int dim>
 void check_line(Quadrature<1> &quadrature)
 {
   Point<dim> p1;
@@ -54,7 +54,7 @@ void check_line(Quadrature<1> &quadrature)
   deallog << "length: " << s << std::endl;
 }
 
-template<int dim>
+template <int dim>
 void check_face(Quadrature<1> &q1)
 {
   deallog << "Checking dim " << dim
@@ -86,7 +86,7 @@ void check_face(Quadrature<1> &q1)
       }
 }
 
-template<int dim>
+template <int dim>
 void check_faces (Quadrature<1> &q1)
 {
   const unsigned int nq = q1.size();
index 8beef1adbf75c808aeedb1df1fd16e7bf2b8f897..acc2d87865750b3591a6a6d761d82f727335101f 100644 (file)
@@ -31,7 +31,7 @@
 using namespace dealii;
 
 
-template<typename quadrature_type, unsigned short startn>
+template <typename quadrature_type, unsigned short startn>
 void check_quadrature (double *);
 void check_GRC_right(double *);
 
@@ -95,7 +95,7 @@ int main()
 }
 
 
-template<typename quadrature_type,unsigned short startn>
+template <typename quadrature_type,unsigned short startn>
 void check_quadrature(double *exact_monomials)
 {
 
index bb9cdea24a3379aa05e6b510217bccba15acd7e4..0a59b0e27b749a445c90fadd048bb906fc667d9a 100644 (file)
@@ -43,7 +43,7 @@
 
 using namespace dealii;
 
-template<int dim>
+template <int dim>
 class MyFunction : public Function<dim>
 {
 public:
@@ -97,7 +97,7 @@ DeclException3 (ExcWrongValue,
 /**
  * Loop over quadrature points and check that value is the same as given by the function.
  */
-template<int dim,typename DATA>
+template <int dim,typename DATA>
 void check_qph(parallel::distributed::Triangulation<dim> &tr,
                const CellDataStorage<typename Triangulation<dim,dim>::cell_iterator,DATA> &manager,
                const Quadrature<dim> &rhs_quadrature,
@@ -128,7 +128,7 @@ void check_qph(parallel::distributed::Triangulation<dim> &tr,
   dof_handler.clear();
 }
 
-template<int dim>
+template <int dim>
 void test()
 {
   unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
index f60677db2b57b9f083bd47940b163e0a79a275a5..a2c9187d01c3e5e665548653e7b425921bb93ce9 100644 (file)
@@ -42,7 +42,7 @@
 
 using namespace dealii;
 
-template<int dim>
+template <int dim>
 class MyFunction : public Function<dim>
 {
 public:
@@ -99,7 +99,7 @@ DeclException3 (ExcWrongValue,
 /**
  * Loop over quadrature points and check that value is the same as given by the function.
  */
-template<int dim,typename DATA>
+template <int dim,typename DATA>
 void check_qph(parallel::distributed::Triangulation<dim> &tr,
                const CellDataStorage<typename Triangulation<dim,dim>::cell_iterator,DATA> &manager,
                const Quadrature<dim> &rhs_quadrature,
@@ -134,7 +134,7 @@ void check_qph(parallel::distributed::Triangulation<dim> &tr,
   dof_handler.clear();
 }
 
-template<int dim>
+template <int dim>
 void test()
 {
   unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
index 24cdab3426827d109876f2ecde70483fd050bc93..c91e6d584b744dffa01cd6e370a25cee3339a752 100644 (file)
@@ -38,7 +38,7 @@
 
 using namespace dealii;
 
-template<int dim>
+template <int dim>
 class MyFunction : public Function<dim>
 {
 public:
@@ -105,7 +105,7 @@ DeclException3 (ExcWrongValue,
 /**
  * Loop over quadrature points and check that value is the same as given by the function.
  */
-template<int dim>
+template <int dim>
 void check_qph(parallel::distributed::Triangulation<dim> &tr,
                const CellDataStorage<typename Triangulation<dim,dim>::cell_iterator,MyDataBase> &manager,
                const Quadrature<dim> &rhs_quadrature,
@@ -140,7 +140,7 @@ void check_qph(parallel::distributed::Triangulation<dim> &tr,
   dof_handler.clear();
 }
 
-template<int dim>
+template <int dim>
 void test()
 {
   unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
index 6311f66febe476c6c7537b5af81cd5c1e8f85f54..d60b0903d0c6c989515cc8d52858617015698982 100644 (file)
 // for example, complex numbers cannot be converted to primitive numbers
 // So in these cases we disable the test if NumberType1 cannot be constructed
 // from NumberType2
-template<int rank, int dim,
-         template<int,int,typename> class TensorType,
-         typename NumberType1,
-         typename NumberType2>
+template <int rank, int dim,
+          template <int,int,typename> class TensorType,
+          typename NumberType1,
+          typename NumberType2>
 typename std::enable_if<!std::is_constructible<NumberType1,NumberType2>::value,void>::type
 test_tensor_constructor (const std::string &, const std::string &)
 {}
 
-template<int rank, int dim,
-         template<int,int,typename> class TensorType,
-         typename NumberType1,
-         typename NumberType2>
+template <int rank, int dim,
+          template <int,int,typename> class TensorType,
+          typename NumberType1,
+          typename NumberType2>
 typename std::enable_if<std::is_constructible<NumberType1,NumberType2>::value,void>::type
 test_tensor_constructor (const std::string &type1, const std::string &type2)
 {
@@ -58,9 +58,9 @@ test_tensor_constructor (const std::string &type1, const std::string &type2)
   deallog << "OK" << std::endl;
 }
 
-template<int rank, int dim,
-         template<int,int,typename> class TensorType,
-         typename NumberType1>
+template <int rank, int dim,
+          template <int,int,typename> class TensorType,
+          typename NumberType1>
 void
 test_fixed_NT_2(const std::string &type1)
 {
@@ -70,8 +70,8 @@ test_fixed_NT_2(const std::string &type1)
   test_tensor_constructor<rank,dim,TensorType,NumberType1,std::complex<double> >(type1, "std::complex<double>");
 }
 
-template<int rank, int dim,
-         template<int,int,typename> class TensorType>
+template <int rank, int dim,
+          template <int,int,typename> class TensorType>
 void
 test_fixed_NT_1()
 {
@@ -81,7 +81,7 @@ test_fixed_NT_1()
   test_fixed_NT_2<rank,dim,TensorType,std::complex<double> >("std::complex<double>");
 }
 
-template<int rank, int dim>
+template <int rank, int dim>
 void
 test_fixed_TensorType()
 {
@@ -89,7 +89,7 @@ test_fixed_TensorType()
   test_fixed_NT_1<rank,dim,SymmetricTensor>();
 }
 
-template<int dim>
+template <int dim>
 void
 test_fixed_rank()
 {
index 87766712dadd7e82a5e4ba35944fc6586ddc1df0..1cc4216bd104ad73730bba660d2f105aedb08980 100644 (file)
@@ -26,9 +26,9 @@
 
 // Although not strictly required, in this test it is expected that T1 or T3
 // (or both) are a symmetric tensor
-template<int rank1, int rank2, int rank3, int dim, typename number,
-         template<int,int,typename> class T1,
-         template<int,int,typename> class T3>
+template <int rank1, int rank2, int rank3, int dim, typename number,
+          template <int,int,typename> class T1,
+          template <int,int,typename> class T3>
 void test_symm_tensor_contract_3(const T1<rank1,dim,number>     &l,
                                  const Tensor<rank2,dim,number> &m,
                                  const T3<rank3,dim,number>     &r)
index cedfef2a7ea86f8a06d76e1916f4792de13f0d15..cdb59892856dbaa2c56131dba45085c3c84a62bd 100644 (file)
@@ -25,7 +25,7 @@
 #include <deal.II/base/logstream.h>
 #include <deal.II/base/table.h>
 
-template<int dim>
+template <int dim>
 void test()
 {
   dealii::TableIndices<dim> new_size;
index 300511b0ddb2206678b236f919b5e976477a1e04..35cbd936d20cd0ed4ba4613f7b4469b3d1d53f40 100644 (file)
@@ -38,7 +38,7 @@
 #include <vector>
 
 
-template<int dim>
+template <int dim>
 double
 value(const Point<dim> &p)
 {
@@ -51,7 +51,7 @@ value(const Point<dim> &p)
 
 namespace
 {
-  template<int dim>
+  template <int dim>
   struct Scratch
   {
     Scratch(const FiniteElement<dim> &fe, const Quadrature<dim> &quadrature) :
@@ -100,7 +100,7 @@ zero_element(std::vector<double> &dst,
 }
 
 
-template<int dim>
+template <int dim>
 void
 mass_assembler(const typename Triangulation<dim>::active_cell_iterator &cell,
                Scratch<dim> &data, CopyData &copy_data)
index 399c83300cbc96d029c057894c7e2502747da9cb..b22923509783f3b1ef861d656d10844f7f6ee183 100644 (file)
@@ -35,7 +35,7 @@
 #include <vector>
 
 
-template<int dim>
+template <int dim>
 double
 value(const Point<dim> &p)
 {
@@ -48,7 +48,7 @@ value(const Point<dim> &p)
 
 namespace
 {
-  template<int dim>
+  template <int dim>
   struct Scratch
   {
     Scratch(const FiniteElement<dim> &fe, const Quadrature<dim> &quadrature) :
@@ -97,7 +97,7 @@ zero_element(std::vector<double> &dst,
 }
 
 
-template<int dim>
+template <int dim>
 void
 mass_assembler(const typename Triangulation<dim>::active_cell_iterator &cell,
                Scratch<dim> &data, CopyData &copy_data)
index c559b42a24bb397b36264dd53fe7c9ccf40cb024..ffd604e98f0d52aa2c78947a8242f94766c117eb 100644 (file)
@@ -37,7 +37,7 @@
 #include <deal.II/lac/precondition.h>
 #include <typeinfo>
 
-template<typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
+template <typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
 void
 check_solve(SolverType          &solver,
             const SolverControl &solver_control,
index 51de7ea809c76e4fcf4cdc58b2107a2eb74f978b..82633e0ac27146def368ec5620fa3c380eca6c1a 100644 (file)
@@ -36,7 +36,7 @@
 #include <deal.II/lac/precondition.h>
 #include <typeinfo>
 
-template<typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
+template <typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
 void
 check_solve(SolverType          &solver,
             const SolverControl &solver_control,
index 7eb924d6dbbb7624e79fe7bebab60600d3ab5fa6..9886076d089a20566bbb90248663b995be0df01b 100644 (file)
@@ -37,7 +37,7 @@
 #include <fstream>
 
 
-template<int dim>
+template <int dim>
 class MySquareFunction : public Function<dim>
 {
 public:
index 56aa9338620fed963767e86c3c96bc7f4cb074cb..5e732cdbbf808f7c29b1d990933fb7f9d4542497 100644 (file)
@@ -37,7 +37,7 @@
 #include <fstream>
 
 
-template<int dim>
+template <int dim>
 class MySquareFunction : public Function<dim>
 {
 public:
index cfc81b9622a67fbfd8bd7049afc6a624c8cbf950..2c1f09da56fdc928450a47af2a229df9bc086ddf 100644 (file)
@@ -44,7 +44,7 @@ public:
 };
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   const HyperBallBoundary<dim> boundary_description;
index fed0179a4ec5919a4c2cb31a051df752baabbbe6..7da555a2537648ebe836a17359240997d5596682 100644 (file)
@@ -47,7 +47,7 @@ public:
 };
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   const HyperBallBoundary<dim> boundary_description;
index 57d01d0a3c3004ebf84cfeb07aca1ca5b0079fe5..5a63afbc11ea8b8dbce4ee03b9bc39f7edd47349 100644 (file)
@@ -48,7 +48,7 @@ public:
 };
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   const HyperBallBoundary<dim> boundary_description;
index 11bf4d24dea226066c7e89ec7da975ee52556cf4..32fe9be6d3a6f777cd8fd229b081973df7fe188e 100644 (file)
@@ -52,7 +52,7 @@ public:
 
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   const HyperBallBoundary<dim> boundary_description;
index 287589f2ad2b3bf7f5b1d592a969393ee6ebcd6a..c547a98b4a137e4e4502d390e55084eb04a708a7 100644 (file)
@@ -52,7 +52,7 @@ public:
 
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   const HyperBallBoundary<dim> boundary_description;
index 3fb40176f4a4ffae513186b8f83eb51f5dcbd933..2d255e58820e128f5cc41cb18013c97ae779b849 100644 (file)
@@ -61,7 +61,7 @@ public:
 
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   const HyperBallBoundary<dim> boundary_description;
index aab8bc5e4ee34b209d4716167d015952e4a5b6d8..185d8f2495ec1d6ff93ce7c1aaa0b36eb79d9633 100644 (file)
@@ -61,7 +61,7 @@ public:
 
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   const HyperBallBoundary<dim> boundary_description;
index c0e07ac0e4e852b3b022920f4218eedd0e95528a..ff69cbbd92a4608d821a548f12956f4a62e48203 100644 (file)
@@ -40,7 +40,7 @@
 
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   // 0 components is not okay
index aac82aead388cb51903e1a539e0c29edaa98a093..bd3d7a692cc09cde9db2a32b51a88345493a3a97 100644 (file)
@@ -37,7 +37,7 @@
 #include <iomanip>
 
 
-template<int dim>
+template <int dim>
 class MySquareFunction : public Function<dim>
 {
 public:
@@ -57,7 +57,7 @@ public:
 };
 
 
-template<int dim>
+template <int dim>
 class MyExpFunction : public Function<dim>
 {
 public:
index 6b11ccd3b6b2705de1f98d7e1d6f8645f637c99b..2c9258f2c40b58141e6318f1278a6ba49ce985b6 100644 (file)
@@ -41,7 +41,7 @@
 #include <iomanip>
 
 
-template<int dim>
+template <int dim>
 class MySquareFunction : public Function<dim>
 {
 public:
@@ -61,7 +61,7 @@ public:
 };
 
 
-template<int dim>
+template <int dim>
 class MyExpFunction : public Function<dim>
 {
 public:
index 5c5dd049215fbb3f99be54efde420e534433ebe2..74661b81f8d6b83a54366db16f01b553d8d33e4a 100644 (file)
@@ -36,7 +36,7 @@
 #include <iomanip>
 
 
-template<int dim>
+template <int dim>
 class MySquareFunction : public Function<dim>
 {
 public:
@@ -72,7 +72,7 @@ public:
 };
 
 
-template<int dim>
+template <int dim>
 class MyExpFunction : public Function<dim>
 {
 public:
index bec0b660a630afcb5a3e31f67e765fc6c29ae6fa..74221772a770d231a4a5b82bbf905d963e94cd8d 100644 (file)
@@ -37,7 +37,7 @@
 #include <iomanip>
 
 
-template<int dim>
+template <int dim>
 class MySquareFunction : public Function<dim>
 {
 public:
@@ -73,7 +73,7 @@ public:
 };
 
 
-template<int dim>
+template <int dim>
 class MyExpFunction : public Function<dim>
 {
 public:
index 7f92eb07ce44d45c42d33f2706392d4f2ef269b0..ae5fc80d25756a294335cf74f4ff82ac3fcb22a3 100644 (file)
@@ -37,7 +37,7 @@
 #include <iomanip>
 
 
-template<int dim>
+template <int dim>
 class MySquareFunction : public Function<dim>
 {
 public:
@@ -73,7 +73,7 @@ public:
 };
 
 
-template<int dim>
+template <int dim>
 class MyExpFunction : public Function<dim>
 {
 public:
index 8405ab7014ef3b66917fbcb9648a908fd4332b4b..41c1f7fdf93c2452fa01f7e29939adb09333b205 100644 (file)
@@ -38,7 +38,7 @@
 #include <iomanip>
 
 
-template<int dim>
+template <int dim>
 class MySquareFunction : public Function<dim>
 {
 public:
@@ -74,7 +74,7 @@ public:
 };
 
 
-template<int dim>
+template <int dim>
 class MyExpFunction : public Function<dim>
 {
 public:
index c3ab8a2ee548ffa4e1482501adb20fe6890f64b1..4bf5485e4dd1d755728e4e4d601f5aad5d302c32 100644 (file)
@@ -36,7 +36,7 @@
 #include <iomanip>
 
 
-template<int dim>
+template <int dim>
 class MySquareFunction : public Function<dim>
 {
 public:
@@ -56,7 +56,7 @@ public:
 };
 
 
-template<int dim>
+template <int dim>
 class MyExpFunction : public Function<dim>
 {
 public:
index a5405471b53e34b523864fc44c9b44f602b549d5..7656cb761cebac6bcbbae1bb59545c890e0354bf 100644 (file)
@@ -37,7 +37,7 @@
 #include <iomanip>
 
 
-template<int dim>
+template <int dim>
 class MySquareFunction : public Function<dim>
 {
 public:
@@ -57,7 +57,7 @@ public:
 };
 
 
-template<int dim>
+template <int dim>
 class MyExpFunction : public Function<dim>
 {
 public:
index 6a7aea8c76e79b90d7f0708a22e26a04fc02cce1..8fa537394652a3d4fdfad7a4760025688b390a1e 100644 (file)
@@ -37,7 +37,7 @@
 #include <iomanip>
 
 
-template<int dim>
+template <int dim>
 class MySquareFunction : public Function<dim>
 {
 public:
@@ -57,7 +57,7 @@ public:
 };
 
 
-template<int dim>
+template <int dim>
 class MyExpFunction : public Function<dim>
 {
 public:
index e2898cb955a645056d45f6b9e2e38eb203fc2780..b444cae9a295ebc31ff8e1fbda81e09b69a1084b 100644 (file)
@@ -38,7 +38,7 @@
 #include <iomanip>
 
 
-template<int dim>
+template <int dim>
 class MySquareFunction : public Function<dim>
 {
 public:
@@ -58,7 +58,7 @@ public:
 };
 
 
-template<int dim>
+template <int dim>
 class MyExpFunction : public Function<dim>
 {
 public:
index 598f102988bfa1db788223d7ac0530d8eee7046c..bdf97a8848ffca5df89a58c1ee0e7eadf64fa470 100644 (file)
@@ -39,7 +39,7 @@
 #include <vector>
 
 
-template<int dim>
+template <int dim>
 class MyFunction : public Function<dim>
 {
 public:
index 2733a2dc53a57c9c502ec87edf922fd7b36c0d92..3641aae9bce3382410f3ce4a73f1e8cfd060aaf9 100644 (file)
@@ -54,7 +54,7 @@
 
 std::ofstream logfile("output");
 
-template<int spacedim>
+template <int spacedim>
 class BEM
 {
 
index aef5dc33134142d6cedb188166c76a7cffc07a32..97399c9f8d734c07378c7561229c9326039699d0 100644 (file)
@@ -37,7 +37,7 @@
 #include <fstream>
 
 
-template<int dim>
+template <int dim>
 class MySquareFunction : public Function<dim>
 {
 public:
@@ -67,7 +67,7 @@ get_q_face ()
   return q;
 }
 
-template<>
+template <>
 Quadrature<0> &
 get_q_face <1>()
 {
index c08315fbdb577bf106eeb3004ca00cfe211b2014..90ee7423618f53f06afae898562840f853a8ff85 100644 (file)
@@ -40,7 +40,7 @@
 
 
 // function is x^2+2xy
-template<int dim>
+template <int dim>
 class MyFunction : public Function<dim>
 {
 public:
@@ -62,7 +62,7 @@ public:
 
 
 // normal derivative of function above is 0 except for x=1, y=1 with n=(0,1,0)
-template<int dim>
+template <int dim>
 class MyNormalDerivative : public Function<dim>
 {
 public:
@@ -97,7 +97,7 @@ get_q_face ()
   return q;
 }
 
-template<>
+template <>
 Quadrature<0> &
 get_q_face <1>()
 {
index 0b5fedca95f458da13f702cfdbf3a54a56f0eac5..80b48cc28ec2e72b3c73b077cc18d8f1718fe06f 100644 (file)
@@ -43,7 +43,7 @@
 #include <deal.II/fe/mapping_q_eulerian.h>
 #include <deal.II/fe/mapping_fe_field.h>
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void test(const unsigned int refs,
           const unsigned int degree,
           const unsigned int subdivisions)
index 3beff049086800e0966e6f0a1968f80956b359b9..1ddcdb70c7afecd087a048154e1d4d8413b6597a 100644 (file)
@@ -29,7 +29,7 @@
 #include <fstream>
 
 
-template<int dim>
+template <int dim>
 void test(std::ostream & /*out*/)
 {
   if (true)
index 75165dd1b6b0dcaabc50c221c8fc56643c6e7431..93032f8999168ca2324518e876e315ce764c9e3a 100644 (file)
@@ -31,7 +31,7 @@
 
 
 
-template<int dim>
+template <int dim>
 void test(std::ostream & /*out*/)
 {
   parallel::distributed::Triangulation<dim> tr(MPI_COMM_WORLD);
index 24d8d81a1184532c416b3ea2aa49e3ba5db7cf0e..742ae41cc824fa8c26e90be1277e639607c2b6e3 100644 (file)
@@ -29,7 +29,7 @@
 
 
 
-template<int dim>
+template <int dim>
 void test(std::ostream & /*out*/)
 {
   parallel::distributed::Triangulation<dim> tr(MPI_COMM_WORLD);
index 48ec887525b0060c34553d1842864f16e8a3b426..6cb85a5574d681dfac3f770a33ec3e66d677fc6f 100644 (file)
@@ -28,7 +28,7 @@
 #include <deal.II/grid/grid_in.h>
 
 
-template<int dim>
+template <int dim>
 void test(std::ostream & /*out*/)
 {
   parallel::distributed::Triangulation<dim> tr(MPI_COMM_WORLD);
index a328e16110d7290d746c6ea78ccc15a4ff6fc7b2..01369e96dccb2f57b9a492da204ceebb03435a94 100644 (file)
@@ -30,7 +30,7 @@
 #include <fstream>
 
 
-template<int dim>
+template <int dim>
 void test(std::ostream & /*out*/)
 {
   if (true)
index 8888fadbe2eb52d7cabaa09a3ccd59b87fdf694e..275d5e526f787a5804108157f7d921a75509a098 100644 (file)
@@ -32,7 +32,7 @@
 #include <fstream>
 
 
-template<int dim>
+template <int dim>
 void test(std::ostream & /*out*/)
 {
   parallel::distributed::Triangulation<dim> tr(MPI_COMM_WORLD);
index 1353a1e2c4621f7bf3fe15963d08134049b627ef..12588f0228858ccb73262b943fdbd7af1c697d33 100644 (file)
@@ -47,7 +47,7 @@
 #include <cstdlib>
 
 
-template<int dim>
+template <int dim>
 void test(std::ostream & /*out*/)
 {
   parallel::distributed::Triangulation<dim> tr(MPI_COMM_WORLD);
index 64fa4ba900f5ea497c6ffe0045609d02ad25a1e2..1a772c98873f610e801fb2e4a6297298ee128cdc 100644 (file)
@@ -34,7 +34,7 @@
 #include <cstdlib>
 
 
-template<int dim>
+template <int dim>
 void test(std::ostream & /*out*/)
 {
   parallel::distributed::Triangulation<dim> tr(MPI_COMM_WORLD);
index 21c5c4b010edf81c7fedd70c0e98c11238920246..bc267f050cab47160188622f5ac5edada1fced5d 100644 (file)
@@ -37,7 +37,7 @@
 #include <cstdlib>
 
 
-template<int dim>
+template <int dim>
 void test(std::ostream & /*out*/)
 {
   parallel::distributed::Triangulation<dim> tr(MPI_COMM_WORLD);
index a169d771a863c47dfef0eb0010df771bfa31792b..6b1a6d6654794240d45cf796547ae57a875699ff 100644 (file)
@@ -37,7 +37,7 @@
 #include <fstream>
 
 
-template<int dim>
+template <int dim>
 void test(std::ostream & /*out*/)
 {
   deallog << "hyper_cube" << std::endl;
index bf23acd719970db93124e002bb67d2cea9cff401..8643b296acc66c5c4cd43318fd24f01af04cb067 100644 (file)
@@ -32,7 +32,7 @@
 #include <fstream>
 
 
-template<int dim>
+template <int dim>
 void test(std::ostream & /*out*/)
 {
   parallel::distributed::Triangulation<dim> tr(MPI_COMM_WORLD);
index 0c16f45324410adbbe4f725a0e2088fcc45bfc2d..d4001ccdc4076cc8461f1613dd5f5eded9194449 100644 (file)
@@ -50,7 +50,7 @@
 #include <cstdlib>
 
 
-template<int dim>
+template <int dim>
 void test(std::ostream & /*out*/)
 {
   parallel::distributed::Triangulation<dim> tr(MPI_COMM_WORLD);
index df522d3d44a2c1e40a2ac1dd474e31bcd6bfa75e..2b6e19f99424702e095a455b3edbed7e4a12f980 100644 (file)
@@ -34,7 +34,7 @@
 #include <cstdlib>
 
 
-template<int dim>
+template <int dim>
 void test(std::ostream & /*out*/)
 {
   parallel::distributed::Triangulation<dim> tr(MPI_COMM_WORLD);
index 99a3ce1fd4d9af91f37e8128075594034ebe83e9..d3fd13ddd1d81069809d2c5e63ad8bd9dfc63d99 100644 (file)
@@ -39,7 +39,7 @@
 #include <cstdlib>
 
 
-template<int dim>
+template <int dim>
 void test(std::ostream & /*out*/)
 {
   for (unsigned int i=0; i<GeometryInfo<dim>::max_children_per_cell; ++i)
index 5663696e1bb8f8af6f1a9b9ea77ec165953edaa4..888d98e06597c8cdf25f07cccf94370e2b6b2672 100644 (file)
@@ -38,7 +38,7 @@
 #include <cstdlib>
 
 
-template<int dim>
+template <int dim>
 void test(std::ostream & /*out*/)
 {
   parallel::distributed::Triangulation<dim> tr(MPI_COMM_WORLD);
index 7aaa457ce823b2dced4cb0c27d27d2b5e6080565..863c782727467026c6e6084149a5275e3c370ae7 100644 (file)
@@ -34,7 +34,7 @@
 #include <fstream>
 
 
-template<int dim>
+template <int dim>
 void test(std::ostream & /*out*/)
 {
   {
index 6961e0387d30db9bcfcb715dba84684e8a36aeae..503c4253b7073f5b547dac54a0636e7f1ab75fa2 100644 (file)
@@ -31,7 +31,7 @@
 #include <fstream>
 
 
-template<int dim>
+template <int dim>
 void test(std::ostream & /*out*/)
 {
   parallel::distributed::Triangulation<dim> tr(MPI_COMM_WORLD);
index 0b19ca1d25391a9a078eaa63b5361435c3ec090b..bdb9c2c820f583973aa1af69c95a7b83c092164d 100644 (file)
@@ -46,9 +46,9 @@ using namespace dealii;
 // mesh, uncomment the following macro definition.
 // #define __WRITE_VTU__
 
-template<int dim> class Location;
+template <int dim> class Location;
 
-template<int dim>
+template <int dim>
 class TriaTest
 {
 private:
@@ -68,7 +68,7 @@ private:
 };
 
 // Equip class Point<dim> with operator < in order to sort the cell center coordinates.
-template<int dim>
+template <int dim>
 class Location: public Point<dim>
 {
 public:
@@ -172,7 +172,7 @@ int main (int argc, char *argv[])
   return (0);
 }
 
-template<int dim>
+template <int dim>
 TriaTest<dim>::TriaTest(const typename dealii::Triangulation<dim>::MeshSmoothing smoothing_option)
   :
   mpi_communicator(MPI_COMM_WORLD),
@@ -200,7 +200,7 @@ TriaTest<dim>::TriaTest(const typename dealii::Triangulation<dim>::MeshSmoothing
   // triangulation.refine_global(1);
 }
 
-template<int dim>
+template <int dim>
 void TriaTest<dim>::run(std::vector<unsigned int> &n_cell,
                         std::set<Location<dim> > &position_list)
 {
@@ -272,7 +272,7 @@ void TriaTest<dim>::run(std::vector<unsigned int> &n_cell,
   return;
 }
 
-template<int dim>
+template <int dim>
 void TriaTest<dim>::write_vtu(const unsigned int counter) const
 {
 #ifdef __WRITE_VTU__
index c0b7efe74076ffb9af9fa97b97bdd8587d01092a..d2578f64d03e26b538dfb6cbe3c39e19e11b811d 100644 (file)
@@ -29,7 +29,7 @@
 #include <fstream>
 
 
-template<int dim>
+template <int dim>
 void test(std::ostream & /*out*/)
 {
   if (true)
index 05fa88684aeed069b646db8dd7f6b37aeedfa382..887523b41357513005cdd3f0d69e7deff22610f9 100644 (file)
@@ -31,7 +31,7 @@
 
 
 
-template<int dim>
+template <int dim>
 void test(const char *filename)
 {
   const char *p = strrchr(filename,'/');
index 7e0af4d3e9d0e3ed876ae5a8d0da48efdbfa135d..e89a59a7b8ee57ddd1838b1199735b105685bf2d 100644 (file)
@@ -29,7 +29,7 @@
 
 
 
-template<int dim>
+template <int dim>
 void test(std::ostream & /*out*/)
 {
   parallel::distributed::Triangulation<dim> tr(MPI_COMM_WORLD);
index 213f33d20faad26dea2cf504fbbfa47e8e86a69c..73af5069415044c9e3c0bdd7b44dbcd1f86a4a74 100644 (file)
@@ -28,7 +28,7 @@
 #include <deal.II/grid/grid_in.h>
 
 
-template<int dim>
+template <int dim>
 void test(std::ostream & /*out*/)
 {
   parallel::distributed::Triangulation<dim> tr(MPI_COMM_WORLD);
index 548362e84a179ea843e3fe047d63c576084385f1..b05d8ab8a062f38ce7da758111d156894d1e3d68 100644 (file)
@@ -131,7 +131,7 @@ void create_disconnected_mesh (Triangulation<dim> &tria)
 
 
 
-template<int dim>
+template <int dim>
 void test(std::ostream & /*out*/)
 {
   parallel::distributed::Triangulation<dim> tr(MPI_COMM_WORLD);
index 5b4288dcd66446b2bd389c005b76068bb7fdac77..fe48a3d3a0ea838d84c8cea6aebe07abea54e7b9 100644 (file)
@@ -29,7 +29,7 @@
 #include <deal.II/grid/grid_in.h>
 
 
-template<int dim>
+template <int dim>
 void test(std::ostream & /*out*/)
 {
   parallel::distributed::Triangulation<dim> tr(MPI_COMM_WORLD);
index 0838df646721b9c079703992bb3a8f3b771e43cd..57a46ff0616a579121af35ed2aed61937beb0693 100644 (file)
@@ -30,7 +30,7 @@
 #include <fstream>
 
 
-template<int dim>
+template <int dim>
 void test(std::ostream & /*out*/)
 {
   if (true)
index 73e7e3ae7d5cd27f79783b3313fdea2516cd1be1..39744a66f65033e6a7263d992816c4491c32192f 100644 (file)
@@ -32,7 +32,7 @@
 #include <fstream>
 
 
-template<int dim>
+template <int dim>
 void test(std::ostream & /*out*/)
 {
   parallel::distributed::Triangulation<dim> tr(MPI_COMM_WORLD);
index 54e2b50ccacbbf155129cb915efe3ef666779936..288a025ed602c441a22d586d4da4dbcdc6deae5c 100644 (file)
@@ -47,7 +47,7 @@
 #include <cstdlib>
 
 
-template<int dim>
+template <int dim>
 void test(std::ostream & /*out*/)
 {
   parallel::distributed::Triangulation<dim> tr(MPI_COMM_WORLD);
index 27f8e95a9475e8d1212a2ad2d8cb80b84768e40e..f5c3516c772c857ab27b6c08ebaa7198bc50f280 100644 (file)
@@ -34,7 +34,7 @@
 #include <cstdlib>
 
 
-template<int dim>
+template <int dim>
 void test(std::ostream & /*out*/)
 {
   parallel::distributed::Triangulation<dim> tr(MPI_COMM_WORLD);
index 779a9de6e88c5eec06e52187167098e7132c715e..7a4c707d347c558b9781cde86f31d0071c4da45f 100644 (file)
@@ -34,7 +34,7 @@
 #include <cstdlib>
 
 
-template<int dim>
+template <int dim>
 void test(std::ostream & /*out*/)
 {
   parallel::distributed::Triangulation<dim> tr(MPI_COMM_WORLD);
index 87efb526d4430aa9ba0715e9167aabac0c57b829..3cb9a8202a76b917e159e9a721a07b74ea63feec 100644 (file)
@@ -37,7 +37,7 @@
 #include <cstdlib>
 
 
-template<int dim>
+template <int dim>
 void test(std::ostream & /*out*/)
 {
   parallel::distributed::Triangulation<dim> tr(MPI_COMM_WORLD);
index 9dd63fbf2523fcc0b3386e74fd400c008f4c9c83..c59be66d804197147999bedaf96c93a461075ed0 100644 (file)
@@ -32,7 +32,7 @@
 #include <fstream>
 
 
-template<int dim>
+template <int dim>
 void test(std::ostream & /*out*/)
 {
   parallel::distributed::Triangulation<dim> tr(MPI_COMM_WORLD);
index ea514fbdf288895ff2a5fb9d51fe118e735abb9b..c5f61f16d9c73a8736727611df66bebee6bd5f2a 100644 (file)
@@ -50,7 +50,7 @@
 #include <cstdlib>
 
 
-template<int dim>
+template <int dim>
 void test(std::ostream & /*out*/)
 {
   parallel::distributed::Triangulation<dim> tr(MPI_COMM_WORLD);
index e4e8f08487bb1ff82bd635f44c227eff8e088660..2e59f2763a1bc3147014f0d42c3c8bbdcd065579 100644 (file)
@@ -34,7 +34,7 @@
 #include <cstdlib>
 
 
-template<int dim>
+template <int dim>
 void test(std::ostream & /*out*/)
 {
   parallel::distributed::Triangulation<dim> tr(MPI_COMM_WORLD);
index 2dd476d422819f17a9cd3b041f1e2469fd56112b..b9bd1c1ce1ec776ad63a78f44e178eaf2ae296aa 100644 (file)
@@ -39,7 +39,7 @@
 #include <cstdlib>
 
 
-template<int dim>
+template <int dim>
 void test(std::ostream & /*out*/)
 {
   for (unsigned int i=0; i<GeometryInfo<dim>::max_children_per_cell; ++i)
index 8d9fbcec9827a076ffdb8168a8c659dbea2800e5..71ae56b8f57888857f2f26f98572c4478ced554e 100644 (file)
@@ -37,7 +37,7 @@
 #include <cstdlib>
 
 
-template<int dim>
+template <int dim>
 void test(std::ostream & /*out*/)
 {
   parallel::distributed::Triangulation<dim> tr(MPI_COMM_WORLD);
index 4ec6626876801c6091664e283f3c05ceff06d9d0..2eb263a8534d8ebd178d4f0ef5fe6401f56544af 100644 (file)
@@ -37,7 +37,7 @@
 #include <fstream>
 
 
-template<int dim>
+template <int dim>
 void test(std::ostream & /*out*/)
 {
   {
index 71b78b088977486df259e7e7db9e97fdb7065dff..9096604f76134f600deb19b28bbdd49c76f16e9d 100644 (file)
@@ -34,7 +34,7 @@
 #include <fstream>
 
 
-template<int dim>
+template <int dim>
 void test(std::ostream & /*out*/)
 {
   {
index e6093750ac81913ac34d474cabe2ec433d56a107..9ccc48a8b3959722512dbc472428259d7de3002d 100644 (file)
@@ -34,7 +34,7 @@
 #include <cstdlib>
 
 
-template<int dim>
+template <int dim>
 void test(std::ostream & /*out*/)
 {
   parallel::distributed::Triangulation<dim> tr(MPI_COMM_WORLD);
index 1d155f131eed747c965155e7b83640ba6f27b9a4..eca91f3a6f18c0612a4627e1eee2def35de5c4a0 100644 (file)
@@ -31,7 +31,7 @@
 #include <fstream>
 
 
-template<int dim>
+template <int dim>
 void test(std::ostream & /*out*/)
 {
   parallel::distributed::Triangulation<dim> tr(MPI_COMM_WORLD);
index 21dc444f8f19a316a1c1cc832e87b6fc2872fa42..b0a7f18f47f481f2afcc1762acd1906b50a36ceb 100644 (file)
@@ -46,9 +46,9 @@ using namespace dealii;
 // mesh, uncomment the following macro definition.
 // #define __WRITE_VTU__
 
-template<int dim> class Location;
+template <int dim> class Location;
 
-template<int dim>
+template <int dim>
 class TriaTest
 {
 private:
@@ -68,7 +68,7 @@ private:
 };
 
 // Equip class Point<dim> with operator < in order to sort the cell center coordinates.
-template<int dim>
+template <int dim>
 class Location: public Point<dim>
 {
 public:
@@ -172,7 +172,7 @@ int main (int argc, char *argv[])
   return (0);
 }
 
-template<int dim>
+template <int dim>
 TriaTest<dim>::TriaTest(const typename dealii::Triangulation<dim>::MeshSmoothing smoothing_option)
   :
   mpi_communicator(MPI_COMM_WORLD),
@@ -200,7 +200,7 @@ TriaTest<dim>::TriaTest(const typename dealii::Triangulation<dim>::MeshSmoothing
   // triangulation.refine_global(1);
 }
 
-template<int dim>
+template <int dim>
 void TriaTest<dim>::run(std::vector<unsigned int> &n_cell,
                         std::set<Location<dim> > &position_list)
 {
@@ -272,7 +272,7 @@ void TriaTest<dim>::run(std::vector<unsigned int> &n_cell,
   return;
 }
 
-template<int dim>
+template <int dim>
 void TriaTest<dim>::write_vtu(const unsigned int counter) const
 {
 #ifdef __WRITE_VTU__
index 6a06bdcf8688e38fb9942afa168385ffe28d8cab..d128e23c6f4be42707778952a03c0790d564323e 100644 (file)
@@ -31,7 +31,7 @@
 #include <fstream>
 
 
-template<int dim>
+template <int dim>
 void test(std::ostream & /*out*/)
 {
   parallel::distributed::Triangulation<dim> tr(MPI_COMM_WORLD);
index 9030d56636632b761d70ecfe5af948c4aed27bc9..9a0dea398b36b0e00fd6230c0b9f02d899079d36 100644 (file)
@@ -31,7 +31,7 @@
 #include <fstream>
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void test(std::ostream & /*out*/)
 {
   parallel::distributed::Triangulation<dim,spacedim> tr(MPI_COMM_WORLD);
index af5767627661efe0d350f48527322caaa3ede80c..235d0818c678fa86473095806d63f888c475451e 100644 (file)
@@ -23,7 +23,7 @@
 #include <deal.II/distributed/tria.h>
 #include <deal.II/grid/grid_generator.h>
 
-template<int dim>
+template <int dim>
 void test()
 {
   Triangulation<dim> tr1;
index efde0b7d2494be056a7f5c5fd8ea684d2ec8990a..0f58b056ac6aedad6fb8158915016fa53d190269 100644 (file)
@@ -38,7 +38,7 @@
 #include <cstdlib>
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   parallel::distributed::Triangulation<dim>
index fab83eaf97b72bbc2cf00741555e0a3c2fe281ae..f94dbc772972c4f022a7aa62283ea46843698a9e 100644 (file)
@@ -38,7 +38,7 @@
 #include <cstdlib>
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   parallel::distributed::Triangulation<dim>
index 1db11648e824ee63363a0c3c35614e1d7cf0f8ad..9e06c852b2acd2f38f3fd42212b8aad1d55167ac 100644 (file)
@@ -39,7 +39,7 @@
 #include <cstdlib>
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   parallel::distributed::Triangulation<dim>
index 53958b9a6b766e7b1c609afdf8f22aed91bfca40..966d413d87dfde5803d51a944187cda036021849 100644 (file)
@@ -37,7 +37,7 @@
 #include <cstdlib>
 
 
-template<int dim>
+template <int dim>
 void test(std::ostream & /*out*/)
 {
   parallel::distributed::Triangulation<dim> tr(MPI_COMM_WORLD);
index dcaef9d4dbf8807f75a608729da9f160a147f592..3c84946e9b23a0e8a83106104f6ca73e97433b23 100644 (file)
@@ -40,7 +40,7 @@
 #include <fstream>
 #include <cstdlib>
 
-template<int dim>
+template <int dim>
 class MyFunction : public Function<dim>
 {
 public:
@@ -58,7 +58,7 @@ public:
   };
 };
 
-template<int dim>
+template <int dim>
 void test(std::ostream & /*out*/)
 {
   MyFunction<dim> func;
index 36d211b5a5f84977c8164c45cb4e54f25643956f..2b3c41149b6095ba4b01cfc5e0a35c5590a129d5 100644 (file)
@@ -43,7 +43,7 @@
 
 #include <deal.II/grid/grid_out.h>
 
-template<int dim>
+template <int dim>
 class MyFunction : public Function<dim>
 {
 public:
@@ -61,7 +61,7 @@ public:
   };
 };
 
-template<int dim>
+template <int dim>
 void test(std::ostream & /*out*/)
 {
   MyFunction<dim> func;
index 3b5c2ccfaf3022564b6d710781f2746b0afffbf1..5c025ebe13c7a46a78b90c2812274f3401b34a7b 100644 (file)
@@ -37,7 +37,7 @@
 #include <cstdlib>
 
 
-template<int dim>
+template <int dim>
 void test(std::ostream & /*out*/)
 {
   parallel::distributed::Triangulation<dim> tr(MPI_COMM_WORLD);
index 10d231b7bd930050808f29b0ad6935d1fd41ad39..9dc6542c25689b96f7fcac38bd60d3605a43d0dc 100644 (file)
@@ -34,7 +34,7 @@
 
 #include <fstream>
 
-template<int dim>
+template <int dim>
 void testit(parallel::distributed::Triangulation<dim> &tr)
 {
   GridGenerator::hyper_cube(tr);
@@ -55,7 +55,7 @@ void testit(parallel::distributed::Triangulation<dim> &tr)
 }
 
 
-template<int dim>
+template <int dim>
 void test(std::ostream & /*out*/)
 {
   {
index 5e9dfd923cf957b60fc3975e26c1e98fa4dc61d0..dc702559a07dbe1cb5cf12a5fde6891813b1d521 100644 (file)
@@ -33,7 +33,7 @@
 
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   parallel::distributed::Triangulation<dim> tr (MPI_COMM_WORLD);
index 884990e5bc3a37ba705af9492e1c3ea0bd0c5cb4..37c7c9a824b655b4de174577d5ec3661ba142fd3 100644 (file)
@@ -51,7 +51,7 @@ void test_in_dim(const DoFHandlerType &d1, const DoFHandlerType &d2)
 }
 
 
-template<int dim>
+template <int dim>
 void init_tria (Triangulation<dim> &tr)
 {
   GridGenerator::hyper_cube(tr);
@@ -59,7 +59,7 @@ void init_tria (Triangulation<dim> &tr)
 }
 
 
-template<int dim>
+template <int dim>
 void init_dofs (DoFHandler<dim> &dof,
                 const Triangulation<dim> &tr,
                 const FiniteElement<dim> &fe)
index 42e288e61b26be63732986ea08552cbcd4ae13e8..d6bbf90c60cf2059e1b08a3354066dfbd6979775 100644 (file)
@@ -72,7 +72,7 @@ void test_grid(const Triangulation<dim> &tr,
 }
 
 
-template<int dim>
+template <int dim>
 void test_fe (const FiniteElement<dim> &fe)
 {
   Triangulation<dim> tr(Triangulation<dim>::limit_level_difference_at_vertices);
index 11bd1f38dd90d6d6cd79a566da431c72f414c894..35155ab7cb4b00c275ca32b9aead86e23e02f89a 100644 (file)
@@ -75,7 +75,7 @@ void test_grid(const Triangulation<dim> &tr,
 }
 
 
-template<int dim>
+template <int dim>
 void test_fe (const FiniteElement<dim> &fe)
 {
   Triangulation<dim> tr(Triangulation<dim>::limit_level_difference_at_vertices);
index 562ee2988e7c5dbe22e4fb1e1af73bd7f6a966ed..adc3e20c22d4d307fff0273950bbf8db73340a3c 100644 (file)
@@ -34,7 +34,7 @@
 
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   Triangulation<dim> triangulation (Triangulation<dim>::limit_level_difference_at_vertices);
index ca10c3343aac15d1c63f839557564e1a15098d87..1977cb4230c9637b5454c4b5bf8959d399759caf 100644 (file)
@@ -37,7 +37,7 @@
 #include <cstdlib>
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   Triangulation<dim> triangulation (Triangulation<dim>::limit_level_difference_at_vertices);
index 989ba3f27e2923628df99bb0e567f4349fbaa726..a3aab6ac677d25644fb80bae7924c61e57bb5ee3 100644 (file)
@@ -35,7 +35,7 @@
 #include <cstdlib>
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   Triangulation<dim> triangulation (Triangulation<dim>::limit_level_difference_at_vertices);
index 6fa19858dc60726450e7e3d5190dae9f428496b6..7a4e24c69627f0f9591eb91b9b12f4822b88c54d 100644 (file)
@@ -193,7 +193,7 @@ void generate_grid(Triangulation<3> &triangulation, int orientation)
  * Print out all face DoFs and support points as well as the actual
  * matching via make_periodicity_constraints
  */
-template<int dim>
+template <int dim>
 void print_matching(DoFHandler<dim> &dof_handler, bool constrain_only_velocity = false)
 {
   const FiniteElement<dim> &fe = dof_handler.get_fe();
index 8f0a5e380b65c96a53c45ae52d2e67e7c3155177..7da7e6b4ed8c307b16f74e05942fbf02ae907e81 100644 (file)
@@ -114,7 +114,7 @@ void generate_grid(Triangulation<2> &triangulation)
  * Print out all face DoFs and support points as well as the actual
  * matching via make_periodicity_constraints
  */
-template<int dim>
+template <int dim>
 void print_matching(DoFHandler<dim> &dof_handler)
 {
   const FiniteElement<dim> &fe = dof_handler.get_fe();
index 77f7c5cbf6f06f65c2ce2ab48e6b1b37d146594b..a3b91a88258554cbeb2a9b36c5a151f4a1c8d2a4 100644 (file)
@@ -148,7 +148,7 @@ void generate_grid(Triangulation<2> &triangulation)
  * Print out all face DoFs and support points as well as the actual
  * matching via make_periodicity_constraints
  */
-template<int dim>
+template <int dim>
 void print_matching(DoFHandler<dim> &dof_handler)
 {
   const FiniteElement<dim> &fe = dof_handler.get_fe();
index c901f628e68c1140ba1bde076f4501e4f36f9ac6..6f19f41ef8e94ab37541cca2dd3f48a4f3efb2b8 100644 (file)
@@ -113,7 +113,7 @@ void generate_grid(Triangulation<2> &triangulation)
  * Print out all face DoFs and support points as well as the actual
  * matching via make_periodicity_constraints
  */
-template<int dim>
+template <int dim>
 void print_matching(DoFHandler<dim> &dof_handler)
 {
   const FiniteElement<dim> &fe = dof_handler.get_fe();
index 0b947c381422ced52e5c4e13d88bb4f592965741..64c1657003633b37a3398321abc9157093c40933 100644 (file)
@@ -198,7 +198,7 @@ void generate_grid(Triangulation<3> &triangulation, int orientation)
  * Print out all face DoFs and support points as well as the actual
  * matching via make_periodicity_constraints
  */
-template<int dim>
+template <int dim>
 void print_matching(DoFHandler<dim> &dof_handler, bool constrain_only_velocity = false)
 {
   const FiniteElement<dim> &fe = dof_handler.get_fe();
index d6109093e3cce2e1bbdc4f2c04ef1ed2f41c0b2b..6a3e12c4beb8cf05fbbf3015fd4c078cb6536ac3 100644 (file)
@@ -36,7 +36,7 @@
 #include <cstdio>
 
 
-template<int dim>
+template <int dim>
 bool
 pred_d(const typename DoFHandler<dim>::active_cell_iterator &cell)
 {
index c5aab334a4796095d011caf766cbe5b759727e01..185226a97eb2f08f234277b10e99ce3deba29d5c 100644 (file)
@@ -41,7 +41,7 @@
 #include <cstdio>
 
 
-template<int dim>
+template <int dim>
 bool
 pred_d(const typename DoFHandler<dim>::active_cell_iterator &cell)
 {
index 5a83f05a6be263a6d32b3a418c001306ea461e03..c01e3d1cd8fcf842439a7254f9e4fd00b633cd50 100644 (file)
 #include <cstdio>
 
 
-template<int dim>
+template <int dim>
 bool
 pred_left(const typename DoFHandler<dim>::active_cell_iterator &cell)
 {
   return (cell->center()(0) < 0.49);
 }
 
-template<int dim>
+template <int dim>
 bool
 pred_right(const typename DoFHandler<dim>::active_cell_iterator &cell)
 {
@@ -52,7 +52,7 @@ pred_right(const typename DoFHandler<dim>::active_cell_iterator &cell)
 }
 
 
-template<int dim>
+template <int dim>
 bool
 pred_r(const typename Triangulation<dim>::active_cell_iterator &cell)
 {
index 6c106e4605612f5550b8d15bfd3ee8057f14a202..9f34a9534ec285ad7958337a5aec9c4547318c97 100644 (file)
@@ -51,14 +51,14 @@ std::string output_name(const unsigned int subdomain)
          ".vtu";
 }
 
-template<int dim>
+template <int dim>
 bool
 pred_d(const typename DoFHandler<dim>::active_cell_iterator &cell)
 {
   return (cell->center()(0) < 0.49);
 }
 
-template<int dim>
+template <int dim>
 bool
 pred_r(const typename Triangulation<dim>::active_cell_iterator &cell)
 {
index d0b55c632b3c9cdc2090e60abb4272ad79833aa5..d0101673aedc3e5f77954c9ccc622c3a9e1cafbf 100644 (file)
@@ -34,7 +34,7 @@
 
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   Triangulation<dim> triangulation (Triangulation<dim>::limit_level_difference_at_vertices);
index 0247a065ef439dcd12bbb438f6fe8853bc10ecc6..c109749dbf81ebde4d67b4718d2c8d68c3d2ec09 100644 (file)
@@ -58,7 +58,7 @@ void write_mesh (const parallel::shared::Triangulation<dim,spacedim> &tria,
 
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   parallel::shared::Triangulation<dim>
index 862272b8f920c44e3119238df2c59f168624717d..b269e11b3a6c021eda54d9a0829af1cd486cbd2e 100644 (file)
@@ -29,7 +29,7 @@
 #include <string>
 
 
-template<int dim>
+template <int dim>
 void check()
 {
   Triangulation<dim> tr;
index c1738a0fb3108d3565d3199dedb1b8ae7b2260e3..3cd674f8bc278d8fec9617ec0ced743450e7fe60 100644 (file)
@@ -28,7 +28,7 @@
 
 
 
-template<int dim>
+template <int dim>
 void
 test(const unsigned int degree)
 {
index 874cf518c4fd13b9abb3e4ad51da974af38294ae..0cc5e614d54568f6603cf3bc3f2f05ee0b080922 100644 (file)
@@ -44,7 +44,7 @@
 #include <fstream>
 
 
-template<int dim>
+template <int dim>
 class MySquareFunction : public Function<dim>
 {
 public:
index 11d36764addb9ac56cdeb4ff9dd767915545e927..33712d147b3caee554192ce4c2d840ce2afbf1ac 100644 (file)
@@ -44,7 +44,7 @@
 #include <fstream>
 
 
-template<int dim>
+template <int dim>
 class MySquareFunction : public Function<dim>
 {
 public:
index 34e0e4da89e25c900da7a99e31fdf9b8d7b360d8..c2e3aa35e2e8029f7912559fea7a68d42fcf6089 100644 (file)
@@ -25,7 +25,7 @@
 
 
 
-template<unsigned int dim>
+template <unsigned int dim>
 void test (const unsigned int degree)
 {
   FE_ABF<dim> fe(degree);
index 09a2027984c0f868a4a867937843a2f1cb6069f6..445d516ced5dbd4829bca052fa95b2255105a7ea 100644 (file)
@@ -31,7 +31,7 @@
 
 
 
-template<int dim>
+template <int dim>
 inline void
 plot_shape_functions(const unsigned int degree)
 {
index c649efc5d20d169b17f54b5e863b720c7318ec05..69ab11dbd115867d17b9d21aa3bd3158cc4f52f9 100644 (file)
@@ -43,7 +43,7 @@
 
 std::ofstream logfile ("output");
 
-template<int dim>
+template <int dim>
 void
 test (const unsigned int degree)
 {
index e282f64debe14f353a777956b32a42a1dbde0ee0..f09b116df4c21a011ded3d8361792faa3d7006ee 100644 (file)
@@ -49,7 +49,7 @@
 
 std::ofstream logfile ("output");
 
-template<int dim>
+template <int dim>
 void
 test (const unsigned int degree)
 {
index 6e2a3ba2e7b6b287bd80758f63251df4033ac981..d2de4b23c2af9d5ad965d9f77290dc4f9cec7d2d 100644 (file)
@@ -42,7 +42,7 @@
 
 std::ofstream logfile ("output");
 
-template<int dim>
+template <int dim>
 void
 test (const unsigned int degree)
 {
index 05bde971ca30b6cd32dc3166e31d0ac2b47eec3e..c583bcf6b63e3268afba17c5bf1e7007502434f9 100644 (file)
@@ -47,7 +47,7 @@
 
 std::ofstream logfile ("output");
 
-template<int dim>
+template <int dim>
 void
 test (const unsigned int degree)
 {
index 2b1d50db01d02777fc6279a7f56e2d213afc1806..dc122ef0587ae17052dae8a5a28c610ade273b5c 100644 (file)
@@ -47,7 +47,7 @@
 
 std::ofstream logfile ("output");
 
-template<int dim>
+template <int dim>
 void
 test (const unsigned int degree)
 {
index f07bb57f9d9692f1b9fc6f84da65db9d81530ae0..bf0adeecf0bda0f20e9e4d0038742f920be0d184 100644 (file)
@@ -47,7 +47,7 @@
 
 std::ofstream logfile ("output");
 
-template<int dim>
+template <int dim>
 void
 test (const unsigned int degree)
 {
index 5674ee3d8cbb95b9d9e00f7e6f6a80dc5b913dba..deb2bdb0bab4e0d4567dd9b287039ab03ce7ed6d 100644 (file)
@@ -33,7 +33,7 @@
 
 std::ofstream logfile ("output");
 
-template<int dim>
+template <int dim>
 void
 test (const unsigned int degree)
 {
index 375c9e7e3d0d84236e01db0cf2b6dc52ece9e95b..170f7ab39469351821930bdf1e7ea5160bc8b105 100644 (file)
@@ -92,7 +92,7 @@ transform_grid (Triangulation<2> &tria,
 
 
 
-template<int dim>
+template <int dim>
 void
 plot_shape_functions(const unsigned int degree)
 {
index 1da2c9e3c2a7737c8fcc887333159c310d1b3741..a8a27e8a8723b85c01f9208fb77441e186d23273 100644 (file)
@@ -28,7 +28,7 @@
 
 
 
-template<int dim>
+template <int dim>
 void
 test(const unsigned int degree)
 {
index 3c93f2d32b97fefeb992ac032bb08ed4b614cf97..4220ba1787ff1e3d056206640b47a7623b74c926 100644 (file)
@@ -28,7 +28,7 @@
 
 
 
-template<int dim>
+template <int dim>
 void
 test(const unsigned int degree)
 {
index aa1131f5364f932b6f75e5f6780a47f12f261b91..54dc91308ec71914ad905dd4ff97c635485c5fbe 100644 (file)
@@ -41,7 +41,7 @@
 
 std::ofstream logfile ("output");
 
-template<int dim>
+template <int dim>
 void
 test (const unsigned int degree)
 {
index f4a06a2a0b1be9ce562f5a7b00af10cb7493ec78..c4d3ecff21836a77acb87f22135c8effff2d4122 100644 (file)
@@ -43,7 +43,7 @@
 
 std::ofstream logfile ("output");
 
-template<int dim>
+template <int dim>
 void
 test (const unsigned int degree)
 {
index 5c9a35635061704d055c4ce27048729b2d496157..95989f98c5b0c5bff00e7d903329ed03df127852 100644 (file)
@@ -61,7 +61,7 @@ bool equal (const FullMatrix<double> &m1,
 }
 
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr)
 {
   FE_Q<dim> fe(1);
index 8244c120f231a07b8d99029ed3f0b7d2718c2d0c..68f70f9e73cf1e4609cf8e84c1b7f8ab628936b3 100644 (file)
@@ -61,7 +61,7 @@ bool equal (const FullMatrix<double> &m1,
 }
 
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr)
 {
   FE_Q<dim> fe(2);
index 94950722b705216bc5d8b10379e2b09780b7bd6f..b74424214cb53e64071c7e96ed0bdeb1440aec9f 100644 (file)
@@ -61,7 +61,7 @@ bool equal (const FullMatrix<double> &m1,
 }
 
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr)
 {
   FE_Q<dim> fe(1);
index 71c7c9246c5a984efb5ca60d205e42245d1043f3..24e88aaf71b2ab9768439f85d2fd70ec7a17b438 100644 (file)
@@ -61,7 +61,7 @@ bool equal (const FullMatrix<double> &m1,
 }
 
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr)
 {
   FE_Q<dim> fe(2);
index 403a15ba32fe7ead052ea2039b3c32aa8d1233ea..765ae655b2c03cfe9fcbf901c97b9fa6ca15da48 100644 (file)
@@ -61,7 +61,7 @@ bool equal (const FullMatrix<double> &m1,
 }
 
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr)
 {
   FE_Q<dim> fe(1);
index 945d944a8675be8c82c98ddcb13117ae199722e9..dfc0e69a1da0476d0c440ba68cf5e1bcffa6c62d 100644 (file)
@@ -61,7 +61,7 @@ bool equal (const FullMatrix<double> &m1,
 }
 
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr)
 {
   FE_Q<dim> fe(2);
index 9265169226eb008bc545cc1caee0b17390fe54c9..6389bf7ac83f441c739946e38e8aaa447ca2042d 100644 (file)
@@ -61,7 +61,7 @@ bool equal (const FullMatrix<double> &m1,
 }
 
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr)
 {
   FE_Q<dim> fe(1);
index af695486046cca0b80164bb4183fff168ff03e3c..bedaf576ef15ba27be1f85ade6a34c3ec58c0c6b 100644 (file)
@@ -61,7 +61,7 @@ bool equal (const FullMatrix<double> &m1,
 }
 
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr)
 {
   FE_Q<dim> fe(2);
index a143b8de576fe16fbd6937e714bb9ea88393e234..c1abedaf41646cf0759a5e3710d2956702875a2b 100644 (file)
@@ -61,7 +61,7 @@ bool equal (const FullMatrix<double> &m1,
 }
 
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr)
 {
   FE_Q<dim> fe(1);
index 2a7dfe1f0dcd9b39df33b71d87ab7c0a5cf4713d..1136f1022a162e05498c682fa03ec1941aa957d7 100644 (file)
@@ -61,7 +61,7 @@ bool equal (const FullMatrix<double> &m1,
 }
 
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr)
 {
   FE_Q<dim> fe(2);
index b7ef996b9b89309b447c121adff35aeebb5924ca..64158011d8ed7b2bfb3f9a110896ab97bd1c4b0b 100644 (file)
@@ -43,7 +43,7 @@
 #include <fstream>
 
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr)
 {
   FE_Q<dim> fe(2);
index d19b6d6110240d536203a656676791ee45b68e2d..1990d56cf96a08119988390cd59311b0a491d3cf 100644 (file)
@@ -61,7 +61,7 @@ bool equal (const FullMatrix<double> &m1,
 }
 
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr)
 {
   FE_DGPMonomial<dim> fe(1);
index 1d8ea9945284ed918cce9ebc21cfd2fc71fa76b4..e52b3c7d72da0011f906339cbddbd3f8cddebaad 100644 (file)
@@ -61,7 +61,7 @@ bool equal (const FullMatrix<double> &m1,
 }
 
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr)
 {
   FE_DGPMonomial<dim> fe(2);
index 4a142e4df2de58ffdcad82e4ebcd4d04294706c2..0ac87a2928eb8bbc6f464836058e2a68104d5a8d 100644 (file)
@@ -61,7 +61,7 @@ bool equal (const FullMatrix<double> &m1,
 }
 
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr)
 {
   FE_DGPMonomial<dim> fe(1);
index 3263a4355276ad31e80af5f5a3dc0a7742511392..7e03c6c571f9477d6f966d034d87f85da67a48d0 100644 (file)
@@ -61,7 +61,7 @@ bool equal (const FullMatrix<double> &m1,
 }
 
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr)
 {
   FE_DGPMonomial<dim> fe(2);
index 1f092d253e95cdf645aeaeac3de86eb49aa5fd5f..524feae3f1457d91217feb6051c3787548ae6e2c 100644 (file)
@@ -61,7 +61,7 @@ bool equal (const FullMatrix<double> &m1,
 }
 
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr)
 {
   FE_DGPMonomial<dim> fe(1);
index bc038451f60fa0b6d29009dea6f100c04b3de868..cd2ece90aef367b81eefca6fb8efe68ede03a5b4 100644 (file)
@@ -61,7 +61,7 @@ bool equal (const FullMatrix<double> &m1,
 }
 
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr)
 {
   FE_DGPMonomial<dim> fe(2);
index ae46af435555ebcc24d343848aa0d02e4a4d0396..24c2e2ff7bf50fe34e3f97f88ebb3d5d703c0122 100644 (file)
@@ -61,7 +61,7 @@ bool equal (const FullMatrix<double> &m1,
 }
 
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr)
 {
   FE_DGPMonomial<dim> fe(1);
index 2a0824c7623068b32b84491b28dda33e54c714ac..a203b858304eedca95d73d6553256fe350c32f3f 100644 (file)
@@ -61,7 +61,7 @@ bool equal (const FullMatrix<double> &m1,
 }
 
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr)
 {
   FE_DGPMonomial<dim> fe(2);
index 3bfc6ff48d2f08d2e9d1a39e83d5b96c0aa04bac..b4e711b27593b71f963231925dd4cde5c3209ec3 100644 (file)
@@ -61,7 +61,7 @@ bool equal (const FullMatrix<double> &m1,
 }
 
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr)
 {
   FE_DGPMonomial<dim> fe(1);
index bd2c38f4d7617afa244c6c70ca81e5e891d6f54e..c5551ce7fa671751a4a0c977b68c8142be6e2e24 100644 (file)
@@ -61,7 +61,7 @@ bool equal (const FullMatrix<double> &m1,
 }
 
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr)
 {
   FE_DGPMonomial<dim> fe(2);
index c790e74dc32baa9a54957ee2173da2daa96e585b..8bfce6f9c419533d0a10097d3ea977a2891ebaf5 100644 (file)
@@ -61,7 +61,7 @@ bool equal (const FullMatrix<double> &m1,
 }
 
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr)
 {
   FE_DGPNonparametric<dim> fe(1);
index bb0de6511f6e894a4a98b758d7b19f3014bfaa07..f4091e577aa91b660dfe77b0984f0c7e07cc88d1 100644 (file)
@@ -61,7 +61,7 @@ bool equal (const FullMatrix<double> &m1,
 }
 
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr)
 {
   FE_DGPNonparametric<dim> fe(2);
index 0fddbf64ae686ef7b3caa94924a4affa696ca7e1..7095dbf3b7b1f0421796101cab603fcb6a733549 100644 (file)
@@ -61,7 +61,7 @@ bool equal (const FullMatrix<double> &m1,
 }
 
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr)
 {
   FE_DGPNonparametric<dim> fe(1);
index 39f0412586252e1e57b72ae8423e2d10a70d9fb4..8d36e8adb9c65f1b0f5f0b097539d5172d62283d 100644 (file)
@@ -61,7 +61,7 @@ bool equal (const FullMatrix<double> &m1,
 }
 
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr)
 {
   FE_DGPNonparametric<dim> fe(2);
index 6125dfe8dd6b396a7b1520c29987bce6d8266d58..9fe52710dc1467777f39c22582f7d5e8e75a0c91 100644 (file)
@@ -61,7 +61,7 @@ bool equal (const FullMatrix<double> &m1,
 }
 
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr)
 {
   FE_DGPNonparametric<dim> fe(1);
index 3f3674d23517901055c120f320b2bb3676d9408e..6ea6f85d127c883af8f6eac2b3bd93c8f706406a 100644 (file)
@@ -61,7 +61,7 @@ bool equal (const FullMatrix<double> &m1,
 }
 
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr)
 {
   FE_DGPNonparametric<dim> fe(2);
index be99e576fb90ca6e1bbb04ba5cc6238844de3125..90eb61c35a60536cadd87f65e291ef106a4353ca 100644 (file)
@@ -61,7 +61,7 @@ bool equal (const FullMatrix<double> &m1,
 }
 
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr)
 {
   FE_DGPNonparametric<dim> fe(1);
index 817850a4aff639cbc9ea6a793cd2b1d61d87d2e4..4926c09b9ecacf7cde6aa8a2eff15c281fc2ce3d 100644 (file)
@@ -61,7 +61,7 @@ bool equal (const FullMatrix<double> &m1,
 }
 
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr)
 {
   FE_DGPNonparametric<dim> fe(2);
index d01a563bcaf39cc543d5d40760c6fc6b08c8c1c5..a58c92a58a4ee6a69037c70df76c7284d52ba982 100644 (file)
@@ -61,7 +61,7 @@ bool equal (const FullMatrix<double> &m1,
 }
 
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr)
 {
   FE_DGPNonparametric<dim> fe(1);
index cf412505d6c227b7ce2fe2573c430725457dabd7..f0ff4fdef45937b51355b3d760b1f6345c15020c 100644 (file)
@@ -61,7 +61,7 @@ bool equal (const FullMatrix<double> &m1,
 }
 
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr)
 {
   FE_DGPNonparametric<dim> fe(2);
index 9b0c5795a76d70b9024cede3dc14714caa5af2bc..a6a390f165567df50467bcf7d411dc63f8259a1c 100644 (file)
@@ -31,7 +31,7 @@
 
 
 
-template<int dim>
+template <int dim>
 void
 test(const unsigned int degree)
 {
index 95d214df30640c1ffa859b8efb64f5c0343a5a6a..abfc415d039b1005165c73d0501465bdc37b063a 100644 (file)
@@ -94,7 +94,7 @@ private:
   ConvergenceTable     convergence_table;
 };
 // EXACT SOLUTION CLASS
-template<int dim>
+template <int dim>
 class ExactSolution : public Function<dim>
 {
 public:
@@ -130,7 +130,7 @@ private:
 template <int dim> const double RightHandSide<dim>::bc_constant = 0.1;
 
 // DEFINE EXACT SOLUTION MEMBERS
-template<int dim>
+template <int dim>
 double ExactSolution<dim>::value(const Point<dim> &p,
                                  const unsigned int component) const
 {
@@ -148,7 +148,7 @@ double ExactSolution<dim>::value(const Point<dim> &p,
   return val;
 
 }
-template<int dim>
+template <int dim>
 void ExactSolution<dim>::vector_value(const Point<dim> &p,
                                       Vector<double> &result) const
 {
@@ -237,7 +237,7 @@ MaxwellProblem<dim>::~MaxwellProblem ()
   dof_handler.clear ();
 }
 
-template<int dim>
+template <int dim>
 double MaxwellProblem<dim>::dotprod(const Tensor<1,dim> &A, const Tensor<1,dim> &B) const
 {
   double return_val = 0;
@@ -248,7 +248,7 @@ double MaxwellProblem<dim>::dotprod(const Tensor<1,dim> &A, const Tensor<1,dim>
   return return_val;
 }
 
-template<int dim>
+template <int dim>
 double MaxwellProblem<dim>::dotprod(const Tensor<1,dim> &A, const Vector<double> &B) const
 {
   double return_val = 0;
@@ -362,7 +362,7 @@ void MaxwellProblem<dim>::solve ()
   constraints.distribute (solution);
 
 }
-template<int dim>
+template <int dim>
 void MaxwellProblem<dim>::process_solution(const unsigned int cycle)
 {
   const ExactSolution<dim> exact_solution;
index 131dd480fcf33c1095dfde9e2f39af715a962116..c1d5ac0b0367006714c14dd53d008f03968e3ce7 100644 (file)
@@ -32,7 +32,7 @@
 #include <string>
 
 
-template<int dim>
+template <int dim>
 inline void
 plot_derivatives(Mapping<dim> &mapping,
                  FiniteElement<dim> &finel,
@@ -78,7 +78,7 @@ plot_derivatives(Mapping<dim> &mapping,
 
 
 
-template<int dim>
+template <int dim>
 void plot_FE_Q_shape_functions()
 {
   MappingQGeneric<dim> m(1);
@@ -109,7 +109,7 @@ void plot_FE_Q_shape_functions()
 }
 
 
-template<int dim>
+template <int dim>
 void plot_FE_DGQ_shape_functions()
 {
   MappingQGeneric<dim> m(1);
index 57a2d2ec2e50092f6b220b4a1dc9939e21428b91..e34767887134f18826431146c8eb401b06372a8d 100644 (file)
@@ -32,7 +32,7 @@
 #include <deal.II/fe/fe_bernstein.h>
 //#include "../../include/fe_bernstein.h"
 
-template<int dim>
+template <int dim>
 inline void
 plot_derivatives(Mapping<dim> &mapping,
                  FiniteElement<dim> &finel,
@@ -78,7 +78,7 @@ plot_derivatives(Mapping<dim> &mapping,
 
 
 
-template<int dim>
+template <int dim>
 void plot_FE_Bernstein_shape_functions()
 {
   MappingQGeneric<dim> m(1);
index b43b6c122df627bdd0e5e5c57c1a255cd5623871..84920a588259ccaa673cea2a485f187386b11dce 100644 (file)
@@ -32,7 +32,7 @@
 #include <string>
 
 
-template<int dim>
+template <int dim>
 inline void
 plot_derivatives(Mapping<dim> &mapping,
                  FiniteElement<dim> &finel,
@@ -71,7 +71,7 @@ plot_derivatives(Mapping<dim> &mapping,
 
 
 
-template<int dim>
+template <int dim>
 void plot_FE_Q_shape_functions()
 {
   MappingQGeneric<dim> m(1);
@@ -87,7 +87,7 @@ void plot_FE_Q_shape_functions()
 }
 
 
-template<int dim>
+template <int dim>
 void plot_FE_DGQ_shape_functions()
 {
   MappingQGeneric<dim> m(1);
index ed640e65490f115346ca2c2d4a30e5cabca0e08b..17485f053d0ba2f389dbaef7cb2690e0ab0cbc34 100644 (file)
@@ -35,7 +35,7 @@
 
 
 
-template<int dim>
+template <int dim>
 void
 test(const unsigned int degree)
 {
index 0d18a731537b03c8433cb2b83c3310a3427ec501..2eefa147207c0720a51d5e0ef7a5d72abbd97f39 100644 (file)
@@ -31,7 +31,7 @@
 
 
 
-template<int dim>
+template <int dim>
 void
 test(const unsigned int degree)
 {
index 3590b1417bb1f1bb17fdaf26cbb283e2eaf442b7..659e4c99da2f39adbe609eec48a70f18eb2c8d30 100644 (file)
@@ -32,7 +32,7 @@
 
 
 
-template<int dim>
+template <int dim>
 void
 test(const unsigned int degree1,
      const unsigned int degree2)
index 83ec52cf58a7bf71703bcdfddffc48a63b5eb62f..52a5a839bfb45b601420df8db65b1256944e4c9e 100644 (file)
@@ -32,7 +32,7 @@
 
 
 
-template<int dim>
+template <int dim>
 void
 test(const unsigned int degree1,
      const unsigned int degree2)
index ed25585a38d00555dd1f1d3c4e6b36181ca04217..d8ae9e6c3f1372d91b2196710cac74137a92b1ee 100644 (file)
@@ -27,7 +27,7 @@
 #include <string>
 
 
-template<int dim>
+template <int dim>
 void print_constant_modes(const FiniteElement<dim> &fe)
 {
   deallog << "Testing " << fe.get_name() << std::endl;
@@ -43,7 +43,7 @@ void print_constant_modes(const FiniteElement<dim> &fe)
 }
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   print_constant_modes(FE_Q<dim>(1));
index cf65911659ef9572f4ad88b6b6390b9be0671430..1e1e77ecda0ce6546b1e95fa4ec226079ef22c6b 100644 (file)
@@ -25,7 +25,7 @@
 #include <deal.II/base/logstream.h>
 #include <deal.II/fe/fe_q.h>
 
-template<int dim>
+template <int dim>
 void test()
 {
   FE_Q<dim> fe(1);
index a25b438fd01a9f57503e6e0ad79636f8b4c71f28..fae484d146385421c34a5f2324c0a940145ea73d 100644 (file)
@@ -25,7 +25,7 @@
 #include <deal.II/base/logstream.h>
 #include <deal.II/fe/fe_q.h>
 
-template<int dim>
+template <int dim>
 void test()
 {
   FE_Q<dim> fe(2);
index 50d2f250be1b93a2bbfa84e05787809cdac49273..b3731ad67e0e7e2b20bce1a4c9a161509317bbae 100644 (file)
@@ -26,7 +26,7 @@
 #include <deal.II/fe/fe_q.h>
 #include <deal.II/fe/fe_system.h>
 
-template<int dim>
+template <int dim>
 void test()
 {
   FESystem<dim> fe(FE_Q<dim>(2), 1,
index 18a39863b2c441c0f6fb667427ab6e3ae4f74bcd..04db34ea690a1e2b887eace4a98734d8213ea70f 100644 (file)
@@ -25,7 +25,7 @@
 #include <deal.II/base/logstream.h>
 #include <deal.II/fe/fe_q.h>
 
-template<int dim>
+template <int dim>
 void test()
 {
   FE_Q<dim> fe(3);
index 7d2169e30258e7cc985ba244053d88e716e9aab9..078e96d44c52a999aa7597fd84ed6721cf202695 100644 (file)
@@ -26,7 +26,7 @@
 #include <deal.II/fe/fe_q.h>
 #include <deal.II/fe/fe_system.h>
 
-template<int dim>
+template <int dim>
 void test()
 {
   FESystem<dim> fe(FE_Q<dim>(3), 1,
index 941b7b8dc55c09d9fd970df6e822f118d83c2395..c8b30cdd89a551a589826bfd238fe8a7c86d1080 100644 (file)
@@ -25,7 +25,7 @@
 #include <deal.II/base/logstream.h>
 #include <deal.II/fe/fe_q.h>
 
-template<int dim>
+template <int dim>
 void test()
 {
   FE_Q<dim> fe(4);
index b32dae074dc3e2f9d103c63cb7b3998995e76c16..e46144ee042f464be38e00e2a21bd92fd443455d 100644 (file)
@@ -40,7 +40,7 @@
 
 
 
-template<int dim>
+template <int dim>
 Tensor<1,dim> ones ()
 {
   Tensor<1,dim> result;
@@ -49,7 +49,7 @@ Tensor<1,dim> ones ()
   return result;
 }
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr,
            const FiniteElement<dim> &fe,
            const double tolerance)
@@ -138,7 +138,7 @@ void test (const Triangulation<dim> &tr,
 
 
 
-template<int dim>
+template <int dim>
 void test_hyper_cube(const double tolerance)
 {
   Triangulation<dim> tr;
index ad3b589b275b53be848775da2c9c75a4f322f839..7ff59b52e6b07190bd683694cc861a4a6619c38d 100644 (file)
@@ -95,7 +95,7 @@ void test_2d_3d (std::vector<FiniteElement<1> *> &fe_datas)
 
 
 
-template<int dim>
+template <int dim>
 void test_fe_datas()
 {
   std::vector<FiniteElement<dim> *> fe_datas;
index 9a9cb63b1be4867c245d2b404d524ca1be7acf68..079f2bcabc4862e4c7f6b45c24ccc00b38265010 100644 (file)
@@ -38,7 +38,7 @@
 #include <sstream>
 #include <fstream>
 
-template<int dim>
+template <int dim>
 Tensor<1,dim> ones ()
 {
   Tensor<1,dim> result;
@@ -47,7 +47,7 @@ Tensor<1,dim> ones ()
   return result;
 }
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr,
            const FiniteElement<dim> &fe,
            const double tolerance)
@@ -143,7 +143,7 @@ void test (const Triangulation<dim> &tr,
 
 
 
-template<int dim>
+template <int dim>
 void test_hyper_ball(const double tolerance)
 {
   Triangulation<dim> tr;
index 730c27ba91a78233eb1b96ca34e94e69b684a945..5a8af7e6de2df04aee4abce119af7c23df17239d 100644 (file)
@@ -37,7 +37,7 @@
 #include <sstream>
 #include <fstream>
 
-template<int dim>
+template <int dim>
 Tensor<1,dim> ones ()
 {
   Tensor<1,dim> result;
@@ -46,7 +46,7 @@ Tensor<1,dim> ones ()
   return result;
 }
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr,
            const FiniteElement<dim> &fe,
            const double tolerance)
@@ -142,7 +142,7 @@ void test (const Triangulation<dim> &tr,
 
 
 
-template<int dim>
+template <int dim>
 void test_hyper_ball(const double tolerance)
 {
   Triangulation<dim> tr;
index 861ccf0ced7ea69b3eb26954d213d9455cc6332a..228c43f25501be79ed69cd2aa367f78d00d45c7a 100644 (file)
@@ -39,7 +39,7 @@
 
 
 
-template<int dim>
+template <int dim>
 Tensor<1,dim> ones ()
 {
   Tensor<1,dim> result;
@@ -48,7 +48,7 @@ Tensor<1,dim> ones ()
   return result;
 }
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr,
            const FiniteElement<dim> &fe,
            const double tolerance)
@@ -137,7 +137,7 @@ void test (const Triangulation<dim> &tr,
 
 
 
-template<int dim>
+template <int dim>
 void test_hyper_ball(const double tolerance)
 {
   Triangulation<dim> tr;
index 7b28af5ad04bf2d4fdd7ea65abb7053e651b8b2e..2611db3c01d9031d1fca41451a332ce24af68aea 100644 (file)
@@ -39,7 +39,7 @@
 
 
 
-template<int dim>
+template <int dim>
 Tensor<1,dim> ones ()
 {
   Tensor<1,dim> result;
@@ -48,7 +48,7 @@ Tensor<1,dim> ones ()
   return result;
 }
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr,
            const FiniteElement<dim> &fe,
            const double tolerance)
@@ -138,7 +138,7 @@ void test (const Triangulation<dim> &tr,
 
 
 
-template<int dim>
+template <int dim>
 void test_hyper_ball(const double tolerance)
 {
   Triangulation<dim> tr;
index 9413d6fe4ae07b620a2bfce734524f61f4443a08..937b273fab703b6b5803d3cbdf69077b8d5ad9c8 100644 (file)
@@ -47,7 +47,7 @@
 
 using namespace dealii;
 
-template<int dim>
+template <int dim>
 class EnrichmentFunction : public Function<dim>
 {
 public:
@@ -72,7 +72,7 @@ public:
   }
 };
 
-template<int dim>
+template <int dim>
 void test_base()
 {
   deallog << "Test basic functions:"<<std::endl;
index fb6ac2069ed53d9b9c3ebebc9c8c7b34d2120231..c1b0a05ad85782af91c9e7e978a72411c7ba1909 100644 (file)
@@ -55,7 +55,7 @@ using namespace dealii;
 // uncomment when debugging
 // #define DATA_OUT_FE_ENRICHED
 
-template<int dim>
+template <int dim>
 class EnrichmentFunction : public Function<dim>
 {
 public:
@@ -80,7 +80,7 @@ public:
   }
 };
 
-template<int dim>
+template <int dim>
 void test1()
 {
   deallog << "FEValues.shape_value()"<<std::endl;
index 73ec999994f7513f50f6b54f3f6e33a4f1ecf6ec..ebfea6b84694561f7b3b41f365359f5dda688724 100644 (file)
@@ -47,7 +47,7 @@
 
 using namespace dealii;
 
-template<int dim>
+template <int dim>
 class EnrichmentFunction : public Function<dim>
 {
 public:
index 2d3d921658ab4abb5afb6c4f28a31da506e24e17..1c27b0b6eae2789207d93c27df9a0dbef6453f75 100644 (file)
@@ -55,7 +55,7 @@ using namespace dealii;
 // uncomment when debugging
 // #define DATA_OUT_FE_ENRICHED
 
-template<int dim>
+template <int dim>
 class EnrichmentFunction : public Function<dim>
 {
 public:
@@ -81,7 +81,7 @@ public:
 };
 
 
-template<int dim>
+template <int dim>
 void test3()
 {
   deallog << "FEValues.get_function_values()"<<std::endl;
index 6a2a63ce30ec0dbefddd3ede3c90a757ea27cf08..6b15363ea3dce8479f35914d0fa832614ffea1e3 100644 (file)
@@ -55,7 +55,7 @@ using namespace dealii;
 // uncomment when debugging
 // #define DATA_OUT_FE_ENRICHED
 
-template<int dim>
+template <int dim>
 class EnrichmentFunction : public Function<dim>
 {
 public:
index 01b33e104ef830b90b349bbf586aa09d7513d3a5..e03e093d0796bf72385473448c7fbb961c45a40c 100644 (file)
@@ -56,7 +56,7 @@ using namespace dealii;
 // uncomment when debugging
 // #define DATA_OUT_FE_ENRICHED
 
-template<int dim>
+template <int dim>
 class EnrichmentFunction : public Function<dim>
 {
 public:
index d0512022fe001b2472e7e55bd58acb713e841d14..f94c1a8b4d546e0110df9c20b483847fa9fa8a17 100644 (file)
@@ -55,7 +55,7 @@ using namespace dealii;
 // uncomment when debugging
 // #define DATA_OUT_FE_ENRICHED
 
-template<int dim>
+template <int dim>
 class EnrichmentFunction : public Function<dim>
 {
 public:
index c59363d6bc283609533b11728e4cfcb22d1d499b..55afd1d5c87550fb0c2095bf87d72761a4ae47fd 100644 (file)
@@ -56,7 +56,7 @@ using namespace dealii;
 // uncomment when debugging
 // #define DATA_OUT_FE_ENRICHED
 
-template<int dim>
+template <int dim>
 class EnrichmentFunction : public Function<dim>
 {
 public:
@@ -82,7 +82,7 @@ public:
 };
 
 
-template<int dim>
+template <int dim>
 void test2cells(const unsigned int p_feq=2,
                 const unsigned int p_feen=1)
 {
index 23fd6dbdae0416dfb3cfd99e9c301c743520ea9c..af96ae1b2a86a4d16323ceac153b4c6df0e5793d 100644 (file)
@@ -49,7 +49,7 @@ const double eps = 1e-10;
 
 using namespace dealii;
 
-template<int dim>
+template <int dim>
 void test2cellsFESystem(const unsigned int p_feq=2,
                         const unsigned int p_feen=1)
 {
index 65cf687855439e3ee1f505151dd4b35213d18883..77e18220ac25875b0d2b9373e3d45b9e0d6e5cda 100644 (file)
@@ -60,7 +60,7 @@ const unsigned int patches = 10;
 
 using namespace dealii;
 
-template<int dim>
+template <int dim>
 class EnrichmentFunction : public Function<dim>
 {
 public:
@@ -157,7 +157,7 @@ void check_consistency(const Point<dim>    &p,
                 ExcInternalError());
 }
 
-template<int dim>
+template <int dim>
 void test(const FiniteElement<dim> &fe1,
           const FiniteElement<dim> &fe2,
           const Quadrature<dim>    &volume_quad,
index 083b92c8bc92444750b18c8783e8017e3a33c2ec..552c740ba5ef71a9afc4c496c8bcf0fe2c940b3d 100644 (file)
@@ -61,7 +61,7 @@ const unsigned int patches = 10;
 
 using namespace dealii;
 
-template<int dim>
+template <int dim>
 class EnrichmentFunction : public Function<dim>
 {
 public:
@@ -194,7 +194,7 @@ void check_consistency(const Point<dim>    &p,
 /**
  * {fe_en1,1}, {fe_en2,2} => 3 functions
  */
-template<int dim>
+template <int dim>
 void test(const FiniteElement<dim> &fe_base,
           const FiniteElement<dim> &fe_en1,
           const FiniteElement<dim> &fe_en2,
index 36d24a25ff4ad12e5d35eb2d5a8b66ef571876f5..49ce06f49818a261d1f0e70b256f64f7a1e670eb 100644 (file)
@@ -61,7 +61,7 @@ using namespace dealii;
 /**
  * Coulomb potential
  */
-template<int dim>
+template <int dim>
 class PotentialFunction : public Function<dim>
 {
 public:
@@ -73,7 +73,7 @@ public:
                        const unsigned int component = 0 ) const;
 };
 
-template<int dim>
+template <int dim>
 double PotentialFunction<dim>::value(const Point<dim> &p,
                                      const unsigned int ) const
 {
@@ -82,7 +82,7 @@ double PotentialFunction<dim>::value(const Point<dim> &p,
   return -1.0 / std::sqrt(p.square());
 }
 
-template<int dim>
+template <int dim>
 class EnrichmentFunction : public Function<dim>
 {
 public:
@@ -443,7 +443,7 @@ namespace Step36
     mass_matrix.compress (VectorOperation::add);
   }
 
-  template<int dim>
+  template <int dim>
   std::pair<unsigned int, double>
   EigenvalueProblem<dim>::solve()
   {
index e966a23c02f483a21dcc3254dda1bbb753bf1d49..ee46dfab912a1967b50b173642ee4d4e00a1d51b 100644 (file)
@@ -65,7 +65,7 @@ using namespace dealii;
 /**
  * Coulomb potential
  */
-template<int dim>
+template <int dim>
 class PotentialFunction : public dealii::Function<dim>
 {
 public:
@@ -77,14 +77,14 @@ public:
                        const unsigned int component = 0 ) const;
 };
 
-template<int dim>
+template <int dim>
 double PotentialFunction<dim>::value(const dealii::Point<dim> &p,
                                      const unsigned int ) const
 {
   return -1.0 / std::sqrt(p.square());
 }
 
-template<int dim>
+template <int dim>
 class EnrichmentFunction : public Function<dim>
 {
 public:
@@ -615,7 +615,7 @@ namespace Step36
     mass_matrix.compress (dealii::VectorOperation::add);
   }
 
-  template<int dim>
+  template <int dim>
   std::pair<unsigned int, double>
   EigenvalueProblem<dim>::solve()
   {
index fc321547b25c3baff2b3b8a6ead25a99f2451509..e5d6378155819b0fe0c1aec4dc46de3a77563216 100644 (file)
@@ -43,7 +43,7 @@
 
 
 
-template<int dim>
+template <int dim>
 inline void
 plot_faces(Mapping<dim> &mapping,
            FiniteElement<dim> &fe,
@@ -88,7 +88,7 @@ plot_faces(Mapping<dim> &mapping,
 
 
 
-template<int dim>
+template <int dim>
 inline void
 plot_subfaces(Mapping<dim> &mapping,
               FiniteElement<dim> &fe,
@@ -138,7 +138,7 @@ plot_subfaces(Mapping<dim> &mapping,
 }
 
 
-template<int dim>
+template <int dim>
 void mapping_test()
 {
   deallog << "dim=" << dim << std::endl;
index 188dee369e360fab2b32b95b2a18beb7591769c9..d7a082043c91ddab0d3498ae7d78db25dfad10ca 100644 (file)
@@ -39,7 +39,7 @@
 
 
 
-template<int dim>
+template <int dim>
 Tensor<1,dim> ones ()
 {
   Tensor<1,dim> result;
@@ -48,7 +48,7 @@ Tensor<1,dim> ones ()
   return result;
 }
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr,
            const FiniteElement<dim> &fe,
            const double tolerance)
@@ -137,7 +137,7 @@ void test (const Triangulation<dim> &tr,
 
 
 
-template<int dim>
+template <int dim>
 void test_hyper_ball(const double tolerance)
 {
   Triangulation<dim> tr;
index 92a982bf75d8d62f6536cfeae9bf7741ffbde882..bd7e51bfd57cba7fed2e6ca1e46c4f3f21f6b4a8 100644 (file)
@@ -44,7 +44,7 @@
 
 
 
-template<int dim>
+template <int dim>
 Tensor<1,dim> ones ()
 {
   Tensor<1,dim> result;
@@ -53,7 +53,7 @@ Tensor<1,dim> ones ()
   return result;
 }
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr,
            const FiniteElement<dim> &fe,
            const double tolerance)
@@ -138,7 +138,7 @@ void test (const Triangulation<dim> &tr,
 
 
 
-template<int dim>
+template <int dim>
 void test_hyper_ball(const double tolerance)
 {
   Triangulation<dim> tr;
index 43be9c2769404e3adb26c2e78b9794591d81c349..a5e309d4d434961677c635a72fbd1c4a05e00868 100644 (file)
@@ -20,7 +20,7 @@ const double eps = 1e-10;
 
 using namespace dealii;
 
-template<int dim>
+template <int dim>
 void test2cells(const unsigned int p1=2,
                 const unsigned int p2=1)
 {
index 1e94630fedcc98ba849f9e729f8985d6bdbbb48a..32a2a29ee6d99211686cd47af47ad75ecc66b850 100644 (file)
@@ -92,7 +92,7 @@ static const Point<2> vertices_rectangular[] =
 static const unsigned n_vertices = sizeof(vertices_rectangular) / sizeof(vertices_rectangular[0]);\r
 static const unsigned n_cells = 4;\r
 \r
-template<int dim>\r
+template <int dim>\r
 class VectorFunction : public Function<dim>\r
 {\r
 public:\r
@@ -101,7 +101,7 @@ public:
   virtual void vector_value(const Point<dim> &p, Vector<double> &values) const;\r
 };\r
 \r
-template<>\r
+template <>\r
 double VectorFunction<2>::value(const Point<2> &p, const unsigned int component) const\r
 {\r
   Assert (component < 2,  ExcIndexRange (component, 0, 1));\r
@@ -120,7 +120,7 @@ double VectorFunction<2>::value(const Point<2> &p, const unsigned int component)
   return val;\r
 }\r
 \r
-template<int dim>\r
+template <int dim>\r
 void VectorFunction<dim>::vector_value(const Point<dim> &p, Vector<double> &values) const\r
 {\r
   for (int i = 0; i < dim; ++i)\r
index c19a091aa2049d075f849b89567a331ce855c12d..ca82026c0ea97bd7e02e6eed8acdf5ce9081e14c 100644 (file)
@@ -163,7 +163,7 @@ static const Point<3> vertices_rectangular[] =
 static const unsigned n_vertices = sizeof(vertices_rectangular) / sizeof(vertices_rectangular[0]);\r
 static const unsigned n_cells = 8;\r
 \r
-template<int dim>\r
+template <int dim>\r
 class VectorFunction : public Function<dim>\r
 {\r
 public:\r
@@ -173,7 +173,7 @@ public:
   virtual Tensor< 1, dim >  gradient (const Point< dim > &p, const unsigned int component=0) const;\r
 };\r
 \r
-template<>\r
+template <>\r
 double VectorFunction<3>::value(const Point<3> &p, const unsigned int component) const\r
 {\r
   Assert (component < 3, ExcIndexRange (component, 0, 2));\r
@@ -195,14 +195,14 @@ double VectorFunction<3>::value(const Point<3> &p, const unsigned int component)
   return val;\r
 }\r
 \r
-template<int dim>\r
+template <int dim>\r
 void VectorFunction<dim>::vector_value(const Point<dim> &p, Vector<double> &values) const\r
 {\r
   for (int i = 0; i < dim; ++i)\r
     values(i) = value(p, i);\r
 }\r
 \r
-template<>\r
+template <>\r
 Tensor<1, 3> VectorFunction<3>::gradient(const Point<3> &p, const unsigned int component) const\r
 {\r
   const double PI = numbers::PI;\r
index b1eafc42fb0a62bd6bacb7e1c6ddf6cb8f3abaa6..cf3964190cffae22264e74ac41dd724de41cf0a0 100644 (file)
@@ -37,7 +37,7 @@
 #include <sstream>
 #include <fstream>
 
-template<int dim>
+template <int dim>
 Tensor<1,dim> ones ()
 {
   Tensor<1,dim> result;
@@ -46,7 +46,7 @@ Tensor<1,dim> ones ()
   return result;
 }
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr,
            const FiniteElement<dim> &fe,
            const double tolerance)
@@ -142,7 +142,7 @@ void test (const Triangulation<dim> &tr,
 
 
 
-template<int dim>
+template <int dim>
 void test_hyper_ball(const double tolerance)
 {
   Triangulation<dim> tr;
index 610a42fd66c41301bd7ef28d41a867e209487be0..fee13130d8e02919f96642d4994b767fc11941f6 100644 (file)
@@ -878,7 +878,7 @@ namespace Step22
   }
 
   //squared l^2 norm of divergence of velocity
-  template<int dim>
+  template <int dim>
   void StokesProblem<dim>::divergence_velocity
   (const BlockVector<double> &calc_solution,
    Vector<double>         &output_vector,
index 8b8088afcdecec5959047a35bcd3cecb304648ca..35299085e6cf9da2a8fdce4989ab6399bf5501e0 100644 (file)
@@ -39,7 +39,7 @@
 
 
 
-template<int dim>
+template <int dim>
 Tensor<1,dim> ones ()
 {
   Tensor<1,dim> result;
@@ -48,7 +48,7 @@ Tensor<1,dim> ones ()
   return result;
 }
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr,
            const FiniteElement<dim> &fe,
            const double tolerance)
@@ -137,7 +137,7 @@ void test (const Triangulation<dim> &tr,
 
 
 
-template<int dim>
+template <int dim>
 void test_hyper_ball(const double tolerance)
 {
   Triangulation<dim> tr;
index c8a021322a0892dc7a6fe2ec79bdeb6c6c7b9da5..a14ee98d3ab5de21570d23d8937ced1ea769f05f 100644 (file)
@@ -39,7 +39,7 @@
 
 
 
-template<int dim>
+template <int dim>
 Tensor<1,dim> ones ()
 {
   Tensor<1,dim> result;
@@ -48,7 +48,7 @@ Tensor<1,dim> ones ()
   return result;
 }
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr,
            const FiniteElement<dim> &fe,
            const double tolerance)
@@ -138,7 +138,7 @@ void test (const Triangulation<dim> &tr,
 
 
 
-template<int dim>
+template <int dim>
 void test_hyper_ball(const double tolerance)
 {
   Triangulation<dim> tr;
index 6a38031e78e62907497c7178681f8f5bf0ea7990..63b5218a1f19e5b4cb93ed31d23af6239dc6d09b 100644 (file)
@@ -38,7 +38,7 @@
 #include <sstream>
 #include <fstream>
 
-template<int dim>
+template <int dim>
 Tensor<1,dim> ones ()
 {
   Tensor<1,dim> result;
@@ -47,7 +47,7 @@ Tensor<1,dim> ones ()
   return result;
 }
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr,
            const FiniteElement<dim> &fe,
            const double tolerance)
@@ -143,7 +143,7 @@ void test (const Triangulation<dim> &tr,
 
 
 
-template<int dim>
+template <int dim>
 void test_hyper_ball(const double tolerance)
 {
   Triangulation<dim> tr;
index 2959eaaf191c61f211e12a31b9e39b8151fea9e5..e07fae929b3a7775d0ad81951fad91f19cce7f2f 100644 (file)
@@ -39,7 +39,7 @@
 
 
 
-template<int dim>
+template <int dim>
 Tensor<1,dim> ones ()
 {
   Tensor<1,dim> result;
@@ -48,7 +48,7 @@ Tensor<1,dim> ones ()
   return result;
 }
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr,
            const FiniteElement<dim> &fe,
            const double tolerance)
@@ -139,7 +139,7 @@ void test (const Triangulation<dim> &tr,
 
 // at the time of writing this test, RaviartThomas elements did not pass
 // the hyper_ball version of the test, perhaps due to issues on the boundary.
-template<int dim>
+template <int dim>
 void test_hyper_cube(const double tolerance)
 {
   Triangulation<dim> tr;
index dd23466d34a2c7e6f9104ddf36bf3e8976261ff2..e508d4e706bd4449692f738994f7ab74cca1e4ca 100644 (file)
@@ -38,7 +38,7 @@
 
 
 
-template<int dim>
+template <int dim>
 Tensor<1,dim> ones ()
 {
   Tensor<1,dim> result;
@@ -47,7 +47,7 @@ Tensor<1,dim> ones ()
   return result;
 }
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr,
            const FiniteElement<dim> &fe,
            const double tolerance)
@@ -134,7 +134,7 @@ void test (const Triangulation<dim> &tr,
 
 // at the time of writing this test, RaviartThomas elements did not pass
 // the hyper_ball version of the test, perhaps due to issues on the boundary.
-template<int dim>
+template <int dim>
 void test_hyper_cube(const double tolerance)
 {
   Triangulation<dim> tr;
index 4b6ede6f9025f4a21b26d062fc085a9c5d921983..e9adefad02f4912810954b68b5b66dfce91f80c1 100644 (file)
@@ -39,7 +39,7 @@ using namespace dealii;
 /**
  * A 1D function given by input legendre coefficients
  */
-template<int dim>
+template <int dim>
 class LegendreFunction : public Function<dim>
 {
 public:
@@ -62,7 +62,7 @@ private:
   const std::vector<double> coefficients;
 };
 
-template<int dim>
+template <int dim>
 double LegendreFunction<dim>::value(const dealii::Point<dim> &point,
                                     const unsigned int ) const
 {
@@ -83,7 +83,7 @@ double LegendreFunction<dim>::value(const dealii::Point<dim> &point,
   return f;
 }
 
-template<int dim>
+template <int dim>
 void test(const LegendreFunction<dim> &func,
           const unsigned int poly_degree)
 {
index 3a6cec13e0cf474c8b9bb838fe299583e2dc8456..ccc47bbadddab75e02dfad497ff576399a0588fe 100644 (file)
@@ -54,7 +54,7 @@ bfloat(C(3)), nouns;
 
 using namespace dealii;
 
-template<int dim>
+template <int dim>
 class LegendreFunction : public Function<dim>
 {
 public:
@@ -67,7 +67,7 @@ public:
                        const unsigned int component = 0 ) const;
 };
 
-template<int dim>
+template <int dim>
 double LegendreFunction<dim>::value(const Point<dim> &point,
                                     const unsigned int ) const
 {
@@ -79,7 +79,7 @@ double LegendreFunction<dim>::value(const Point<dim> &point,
 }
 
 
-template<int dim>
+template <int dim>
 void test(const LegendreFunction<dim> &func,
           const unsigned int poly_degree)
 {
index e5fc151771dffbd144bdb987d97c8440e26d8f70..6e326ab5e40ff80bf91c1e8c52bea6eed913edcc 100644 (file)
@@ -36,7 +36,7 @@
 
 using namespace dealii;
 
-template<int dim>
+template <int dim>
 class LegendreFunction : public Function<dim>
 {
 public:
@@ -77,7 +77,7 @@ double Lh(const Point<dim>  &x_q,
   return res;
 }
 
-template<>
+template <>
 double LegendreFunction<2>::value(const dealii::Point<2> &point,
                                   const unsigned int ) const
 {
@@ -90,7 +90,7 @@ double LegendreFunction<2>::value(const dealii::Point<2> &point,
   return f;
 }
 
-template<>
+template <>
 double LegendreFunction<3>::value(const dealii::Point<3> &point,
                                   const unsigned int ) const
 {
@@ -136,7 +136,7 @@ void resize(Table<3,double> &coeff, const unsigned int N)
 
 
 
-template<int dim>
+template <int dim>
 void test(const LegendreFunction<dim> &func,
           const unsigned int poly_degree)
 {
index e5f81d8ab4c5025464369ac6d4b0ddac5aa761fc..f9d34896782a9fbe7dd48be859b031071ea0f4e8 100644 (file)
@@ -37,7 +37,7 @@
 #include <sstream>
 #include <fstream>
 
-template<int dim>
+template <int dim>
 Tensor<1,dim> ones ()
 {
   Tensor<1,dim> result;
@@ -46,7 +46,7 @@ Tensor<1,dim> ones ()
   return result;
 }
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr,
            const FiniteElement<dim> &fe,
            const double tolerance)
@@ -142,7 +142,7 @@ void test (const Triangulation<dim> &tr,
 
 
 
-template<int dim>
+template <int dim>
 void test_hyper_ball(const double tolerance)
 {
   Triangulation<dim> tr;
index 21724f754f532f41a5a59a237f2989fda5894a24..64831fb9dcd41a02746666753acf11570d45ad3e 100644 (file)
@@ -55,7 +55,7 @@ void print_formatted (const FullMatrix<number> &A,
 
 
 
-template<int dim>
+template <int dim>
 void test_embedding (const FiniteElement<dim> &fe)
 {
   const unsigned int n = fe.dofs_per_cell;
@@ -85,7 +85,7 @@ void test_embedding (const FiniteElement<dim> &fe)
 }
 
 
-template<int dim>
+template <int dim>
 void test_projection (const FiniteElement<dim> &fe1,
                       const FiniteElement<dim> &fe2,
                       std::ostream &out)
@@ -107,7 +107,7 @@ void test_projection (const FiniteElement<dim> &fe1,
 }
 
 
-template<int dim>
+template <int dim>
 void test_projection (std::ostream &out)
 {
   FE_DGQ<dim> q0(0);
@@ -152,7 +152,7 @@ void test_projection (std::ostream &out)
 }
 
 
-template<int dim>
+template <int dim>
 void test_renumbering(const FiniteElement<dim> &fe)
 {
   std::vector<unsigned int> v(fe.dofs_per_cell);
@@ -175,7 +175,7 @@ void test_renumbering(const FiniteElement<dim> &fe)
 }
 
 
-template<int dim>
+template <int dim>
 void test_renumbering()
 {
   deallog.push("Renumber");
index 97391bcf9cb91b14035eb47957db3875c4abf84c..5fef09f531aa4f2f6031caf5a531f0b8102f642c 100644 (file)
@@ -44,7 +44,7 @@ void logvec (const std::vector<types::global_dof_index> &v, const std::vector<ty
 }
 
 
-template<int dim>
+template <int dim>
 void test_renumbering(const FiniteElement<dim> &fe)
 {
   std::vector<types::global_dof_index> v(fe.dofs_per_cell);
@@ -59,7 +59,7 @@ void test_renumbering(const FiniteElement<dim> &fe)
 }
 
 
-template<int dim>
+template <int dim>
 void test_renumbering()
 {
   deallog.push("Renumber");
index ae178631e83f221363f85c8ee0cdfb5304e7619f..f89048fff129467e9db23fbd20c758dde99e4c66 100644 (file)
@@ -92,7 +92,7 @@ void make_grid (Triangulation<2> &triangulation)
 }
 
 
-template<int dim>
+template <int dim>
 void test(const Triangulation<dim> &tria,
           const Mapping<dim> &mapping,
           const FiniteElement<dim> &fe1,
index a710f451274232b30c1cef2a73e8b2afd09e246b..d4f31e8be32aa12768156b8b8d19aac6294ea504 100644 (file)
@@ -46,7 +46,7 @@ private:
   const unsigned int q;
 };
 
-template<int dim>
+template <int dim>
 void test()
 {
   Triangulation<dim> tria;
index 0b83f8ea2caf1e6091cf749029c2d2f45309d9c4..45c48f39b749986b3a05c7ba9afc5dc54ec1923b 100644 (file)
@@ -36,7 +36,7 @@
 
 
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr,
            const FiniteElement<dim> &fe)
 {
@@ -88,7 +88,7 @@ void test (const Triangulation<dim> &tr,
 
 
 
-template<int dim>
+template <int dim>
 void test_hyper_sphere()
 {
   Triangulation<dim> tr;
index 4b5f98a5900752439182fa28410aa8ed386304fd..d96fb57f4856d264022e3c6ac67d27e5c22946a4 100644 (file)
@@ -36,7 +36,7 @@
 #include <iostream>
 
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr,
            const FiniteElement<dim> &fe)
 {
@@ -113,7 +113,7 @@ void test (const Triangulation<dim> &tr,
 
 
 
-template<int dim>
+template <int dim>
 void test_hyper_sphere()
 {
   Triangulation<dim> tr;
index 405899a094610f2d40a709cab692a55cd02ada48..3cb6cde8a235e892e21677147e5ad007be525a03 100644 (file)
@@ -38,7 +38,7 @@
 
 
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr,
            const FiniteElement<dim> &fe)
 {
@@ -94,7 +94,7 @@ void test (const Triangulation<dim> &tr,
 
 
 
-template<int dim>
+template <int dim>
 void test_hyper_sphere()
 {
   Triangulation<dim> tr;
index 9049791a8a42ec228a2ccc6ccc48dfb5fd19950c..f29e22823b73ccd24c5a775bf41822ce54ebea6e 100644 (file)
@@ -38,7 +38,7 @@
 
 
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr,
            const FiniteElement<dim> &fe)
 {
@@ -114,7 +114,7 @@ void test (const Triangulation<dim> &tr,
 
 
 
-template<int dim>
+template <int dim>
 void test_hyper_sphere()
 {
   Triangulation<dim> tr;
index f3a018f017901155b7470c4e459c8be5661e3b5c..6f0fdb55f92ba7ef869c2ecbb5a3ac8066c92a89 100644 (file)
@@ -36,7 +36,7 @@
 
 
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr,
            const FiniteElement<dim> &fe)
 {
@@ -80,7 +80,7 @@ void test (const Triangulation<dim> &tr,
 
 
 
-template<int dim>
+template <int dim>
 void test_hyper_sphere()
 {
   Triangulation<dim> tr;
index 3e708912afe7c1bb7d863224158f4c8c36c0d5e1..64bff9782c8a80df65288766e1482ec91a4b162c 100644 (file)
@@ -36,7 +36,7 @@
 
 
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr,
            const FiniteElement<dim> &fe)
 {
@@ -81,7 +81,7 @@ void test (const Triangulation<dim> &tr,
 
 
 
-template<int dim>
+template <int dim>
 void test_hyper_sphere()
 {
   Triangulation<dim> tr;
index 8458dffe47c29c052191fc0c0b8b898b52ae39be..1d22e98da9c6d9c2c5382c2978ba52daaf4410a9 100644 (file)
@@ -36,7 +36,7 @@
 
 
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr,
            const FiniteElement<dim> &fe)
 {
@@ -81,7 +81,7 @@ void test (const Triangulation<dim> &tr,
 
 
 
-template<int dim>
+template <int dim>
 void test_hyper_sphere()
 {
   Triangulation<dim> tr;
index 3eec7bd7b708589d67a8d5a66da99dcd65935067..bede0cb7f184c726f86779499d4ba12ab8a6d498 100644 (file)
@@ -38,7 +38,7 @@
 
 
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr,
            const FiniteElement<dim> &fe)
 {
@@ -82,7 +82,7 @@ void test (const Triangulation<dim> &tr,
 
 
 
-template<int dim>
+template <int dim>
 void test_hyper_sphere()
 {
   Triangulation<dim> tr;
index 20123a2442e0cb151d7350038097b0f577c61643..9cbecf8c93b890476a6f8b94f01417912d1cc433 100644 (file)
@@ -38,7 +38,7 @@
 
 
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr,
            const FiniteElement<dim> &fe)
 {
@@ -85,7 +85,7 @@ void test (const Triangulation<dim> &tr,
 
 
 
-template<int dim>
+template <int dim>
 void test_hyper_sphere()
 {
   Triangulation<dim> tr;
index c74c404c5585da33eca95bd848377207e4dd902f..cbeaa79c6bba2bb79055f269aa7fadcde9fb726b 100644 (file)
@@ -38,7 +38,7 @@
 
 
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr,
            const FiniteElement<dim> &fe)
 {
@@ -86,7 +86,7 @@ void test (const Triangulation<dim> &tr,
 
 
 
-template<int dim>
+template <int dim>
 void test_hyper_sphere()
 {
   Triangulation<dim> tr;
index e3da9a6588176375ebc85dde300f4fe2e274040d..1e118e5942f47af54980e01ccd8bd165259a1296 100644 (file)
@@ -41,7 +41,7 @@
 
 
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr,
            const FiniteElement<dim> &fe)
 {
@@ -90,7 +90,7 @@ void test (const Triangulation<dim> &tr,
 
 
 
-template<int dim>
+template <int dim>
 void test_hyper_sphere()
 {
   Triangulation<dim> tr;
index e5b39a7d3ea1b774e6292013f39b5ff2d68af2bc..5c03fa40e90ee4045d01e18a39ae763feface959 100644 (file)
@@ -41,7 +41,7 @@
 
 
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr,
            const FiniteElement<dim> &fe)
 {
@@ -90,7 +90,7 @@ void test (const Triangulation<dim> &tr,
 
 
 
-template<int dim>
+template <int dim>
 void test_hyper_sphere()
 {
   Triangulation<dim> tr;
index 53fc86edc1e12df4f2f9c456322a1f783fdae15d..de967cf1b5123531559528285237c68d751e2c89 100644 (file)
@@ -41,7 +41,7 @@
 
 
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr,
            const FiniteElement<dim> &fe)
 {
@@ -90,7 +90,7 @@ void test (const Triangulation<dim> &tr,
 
 
 
-template<int dim>
+template <int dim>
 void test_hyper_sphere()
 {
   Triangulation<dim> tr;
index 204572abb9fd27caef749729cd3b0abf86eb8657..d9ed08f53f9dae46bf3d0a1ba0f4c0492534fa3f 100644 (file)
@@ -36,7 +36,7 @@
 
 
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr,
            const FiniteElement<dim> &fe)
 {
@@ -86,7 +86,7 @@ void test (const Triangulation<dim> &tr,
 
 
 
-template<int dim>
+template <int dim>
 void test_hyper_sphere()
 {
   Triangulation<dim> tr;
index 973cdd6764a6d074f5eae78bef15411c9852c33c..d1ce30ceb2e18cb26b96b0b5397ec95b8d966e14 100644 (file)
@@ -36,7 +36,7 @@
 
 
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr,
            const FiniteElement<dim> &fe)
 {
@@ -87,7 +87,7 @@ void test (const Triangulation<dim> &tr,
 
 
 
-template<int dim>
+template <int dim>
 void test_hyper_sphere()
 {
   Triangulation<dim> tr;
index a2504a45ddc189c65727e843132481516ea52aac..07b94c5583430a41e7eb50359a8f40178b3e4a6c 100644 (file)
@@ -36,7 +36,7 @@
 
 
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr,
            const FiniteElement<dim> &fe)
 {
@@ -87,7 +87,7 @@ void test (const Triangulation<dim> &tr,
 
 
 
-template<int dim>
+template <int dim>
 void test_hyper_sphere()
 {
   Triangulation<dim> tr;
index 2cfc7c75748324f450fea7611a5c1358e890ace9..7e4dbde14ed2e02e6844896aa96f6a9045834024 100644 (file)
@@ -38,7 +38,7 @@
 
 
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr,
            const FiniteElement<dim> &fe)
 {
@@ -90,7 +90,7 @@ void test (const Triangulation<dim> &tr,
 
 
 
-template<int dim>
+template <int dim>
 void test_hyper_sphere()
 {
   Triangulation<dim> tr;
index abca78f56a2289f3d6fde258f122a0c866d85656..6f6b08c1af04be705de8bc3d878e017cb60a26eb 100644 (file)
@@ -38,7 +38,7 @@
 
 
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr,
            const FiniteElement<dim> &fe)
 {
@@ -91,7 +91,7 @@ void test (const Triangulation<dim> &tr,
 
 
 
-template<int dim>
+template <int dim>
 void test_hyper_sphere()
 {
   Triangulation<dim> tr;
index f5e0c1253a00e26901bbf55f737e70869e54c7ae..b2a7abb14a0ab0175f4e3a25cde3e77b14b9e34a 100644 (file)
@@ -38,7 +38,7 @@
 
 
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr,
            const FiniteElement<dim> &fe)
 {
@@ -92,7 +92,7 @@ void test (const Triangulation<dim> &tr,
 
 
 
-template<int dim>
+template <int dim>
 void test_hyper_sphere()
 {
   Triangulation<dim> tr;
index 10bf4c3fb330e0d82eec64175308e8f6ca25cb23..2e78a4cafb984313fbf999acc5a49cfab546c0b8 100644 (file)
@@ -36,7 +36,7 @@
 
 
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr,
            const FiniteElement<dim> &fe)
 {
@@ -91,7 +91,7 @@ void test (const Triangulation<dim> &tr,
 
 
 
-template<int dim>
+template <int dim>
 void test_hyper_sphere()
 {
   Triangulation<dim> tr;
index 3f7132b2b0a39dbf7ae3ce13c2f5a651709fdb9d..4bdd334e26286288e9e8bf30fc1865c276be8d26 100644 (file)
@@ -38,7 +38,7 @@
 
 
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr,
            const FiniteElement<dim> &fe)
 {
@@ -96,7 +96,7 @@ void test (const Triangulation<dim> &tr,
 
 
 
-template<int dim>
+template <int dim>
 void test_hyper_sphere()
 {
   Triangulation<dim> tr;
index f20a6ea6c60b5d0e27edf5e85d90b6946c7ff128..4679fbe3bacef8ecb800c6d04559d9d5b9e27a38 100644 (file)
@@ -36,7 +36,7 @@
 
 
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr,
            const FiniteElement<dim> &fe)
 {
@@ -91,7 +91,7 @@ void test (const Triangulation<dim> &tr,
 
 
 
-template<int dim>
+template <int dim>
 void test_hyper_sphere()
 {
   Triangulation<dim> tr;
index 86067285e538d92ad9ef9e84c1444961a40e6bf4..1535b2d6d1ca2befb99bbe150575b2a9144cd05b 100644 (file)
@@ -38,7 +38,7 @@
 
 
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr,
            const FiniteElement<dim> &fe)
 {
@@ -95,7 +95,7 @@ void test (const Triangulation<dim> &tr,
 
 
 
-template<int dim>
+template <int dim>
 void test_hyper_sphere()
 {
   Triangulation<dim> tr;
index dd9e65b0dd90a95f98877728bd4ae86bf5d3ef95..507ef7aeb223a08c8f664a706334a726bd223955 100644 (file)
@@ -36,7 +36,7 @@
 
 
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr,
            const FiniteElement<dim> &fe)
 {
@@ -84,7 +84,7 @@ void test (const Triangulation<dim> &tr,
 
 
 
-template<int dim>
+template <int dim>
 void test_hyper_sphere()
 {
   Triangulation<dim> tr;
index 569e7950fe55bca54ffbc701de1df069825835b8..17d594068561fc87384b7b4948d0dab22a806a05 100644 (file)
@@ -36,7 +36,7 @@
 
 
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr,
            const FiniteElement<dim> &fe)
 {
@@ -84,7 +84,7 @@ void test (const Triangulation<dim> &tr,
 
 
 
-template<int dim>
+template <int dim>
 void test_hyper_sphere()
 {
   Triangulation<dim> tr;
index 96a4de63878f856578edf1ce2a3133554579d6b5..476dc2bd8d33b9573418bb854dd1f00e1beef1c2 100644 (file)
@@ -36,7 +36,7 @@
 
 
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr,
            const FiniteElement<dim> &fe)
 {
@@ -78,7 +78,7 @@ void test (const Triangulation<dim> &tr,
 
 
 
-template<int dim>
+template <int dim>
 void test_hyper_sphere()
 {
   Triangulation<dim> tr;
index 911b65e6d37f76152ba2d98fd59767320d18bac2..74105340059046973b818d5462366090283c7531 100644 (file)
@@ -36,7 +36,7 @@
 
 
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr,
            const FiniteElement<dim> &fe)
 {
@@ -78,7 +78,7 @@ void test (const Triangulation<dim> &tr,
 
 
 
-template<int dim>
+template <int dim>
 void test_hyper_sphere()
 {
   Triangulation<dim> tr;
index 63715c3d69af326e46acc25241dd58e19f63d720..c702d6b89294f7f9c66f519cffe17ce5accc3c55 100644 (file)
@@ -35,7 +35,7 @@
 
 
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr,
            const FiniteElement<dim> &fe)
 {
@@ -78,7 +78,7 @@ void test (const Triangulation<dim> &tr,
 
 
 
-template<int dim>
+template <int dim>
 void test_hyper_cube()
 {
   Triangulation<dim> tr;
index ff53f3ccf60a33240303ef13024046a08cad852b..5ae006a71bf38fc18c2c6907bd35f18ce3f0abd6 100644 (file)
@@ -35,7 +35,7 @@
 
 
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr,
            const FiniteElement<dim> &fe)
 {
@@ -78,7 +78,7 @@ void test (const Triangulation<dim> &tr,
 
 
 
-template<int dim>
+template <int dim>
 void test_hyper_cube()
 {
   Triangulation<dim> tr;
index 3f711f6727203ccffc10a611717e6e31b89a54e3..dacf91540cfad80a669cb27a813afd1cf60884cf 100644 (file)
@@ -50,7 +50,7 @@ Tensor<1,3> curl (const Tensor<2,3> &grads)
 
 
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr,
            const FiniteElement<dim> &fe)
 {
@@ -90,7 +90,7 @@ void test (const Triangulation<dim> &tr,
 
 
 
-template<int dim>
+template <int dim>
 void test_hyper_cube()
 {
   Triangulation<dim> tr;
index 3cc3d1688e93e826c7a38db8a68c858d886a263f..148251f2f33cc5afe238ecf509faed4afaf99146 100644 (file)
@@ -50,7 +50,7 @@ Tensor<1,3> curl (const Tensor<2,3> &grads)
 
 
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr,
            const FiniteElement<dim> &fe)
 {
@@ -90,7 +90,7 @@ void test (const Triangulation<dim> &tr,
 
 
 
-template<int dim>
+template <int dim>
 void test_hyper_cube()
 {
   Triangulation<dim> tr;
index 517898885c8c2fe99f7b4f0af0a86aaf485f01a3..de0aaa86bd1fc6ecb416801e3f1bb65f08c6164c 100644 (file)
@@ -65,7 +65,7 @@ Tensor<1,3> curl (const Tensor<2,3> &grads)
 
 
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr,
            const FiniteElement<dim> &fe)
 {
@@ -117,7 +117,7 @@ void test (const Triangulation<dim> &tr,
 
 
 
-template<int dim>
+template <int dim>
 void test_hyper_cube()
 {
   Triangulation<dim> tr;
index a1e8aed506bc03d1eea73d7f73b40c1134bb4a13..3faf0ae1fd22fbc77e27ecdfff662c3ebf590216 100644 (file)
@@ -65,7 +65,7 @@ Tensor<1,3> curl (const Tensor<2,3> &grads)
 
 
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr,
            const FiniteElement<dim> &fe,
            const unsigned int degree)
@@ -118,7 +118,7 @@ void test (const Triangulation<dim> &tr,
 
 
 
-template<int dim>
+template <int dim>
 void test_hyper_cube()
 {
   Triangulation<dim> tr;
index 4f3aa0fa3358754e7acfbe70f26fec53fe2c2d6c..f1dd0c8b658d3c90f9cf9ec26d9f57df1c33ea58 100644 (file)
@@ -38,7 +38,7 @@
 
 #include <fstream>
 
-template<int dim>
+template <int dim>
 class VectorFunction : public Function<dim>
 {
 public:
@@ -47,7 +47,7 @@ public:
   virtual void vector_value(const Point<dim> &p, Vector<double> &values) const;
 };
 
-template<>
+template <>
 double VectorFunction<2>::value(const Point<2> &p, const unsigned int component) const
 {
   Assert (component < 2,  ExcIndexRange (component, 0, 1));
@@ -66,7 +66,7 @@ double VectorFunction<2>::value(const Point<2> &p, const unsigned int component)
   return val;
 }
 
-template<>
+template <>
 double VectorFunction<3>::value(const Point<3> &p, const unsigned int component) const
 {
   Assert (component < 3, ExcIndexRange (component, 0, 2));
@@ -88,14 +88,14 @@ double VectorFunction<3>::value(const Point<3> &p, const unsigned int component)
   return val;
 }
 
-template<int dim>
+template <int dim>
 void VectorFunction<dim>::vector_value(const Point<dim> &p, Vector<double> &values) const
 {
   for (int i = 0; i < dim; ++i)
     values(i) = value(p, i);
 }
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr,
            const FiniteElement<dim> &fe)
 {
@@ -158,7 +158,7 @@ void test (const Triangulation<dim> &tr,
 
 
 
-template<int dim>
+template <int dim>
 void test_hyper_sphere()
 {
   Triangulation<dim> tr;
index d01ae8955983c027a0b836ed121a3470fab01253..a6f1333b4cdb2bf49af4f1f9849d88937a82be4c 100644 (file)
@@ -31,7 +31,7 @@
 
 
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr,
            const FiniteElement<dim> &fe)
 {
@@ -62,7 +62,7 @@ ok:
 
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   Triangulation<dim> tr;
index 6670fed9472106d7e6fe72bb73af3c95178762d8..e908ef869eb5ae4be0926473c21eda1dabc12042 100644 (file)
@@ -31,7 +31,7 @@
 
 
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr,
            const FiniteElement<dim> &fe)
 {
@@ -62,7 +62,7 @@ ok:
 
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   Triangulation<dim> tr;
index 9607de7b0594d956343280913a032aad4457e6e4..5a8e5e23998d7b98e99515270776782d291ed574 100644 (file)
@@ -31,7 +31,7 @@
 
 
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr,
            const FiniteElement<dim> &fe)
 {
@@ -62,7 +62,7 @@ ok:
 
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   Triangulation<dim> tr;
index 5176525b3294c09c7a34d257832ebc6bb81a321d..d7756300bf3f2aa01997626bbb67abc240727564 100644 (file)
@@ -31,7 +31,7 @@
 
 
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr,
            const FiniteElement<dim> &fe)
 {
@@ -62,7 +62,7 @@ ok:
 
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   Triangulation<dim> tr;
index 6eeb31c0db558c2c212cc564301c736132fd70e7..5fd2eaa4bcab00e46eb0ffa37f864b9bd7baac47 100644 (file)
@@ -37,7 +37,7 @@
 
 // Call this function with a system consisting of several copies of
 // the SAME element
-template<int dim>
+template <int dim>
 void vector_values(const FiniteElement<dim> &fe)
 {
   Assert(fe.n_base_elements() == 1, ExcNotImplemented());
@@ -85,7 +85,7 @@ void vector_values(const FiniteElement<dim> &fe)
   deallog.pop();
 }
 
-template<int dim>
+template <int dim>
 void test_vectors()
 {
   FE_Q<dim> q1(1);
index d0e03b3bc68640faebabc9f094cae7c437f9dd8d..89aaa7ad873e2b8a3bf5b2d46d69a21b11dbf816 100644 (file)
@@ -83,7 +83,7 @@ double vector_difference(
 // Local implementation for any dimension
 
 
-template<int dim, int degree, int COMP=1>
+template <int dim, int degree, int COMP=1>
 class
   Q1WedgeFunction : public Function<dim>
 {
index 5e7460ec57da4e63ec971e851ec2e4689393651f..b45478d1ddddd3246a05811ab63912881121f13f 100644 (file)
@@ -190,7 +190,7 @@ void do_test(const Triangulation<dim> &tria,
 
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   Triangulation<dim> tria;
index 60816e5af0230c3b87ce956d6cc171e65f01c77c..8853ea5695b73f46ce3a58d4a88f7364665a9b59 100644 (file)
@@ -26,7 +26,7 @@
 #include <deal.II/grid/grid_generator.h>
 #include <deal.II/grid/tria_boundary_lib.h>
 
-template<int dim>
+template <int dim>
 void test()
 {
   Triangulation<dim> tria;
index 9cac3e19c16afcfc6579c22e89b732f7754c5074..a033abcfe97e01f342faf3a721acbe0af98d1a39 100644 (file)
@@ -26,7 +26,7 @@
 #include <deal.II/grid/tria.h>
 #include <deal.II/grid/grid_generator.h>
 
-template<int dim>
+template <int dim>
 void test()
 {
   Triangulation<dim> tria;
index 8271cc3075d4ba5d8f69b62f58122f9b0ef561e0..6bbef74d7d53b21b43a23460c42b90a916ec207d 100644 (file)
@@ -32,7 +32,7 @@
 #include <deal.II/grid/tria_boundary_lib.h>
 #include <deal.II/numerics/vector_tools.h>
 
-template<int dim>
+template <int dim>
 void test()
 {
   Triangulation<dim> tria;
index 203aab9afe652ff87b493f97b0740fa6fcb25f6a..bd48ddb81830366112ad183e4da632bbcc1e3dae 100644 (file)
@@ -98,7 +98,7 @@ transform_grid (Triangulation<2> &tria,
 
 
 
-template<int dim>
+template <int dim>
 inline void
 plot_shape_functions(const unsigned int degree)
 {
index 5c9845aec25e01b9f9fc84f70966aed60e5a6a34..46f095fb9c7294d45490d8af0f79fd6129e25b63 100644 (file)
@@ -175,7 +175,7 @@ plot (const Triangulation<dim> &tr, const unsigned int p)
 
 
 
-template<int dim>
+template <int dim>
 inline void
 check (const unsigned int p)
 {
index dd34616ae24fc00532f93b27344b2a52d006c272..46a75cba73f553d90e81827e5de1d7a6ba84d95d 100644 (file)
@@ -37,7 +37,7 @@
 
 
 
-template<int dim>
+template <int dim>
 inline void
 check (const unsigned int p)
 {
index 4413b500d13285c5b7a20967fed830c34293adaf..ace4e51f1a1aabf2159b3a97ca870916021fd6ac 100644 (file)
@@ -73,7 +73,7 @@ using namespace dealii;
 
 namespace polytest
 {
-  template<int dim>
+  template <int dim>
   class SimplePolynomial : public Function<dim>
   {
   public:
@@ -85,7 +85,7 @@ namespace polytest
                          std::vector<Vector<double> >   &values) const;
 
   };
-  template<int dim>
+  template <int dim>
   void SimplePolynomial<dim>::vector_value_list (const std::vector<Point<dim> > &points,
                                                  std::vector<Vector<double> >   &values) const
   {
@@ -103,7 +103,7 @@ namespace polytest
 
   }
 
-  template<int dim>
+  template <int dim>
   void SimplePolynomial<dim>::rhs_value_list (const std::vector<Point<dim> > &points,
                                               std::vector<Vector<double> >   &values) const
   {
@@ -121,7 +121,7 @@ namespace polytest
 
   }
 
-  template<int dim>
+  template <int dim>
   class polytest
   {
   public:
@@ -151,7 +151,7 @@ namespace polytest
 
   };
 
-  template<int dim>
+  template <int dim>
   polytest<dim>::polytest (unsigned int degree)
     :
     p_order(degree),
@@ -166,7 +166,7 @@ namespace polytest
     dof_handler.clear ();
   }
 
-  template<int dim>
+  template <int dim>
   void polytest<dim>::setup_system()
   {
     dof_handler.distribute_dofs (fe);
@@ -192,7 +192,7 @@ namespace polytest
     system_matrix.reinit (sparsity_pattern);
   }
 
-  template<int dim>
+  template <int dim>
   void polytest<dim>::assemble_system()
   {
     const QGauss<dim> test_quad(quad_order);
@@ -266,7 +266,7 @@ namespace polytest
       }
   }
 
-  template<int dim>
+  template <int dim>
   void polytest<dim>::solve()
   {
     SparseDirectUMFPACK direct;
@@ -276,7 +276,7 @@ namespace polytest
     constraints.distribute (solution);
   }
 
-  template<int dim>
+  template <int dim>
   void polytest<dim>::output_error()
   {
     SimplePolynomial<dim> exact_solution;
@@ -288,7 +288,7 @@ namespace polytest
     deallog << "p=" << p_order << " L2_error: " << L2_error << std::endl;
   }
 
-  template<int dim>
+  template <int dim>
   void polytest<dim>::run()
   {
     GridGenerator::hyper_cube (tria, -1.2, 1.3);
index d4dfa3ed8cf7041937d185503a2187cf02832346..2160939eaeabb4dfd8b34c2c61b7fb7ece190650 100644 (file)
@@ -82,7 +82,7 @@ namespace Maxwell
   using namespace dealii;
 
   // Dirichlet BCs / exact solution:.
-  template<int dim>
+  template <int dim>
   class ExactSolution : public Function<dim>
   {
   public:
@@ -96,7 +96,7 @@ namespace Maxwell
                          std::vector<Vector<double> > &value_list);
   };
 
-  template<int dim>
+  template <int dim>
   ExactSolution<dim>::ExactSolution()
     :
     Function<dim> (dim)
@@ -191,7 +191,7 @@ namespace Maxwell
   {
     dof_handler.clear ();
   }
-  template<int dim>
+  template <int dim>
   double MaxwellProblem<dim>::calcErrorHcurlNorm()
   {
     QGauss<dim>  quadrature_formula(quad_order);
@@ -385,7 +385,7 @@ namespace Maxwell
     constraints.distribute (solution);
 
   }
-  template<int dim>
+  template <int dim>
   void MaxwellProblem<dim>::process_solution(const unsigned int cycle)
   {
 
index 21dc20174ff9dc58eec11d9feb7e291f046a84a0..527fa1d122bbe69ca1086427f40198be86631b94 100644 (file)
@@ -32,7 +32,7 @@
 
 
 
-template<int dim>
+template <int dim>
 void
 check()
 {
index fc506d383f308f680cd278e8ba9443c5209b0f35..4882eaaf3917541a75ffafdce84991db6d58a109 100644 (file)
@@ -33,7 +33,7 @@
 
 
 
-template<int dim>
+template <int dim>
 Point<dim> stretch (const Point<dim> &p)
 {
   Point<dim> q = p;
@@ -44,7 +44,7 @@ Point<dim> stretch (const Point<dim> &p)
 
 
 
-template<int dim>
+template <int dim>
 void
 check()
 {
index d77119f3a48d232ca01381c0c8def1bc37c1767f..ef05755016270b5a5f5121e84454a07bc103c77f 100644 (file)
@@ -33,7 +33,7 @@
 
 
 
-template<int dim>
+template <int dim>
 Point<dim> affine (const Point<dim> &p)
 {
   Point<dim> q = p;
@@ -48,7 +48,7 @@ Point<dim> affine (const Point<dim> &p)
 
 
 
-template<int dim>
+template <int dim>
 void
 check()
 {
index 6c4a78ba5d93aa94d33b8d9df5c21f66049e4dcc..c039cd473175d70972380a76816fd39e7eb09f60 100644 (file)
@@ -33,7 +33,7 @@
 
 
 
-template<int dim>
+template <int dim>
 Point<dim> bilinear (const Point<dim> &p)
 {
   Point<dim> q = p;
@@ -48,7 +48,7 @@ Point<dim> bilinear (const Point<dim> &p)
 
 
 
-template<int dim>
+template <int dim>
 void
 check()
 {
index 32b09a22cea5e165441f6984c7b61acf6ac999c1..720bf7d075e2f58c8d34c51f6543ff8e3d80002b 100644 (file)
@@ -32,7 +32,7 @@
 
 
 
-template<int dim>
+template <int dim>
 void
 check()
 {
index 81902b8223abbf084769e30fba48abcaa1f14501..887af36b96e90ce981c01b31979fa0cc0cf36e77 100644 (file)
@@ -33,7 +33,7 @@
 
 
 
-template<int dim>
+template <int dim>
 Point<dim> stretch (const Point<dim> &p)
 {
   Point<dim> q = p;
@@ -44,7 +44,7 @@ Point<dim> stretch (const Point<dim> &p)
 
 
 
-template<int dim>
+template <int dim>
 void
 check()
 {
index e582cfb42a369f5e0655d4587afa91d28c07890d..f68e72a8f8074f08916ad4c671ffc9688ef8e567 100644 (file)
@@ -33,7 +33,7 @@
 
 
 
-template<int dim>
+template <int dim>
 Point<dim> affine (const Point<dim> &p)
 {
   Point<dim> q = p;
@@ -48,7 +48,7 @@ Point<dim> affine (const Point<dim> &p)
 
 
 
-template<int dim>
+template <int dim>
 void
 check()
 {
index e229680a24f01f06fd11f21b365cd1888204e95f..27a73ac2c2def7fb9f659dfb9c23e8137b6a3c0a 100644 (file)
@@ -33,7 +33,7 @@
 
 
 
-template<int dim>
+template <int dim>
 Point<dim> bilinear (const Point<dim> &p)
 {
   Point<dim> q = p;
@@ -48,7 +48,7 @@ Point<dim> bilinear (const Point<dim> &p)
 
 
 
-template<int dim>
+template <int dim>
 void
 check()
 {
index b43cd94fb7d8edb849f1fa7fa36c6e60fd7ec4c3..cb5cad89e73e3ec98df9af267d93b9b4170874b9 100644 (file)
@@ -32,7 +32,7 @@
 
 
 
-template<int dim>
+template <int dim>
 void
 test(const FE_Q<dim> &fe_q)
 {
index 9cbf520e4611cb287e58b9e2f7a5d8df6ee808a9..68128b2b4d4731324b44cb661ef14592bf361cfb 100644 (file)
@@ -32,7 +32,7 @@
 
 
 
-template<int dim>
+template <int dim>
 void
 test(const FE_Q<dim> &fe_q)
 {
index 880472bdb1419c697241b698ba5428a7ce25edbc..3b1200aea6b49740f0cf90f2c22dc98e6e3e9c0a 100644 (file)
@@ -32,7 +32,7 @@
 
 
 
-template<int dim>
+template <int dim>
 void
 test(const FE_Q<dim> &fe_q)
 {
index bda7c0d8aa5806f8c819d4f5ff30d1fcd04f77ef..dd20b114fbe8028680d100c71112b439b2606730 100644 (file)
@@ -33,7 +33,7 @@
 
 
 
-template<int dim>
+template <int dim>
 void
 test(const FE_Q<dim> fe1,
      const FE_Q<dim> fe2)
index cad59ce38785b07bea1d75dfe6887c705451fd58..adb6f82fb11f54a4313a382dae01c3ed23a14997 100644 (file)
@@ -31,7 +31,7 @@
 
 
 
-template<int dim>
+template <int dim>
 inline void
 plot_shape_functions(const unsigned int degree)
 {
index 5b0e0b93ad1fac3f2a469ec5b0ce1dd2fffe22c5..7f0229ec0649df0450c2cf7733015d44a7481e9c 100644 (file)
@@ -43,7 +43,7 @@
 
 std::ofstream logfile ("output");
 
-template<int dim>
+template <int dim>
 void
 test (const unsigned int degree)
 {
index 557463bb0ee4887c3c6bf16c88aa4fb84fbd7ea2..434671ace65581113a850e0fdf84f7fef38eef4a 100644 (file)
@@ -49,7 +49,7 @@
 
 std::ofstream logfile ("output");
 
-template<int dim>
+template <int dim>
 void
 test (const unsigned int degree)
 {
index 7d209a78c9ed6bb76aa21254406da9cce9101f23..46ffb3c1b6241ba1c01c5fb156a72b21a2ea606f 100644 (file)
@@ -42,7 +42,7 @@
 
 std::ofstream logfile ("output");
 
-template<int dim>
+template <int dim>
 void
 test (const unsigned int degree)
 {
index bdd3f06903d74b02d8aeaa9fad871d709ea92c93..70227a88ff7ba57a87be219f3a6282dec8de9bd8 100644 (file)
@@ -47,7 +47,7 @@
 
 std::ofstream logfile ("output");
 
-template<int dim>
+template <int dim>
 void
 test (const unsigned int degree)
 {
index a28ba4daea3a84a44f72ff263551a0b2428d7aee..eda363db57709673444b6e3473b0ee464edb6873 100644 (file)
@@ -47,7 +47,7 @@
 
 std::ofstream logfile ("output");
 
-template<int dim>
+template <int dim>
 void
 test (const unsigned int degree)
 {
index e43ce73e90738b8b6ed3ee241d49242f560f6273..4a3bea9390538f3c9b8c7075f879b40662f69d3a 100644 (file)
@@ -47,7 +47,7 @@
 
 std::ofstream logfile ("output");
 
-template<int dim>
+template <int dim>
 void
 test (const unsigned int degree)
 {
index cb57d76ba8e4d3d9b6fb3d895947a5d326aa7c32..d9552275b1f73de5e80977decb808c5a8c96d419 100644 (file)
@@ -92,7 +92,7 @@ transform_grid (Triangulation<2> &tria,
 
 
 
-template<int dim>
+template <int dim>
 void
 plot_shape_functions(const unsigned int degree)
 {
index c5231294ebccabe9f93d75f83c21dbc19282d146..01cd69ee1c767550c946d2bfeb55404b6ede62dd 100644 (file)
@@ -28,7 +28,7 @@
 
 
 
-template<int dim>
+template <int dim>
 void
 test(const unsigned int degree)
 {
index 704f99bfc3ce57f47fda2b2a599fbfc06afb4708..9a60dc2dd32e4d91f97f47b9faac75159616a9f3 100644 (file)
@@ -28,7 +28,7 @@
 
 
 
-template<int dim>
+template <int dim>
 void
 test(const unsigned int degree)
 {
index 5cdd5cf33d3203f335ed5867013f9998bb2838fc..f978be0121d1d7b3d0b1b528782760772317ea91 100644 (file)
@@ -36,7 +36,7 @@
 
 
 
-template<int dim>
+template <int dim>
 void
 plot_shape_functions(const unsigned int degree)
 {
index a3026bd4ce915be0a93fa85afde0d43a0a708cd5..1dd49d790aab5e6cb8f1638d40cb2a5b0f01ef48 100644 (file)
@@ -41,7 +41,7 @@
 
 std::ofstream logfile ("output");
 
-template<int dim>
+template <int dim>
 void
 test (const unsigned int degree)
 {
index bdcac8f7c35685137468b598233b91d1b586e160..474564ec91602595ac01f6f4aeba153602b658e1 100644 (file)
@@ -43,7 +43,7 @@
 
 std::ofstream logfile ("output");
 
-template<int dim>
+template <int dim>
 void
 test (const unsigned int degree)
 {
index 70e30f8ec348bb9956020b1e67a29b48863b4876..f2549786f560dae6e0f6453f4e3704d315b28f7a 100644 (file)
@@ -38,7 +38,7 @@
 
 
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr,
            const FiniteElement<dim> &fe)
 {
@@ -59,7 +59,7 @@ void test (const Triangulation<dim> &tr,
 
 
 
-template<int dim>
+template <int dim>
 void test_hyper_sphere()
 {
   Triangulation<dim> tr;
index fc24f2b165f229d0a4f76036fe3d9e03ff825073..caac93d3cdea3e881b62a58fd1731aa5e7f3a31d 100644 (file)
@@ -38,7 +38,7 @@
 
 
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr,
            const FiniteElement<dim> &fe)
 {
@@ -67,7 +67,7 @@ void test (const Triangulation<dim> &tr,
 
 
 
-template<int dim>
+template <int dim>
 void test_hyper_sphere()
 {
   Triangulation<dim> tr;
index ce28ca27b721efc5d1268a0bc1396a034564c94b..68ccc03713baf0e83aa8a843d85042faf5c969fa 100644 (file)
@@ -129,7 +129,7 @@ compare_shapes (const FiniteElement<dim> &other,
 }
 
 
-template<int dim>
+template <int dim>
 void
 test (unsigned int degree)
 {
index cf19a72038ca3828cc099a2a6a23a36bd3b8f8bf..e082f6d49d392c7afbfa4e156182605010885741 100644 (file)
@@ -37,7 +37,7 @@
 
 
 
-template<int dim>
+template <int dim>
 void
 plot_shape_functions(const unsigned int degree)
 {
index e32ad90dbed4fa5f4aa6b6e7357690f64ad70ff8..b029b7161c86f9f0816caa74f0b40f68157a307f 100644 (file)
@@ -29,7 +29,7 @@
 
 
 
-template<int dim>
+template <int dim>
 void test ()
 {
   for (unsigned int degree=0; degree<9-2*dim; ++degree)
index c81b99584c031a924265a596d49c64dd6b556edf..1df0eedbd6fbb5f0e921735923c8492f9af21d61 100644 (file)
@@ -26,7 +26,7 @@ char fname[50];
 //
 // x (y) (z) value[0]+1 value[1]+1 ...
 ////////////////////////////////////////////////////////////////////////////
-template<int dim>
+template <int dim>
 inline void
 plot_shape_functions(Mapping<dim> &mapping,
                      FiniteElement<dim> &finel,
@@ -98,7 +98,7 @@ plot_shape_functions(Mapping<dim> &mapping,
 
 
 
-template<int dim>
+template <int dim>
 inline void
 plot_face_shape_functions(
   Mapping<dim> &mapping,
@@ -270,7 +270,7 @@ plot_face_shape_functions(
 }
 
 
-template<>
+template <>
 void plot_face_shape_functions (Mapping<1> &, FiniteElement<1> &, const char *, UpdateFlags)
 {}
 
@@ -370,7 +370,7 @@ check_values_and_derivatives (const FiniteElement<dim> &fe,
 
 
 
-template<int dim>
+template <int dim>
 void test_compute_functions (const Mapping<dim> &mapping,
                              const FiniteElement<dim> &fe,
                              const char *)
index b2ce1f66a5749f6e9d6eb1982557d19e79fcad2f..65cb93572a94a59b970084ee0c56cd635624a31d 100644 (file)
@@ -26,7 +26,7 @@
 #define PRECISION 8
 
 
-template<int dim>
+template <int dim>
 void plot_FE_Bernstein_shape_functions()
 {
   MappingQGeneric<dim> m(1);
index a6e04d183fc55154fbe2a17e4bc1bb2d053ea660..e3c56aeac84ae098bcffb5bb7d126752b5ad7ff7 100644 (file)
@@ -24,7 +24,7 @@
 #define PRECISION 8
 
 
-template<int dim>
+template <int dim>
 void plot_FE_DGP_shape_functions()
 {
   MappingQGeneric<dim> m(1);
index e90262953ff39b6657d58c23eaba31b77e8151f1..e9839f7485ce87c9f68b957ddddf6680df16c004 100644 (file)
@@ -24,7 +24,7 @@
 #define PRECISION 8
 
 
-template<int dim>
+template <int dim>
 void plot_FE_DGPMonomial_shape_functions()
 {
   MappingQGeneric<dim> m(1);
index 88dda636fd8c111158f3f2e84f04cb3636193fd2..1eeeb6a828700abd7f703529929dd5461517dcf8 100644 (file)
@@ -24,7 +24,7 @@
 #define PRECISION 8
 
 
-template<int dim>
+template <int dim>
 void plot_FE_DGPNonparametric_shape_functions()
 {
   MappingQGeneric<dim> m(1);
index 9c323529f95e204c6072cf7eed5a0be1ca8bb8c3..e9a644e923d6388dc9b7557afdacee23a0761112 100644 (file)
@@ -24,7 +24,7 @@
 #define PRECISION 8
 
 
-template<int dim>
+template <int dim>
 void plot_FE_DGQ_shape_functions()
 {
   MappingQGeneric<dim> m(1);
index eb14f392e0d185eccb18acf99c6de3afdb48178b..c28579eac5fab4c7b266355fcbf39db7d0ea90a3 100644 (file)
@@ -26,7 +26,7 @@
 #define PRECISION 8
 
 
-template<int dim>
+template <int dim>
 void plot_FE_FaceQ_shape_functions()
 {
   MappingQGeneric<dim> m(1);
index be8cca0d627f86c98d07d73d5c7521eea5ed5b5a..2eafb0f8aa9d06a59990186190e314cdd643d2a1 100644 (file)
@@ -24,7 +24,7 @@
 #define PRECISION 8
 
 
-template<int dim>
+template <int dim>
 void plot_FE_Nedelec_shape_functions()
 {
   MappingQGeneric<dim> m(1);
index 59e1469212cbb53c576a416a7c40ca83e9c972f2..6ed437de72eb4fd3432d98e31b613b3e90ab2cf5 100644 (file)
@@ -24,7 +24,7 @@
 #define PRECISION 8
 
 
-template<int dim>
+template <int dim>
 void plot_FE_Q_shape_functions()
 {
   MappingQGeneric<dim> m(1);
index 2d4d637de3ceaa820940f512dd75b5e54988689e..6e53192e31082ee5cfcbc439156be76fbe1fc8fa 100644 (file)
@@ -24,7 +24,7 @@
 #define PRECISION 7
 
 
-template<int dim>
+template <int dim>
 void plot_FE_Q_Bubbles_shape_functions()
 {
   MappingQGeneric<dim> m(1);
index 27c119bc8c1ea616b1e9e20e6682511731d0578e..5161dd9fef23fcc095d5b6a9c38ab1fa0c057f3f 100644 (file)
@@ -24,7 +24,7 @@
 #define PRECISION 8
 
 
-template<int dim>
+template <int dim>
 void plot_FE_Q_DG0_shape_functions()
 {
   MappingQGeneric<dim> m(1);
index 619a9bd705d08a6db5d2a212e7b2968ea92433f6..03f5b5f59050a36e12e69b611a6241d17b091b8d 100644 (file)
@@ -24,7 +24,7 @@
 #define PRECISION 8
 
 
-template<int dim>
+template <int dim>
 void plot_FE_Q_Hierarchical_shape_functions()
 {
   MappingQGeneric<dim> m(1);
index 18a3f4c957c3dc933301452b40c5fdf18c7aec0d..8fc96eaec227142eb5d99f03c1b4f5a6eae643c4 100644 (file)
@@ -24,7 +24,7 @@
 #define PRECISION 8
 
 
-template<int dim>
+template <int dim>
 void plot_FE_Q_shape_functions()
 {
   MappingQGeneric<dim> m(1);
index de454833d43766ac93d54328bec00dafaf50de0f..c3f25ed2c8ec0f6d0db9f83c9cf88acc5812b063 100644 (file)
@@ -27,7 +27,7 @@
 
 #define PRECISION 8
 
-template<int dim>
+template <int dim>
 void plot_FE_System_shape_functions()
 {
   MappingQGeneric<dim> m(1);
index a4569f4743b9b9d22f2e071466b3d878656894f3..94099753b86a1c59dd27f0143f7f124e3f4d62d1 100644 (file)
@@ -29,7 +29,7 @@
 
 #define PRECISION 8
 
-template<int dim>
+template <int dim>
 void plot_FE_System_shape_functions()
 {
   MappingQGeneric<dim> m(1);
index 75195bb8f8ea7d1347efdfaefe7c3e52bdf965c9..daf6213f2575eb8220408d3a67d0d3ee6130c27f 100644 (file)
@@ -25,7 +25,7 @@
 #define PRECISION 8
 
 
-template<int dim>
+template <int dim>
 void plot_FE_TraceQ_shape_functions()
 {
   MappingQGeneric<dim> m(1);
index f6480958020fd23a7406f665e83fd735edd5af1b..f4589c38179f5b1a1df33436a6739dc343dc2608 100644 (file)
@@ -37,7 +37,7 @@
 
 
 
-template<int dim>
+template <int dim>
 void
 check(const FiniteElement<dim> &fe1,
       const FiniteElement<dim> &fe2)
index 3f11b0bb0fcdc7f25228de4e203cf58ed8ffd68b..845c99b1d8baa7904a565f98878b36d037407a1f 100644 (file)
@@ -32,7 +32,7 @@
 
 
 
-template<int dim>
+template <int dim>
 void
 check(FESystem<dim> &fe)
 {
index 29604abef2a54cff74e3da99e0ffc71e8d8c5729..fb8667739d32726944c6b1ddf1fb2d743e98c9b7 100644 (file)
@@ -31,7 +31,7 @@
 
 
 
-template<int dim>
+template <int dim>
 void
 check_fe(const FiniteElement<dim> &fe)
 {
@@ -123,7 +123,7 @@ check_fe(const FiniteElement<dim> &fe)
 
 
 
-template<int dim>
+template <int dim>
 void check()
 {
   FE_DGQ<dim> co(0);
index 8a1ca9b3a3af88471a8c947226c84819865db194..fb14ff920c2906f63813c4e9d3662f6a2fa59000 100644 (file)
@@ -38,7 +38,7 @@
     deallog << # el << '<' << dim << ">(" << deg << ')' << std::endl; \
     print_matrix(tr ## dim, l, fe, #el); }
 
-template<int dim>
+template <int dim>
 inline void
 print_matrix(Triangulation<dim> &tr,
              unsigned int level,
index 7260481004a26829b066e0fc51272eab9ffe52d7..c2baf1ac78a78971e300a9d442fcba55a6129af4 100644 (file)
@@ -32,7 +32,7 @@
 #include <fstream>
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   Triangulation<dim> triangulation (Triangulation<dim>::limit_level_difference_at_vertices);
index d39383cd31a1dafe0d5bab25a8abbc1372c0896e..9fe8e1c9f339b9981ce51f49440177b13e39f72d 100644 (file)
@@ -32,7 +32,7 @@
 #include <fstream>
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   Triangulation<dim> triangulation (Triangulation<dim>::limit_level_difference_at_vertices);
index d36372228b816bd5e0568b67b5c527892b52565a..ec3dcea4201bf5912b38f72583bfa13919c925af 100644 (file)
@@ -33,7 +33,7 @@
 #include <fstream>
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   Triangulation<dim> triangulation (Triangulation<dim>::limit_level_difference_at_vertices);
index 051672e512fc54502fbf86cdb40e478dfecf1227..6a675ad1c8030465d7f46739ee7cadb46e13601a 100644 (file)
@@ -36,7 +36,7 @@
 #include <fstream>
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   Triangulation<dim> triangulation (Triangulation<dim>::limit_level_difference_at_vertices);
index f87e4b481c4273911ccee0c853279dfb51d67740..3dd9814a918beadcb13e8a226fbba1f3ab505bff 100644 (file)
@@ -70,7 +70,7 @@ satisfies_level1_at_vertex_rule (const Triangulation<dim> &tr)
 }
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   Triangulation<dim> triangulation (Triangulation<dim>::limit_level_difference_at_vertices);
index 7582362e2ce38195a08d83ac43a9b7510d7c17bb..156d1686a4a0ac80afd9cf7ea92c901453889733 100644 (file)
@@ -71,7 +71,7 @@ satisfies_level1_at_vertex_rule (const Triangulation<dim> &tr)
 }
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   Triangulation<dim> triangulation (Triangulation<dim>::limit_level_difference_at_vertices);
index 99a9d356f77dd0a0115e3536a27d95a5cfc5e755..e5e2b0c20281558e44a7dd020f7efc07b1a130c6 100644 (file)
@@ -67,7 +67,7 @@ satisfies_level1_at_vertex_rule (const Triangulation<dim> &tr)
 }
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   Triangulation<dim> triangulation (Triangulation<dim>::limit_level_difference_at_vertices);
index 36537c561cfedf7ecfbfed80276a20401c885b91..8c0450abed40025caa68dcec1e9d16a91005f1b8 100644 (file)
@@ -33,7 +33,7 @@
 #define PRECISION 5
 
 
-template<int dim>
+template <int dim>
 void create_triangulation(const unsigned int,
                           Triangulation<dim> &)
 {
@@ -41,7 +41,7 @@ void create_triangulation(const unsigned int,
 }
 
 
-template<>
+template <>
 void create_triangulation(const unsigned int case_no,
                           Triangulation<2> &tria)
 {
@@ -105,7 +105,7 @@ void create_triangulation(const unsigned int case_no,
 }
 
 
-template<>
+template <>
 void create_triangulation(const unsigned int case_no,
                           Triangulation<3> &tria)
 {
@@ -175,7 +175,7 @@ void create_triangulation(const unsigned int case_no,
 }
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   Triangulation<dim> tria;
index 6bbe54ccec2b6073cc6360736dfac8c087b0d62f..4073516cc2c938ac02ca7e979a415d83608946b6 100644 (file)
@@ -89,7 +89,7 @@ void create_triangulation(const unsigned int case_no,
 }
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   Triangulation<dim> tria;
index ed5a04dc81b9fa62bda00f7460b2677a97b3bdd4..a2a34eeb0d7bffea5b44b2aebab4374913792f66 100644 (file)
@@ -24,7 +24,7 @@
 #include <deal.II/dofs/dof_accessor.h>
 #include "../tests.h"
 
-template<int dim>
+template <int dim>
 void
 test()
 {
index 011b012141530baad2ffafa108469afcd58a8c2a..97ce2125c7744d108b72c63f023507d947311744 100644 (file)
@@ -32,7 +32,7 @@
 
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   Triangulation<dim> triangulation (Triangulation<dim>::limit_level_difference_at_vertices);
index ea9392af37d6f079b0af284baecea4065938c037..e483e4d5846858b9bad89ea83fba9f0abf0ea18f 100644 (file)
@@ -32,7 +32,7 @@
 
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   Triangulation<dim> triangulation (Triangulation<dim>::limit_level_difference_at_vertices);
index 84a48ee83114202665bad7df350a3551111da770..ebf6eb0459892c00900613bdfd538afbf9947c44 100644 (file)
@@ -34,7 +34,7 @@
 
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   Triangulation<dim> triangulation (Triangulation<dim>::limit_level_difference_at_vertices);
index adf0ca5c5273bb286746d79bc46ab1272616d1b2..871c73cc5202528b98fb88f31892601d2d557019 100644 (file)
@@ -40,7 +40,7 @@
 using namespace dealii;
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   using namespace dealii;
index 1dd20986c575ef58cd72bed5dcfd88bb22ab2d97..8147480e6ebdaebf5b8da1a4e780a186c7fe471c 100644 (file)
@@ -26,7 +26,7 @@
 #include <fstream>
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   // create 2 triangulations with the
index fa4ec71ba056b1d3b822a9aa908ef1cb31647986..56be146eac4fc66191506e05895bfdf155e156cf 100644 (file)
@@ -26,7 +26,7 @@
 #include <fstream>
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   // create 2 triangulations with the
index 9a839b21010d4e3137dda34192ce2ea121e74be6..6467e0049fd46a29b197013cab81713e3124c28d 100644 (file)
@@ -26,7 +26,7 @@
 #include <fstream>
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   // create 2 triangulations with the
index 20043e0bbd35d3b72d9f584e1d44b7fdeb2f4f85..b78aa0bebc374e2f73893518d25a4878688a88c7 100644 (file)
@@ -32,7 +32,7 @@
 
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   Triangulation<dim> triangulation (Triangulation<dim>::limit_level_difference_at_vertices);
index 8868b57a8cf9469573bcf84fcb94b7082339d815..27deccc0d99f361e414fe0ac9df0633b37eb7843 100644 (file)
@@ -28,7 +28,7 @@
 #include <iomanip>
 
 
-template<int dim>
+template <int dim>
 void test(std::ostream &out)
 {
   Point<dim> p1;
index de457ca5854c87581d91b3709df23d0fdd51e945..5446994813625d13c5005f8818da2b1a0cfc64c8 100644 (file)
@@ -30,7 +30,7 @@
 #include <iomanip>
 
 
-template<int dim>
+template <int dim>
 void test(std::ostream &out)
 {
   Point<dim> p1;
index 7681f2701b7eb012b709fc458f9ef43184313e6c..895db72031d4df674651b1eed5c9a877380fc88a 100644 (file)
@@ -30,7 +30,7 @@
 #include <iomanip>
 
 
-template<int dim>
+template <int dim>
 void test(std::ostream &out)
 {
   Point<dim> p1;
index 70de9a9ecc3ff60c865f2f79a0464279f4c3a663..5ee2228e99abc2bee8e58a1965e20b928c18122f 100644 (file)
@@ -29,7 +29,7 @@
 #include <iomanip>
 
 
-template<int dim>
+template <int dim>
 void test(std::ostream &out)
 {
   Point<dim> p1;
index 807a31eb86938fdf82496a9652f937bafa49bfe5..44c0ef23fa042a2303fe5bd560e944c83c764e74 100644 (file)
@@ -68,7 +68,7 @@ template <> Table<3,types::material_id> material_ids<3>()
 
 
 
-template<int dim>
+template <int dim>
 void test(std::ostream &out)
 {
   Point<dim> p1;
index 790718ff6a1f224e6ecfcafe0832151c39ad3fa5..9a58904c43e8285d21ea349c358efe54a92c5aa6 100644 (file)
@@ -27,7 +27,7 @@
 #include <iomanip>
 
 
-template<int dim>
+template <int dim>
 void test(std::ostream &out)
 {
   GridOut go;
index 5f57b400ca211bada0edca1171879753e515f25e..07972330cb507379d29210a2144301fb53426974 100644 (file)
@@ -29,7 +29,7 @@
 #include <iomanip>
 
 
-template<int dim>
+template <int dim>
 void test(std::ostream &out)
 {
   Point<dim> p1;
index ecd2ab4f4f57cfe6eec52544e2eae20091e9370b..53dbf1e9bbce24310c22989cff00f912fe653cb5 100644 (file)
@@ -29,7 +29,7 @@
 #include <iomanip>
 
 
-template<int dim>
+template <int dim>
 void test(std::ostream &out)
 {
   Triangulation<2> triangulation;
index a6ddc0603f722e6e1685b245ee9dc6383e6402d1..cdad5d5bfb3266cff4e78a2dcf488c6fbef419ce 100644 (file)
@@ -29,7 +29,7 @@
 #include <iomanip>
 
 
-template<int dim>
+template <int dim>
 void test(std::ostream &out)
 {
   Triangulation<dim> triangulation;
index e87abb4aabf097c5e091f585d70bb06e223e9928..7af586e38500b6b31d5db452355f0e22b9d63355 100644 (file)
@@ -28,7 +28,7 @@
 #include <iomanip>
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void test(std::ostream &out)
 {
   Point<dim> p1;
index 93cefe25e40cfba3d9286a5f8380efe08fd6fe42..29cfa8196190d252ed8f28113139261dc3bb3ddf 100644 (file)
@@ -32,7 +32,7 @@
 std::ofstream logfile("output");
 
 
-template<int dim>
+template <int dim>
 void check_rect1 (unsigned int n, bool color, bool log)
 {
   Point<dim> left;
index c5d783f757633eb435994eb5aea40429d957198a..0b601bb5f833adaeee8dfd309b34b69e13e33e47 100644 (file)
@@ -42,7 +42,7 @@
 #include <iomanip>
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void test(std::ostream &out)
 {
   Triangulation<dim,spacedim>   triangulation;
index b65910898bd316cd30630c2e80c7e1ebce19a8e2..f7b55bcd8305349c5ae0f729da8cf62e9d62f032 100644 (file)
@@ -37,7 +37,7 @@
 std::ofstream logfile("output");
 
 
-template<int dim>
+template <int dim>
 void check (double r1, double r2, unsigned int n)
 {
   deallog << "dim=" << dim << std::endl;
index d9dbb53f5b9f27700729eeb5ff5db692516cd8b5..d7770024bb3b7f997333afc4e879910c5004a9cd 100644 (file)
@@ -36,7 +36,7 @@
 std::ofstream logfile("output");
 
 
-template<int dim>
+template <int dim>
 void check (double r1, double r2, unsigned int n)
 {
   Point<dim> center;
index b36dcdaee5882102001699422506ac9b70385e17..52a2f55737f277c75ae0276578ee685c4df8a340 100644 (file)
@@ -36,7 +36,7 @@
 std::ofstream logfile("output");
 
 
-template<int dim>
+template <int dim>
 void check (double r1, double r2, unsigned int n)
 {
   Point<dim> center;
index 1656c12151e7546a122e7e0153dda6a89596c2cc..c16c6dd3d08e9b2feeb7b971593d035598c6d999 100644 (file)
@@ -36,7 +36,7 @@
 std::ofstream logfile("output");
 
 
-template<int dim>
+template <int dim>
 void check (double r1, double r2, unsigned int n)
 {
   Point<dim> center;
index b6cd733281e030e40cd371c1edb897eff141c845..dd74f38b0ac7f11b8a3b614abebd41fa9d3ace4e 100644 (file)
@@ -42,7 +42,7 @@
 std::ofstream logfile("output");
 
 
-template<int dim>
+template <int dim>
 void check (const unsigned int n)
 {
   deallog << "n=" << n << std::endl;
index 3a3826e1b0c643e3dce283a6f35098d0a93ea89e..a22745174661f27abd26bbb8c3085ef43698c9d6 100644 (file)
@@ -38,7 +38,7 @@
 std::ofstream logfile("output");
 
 
-template<int dim>
+template <int dim>
 void check (double r1, double r2, unsigned int n)
 {
   Point<dim> center;
index d1ba50ec743a5a531dc03c008470ecf6c5ca2bd7..54c9c2e24cbad3967681ca0aea0f55b1784e0d7a 100644 (file)
@@ -110,7 +110,7 @@ void test3 ()
 }
 
 
-template<int dim>
+template <int dim>
 void check_file (const std::string name,
                  typename GridIn<dim>::Format format)
 {
index dd51733122a4a4a8f2cd12be5a291cf2e66c6fe4..a390f758ce834a8c818c9246eac7776939c597db 100644 (file)
@@ -35,7 +35,7 @@
 std::ofstream logfile("output");
 
 
-template<int dim>
+template <int dim>
 void check_file (const std::string name,
                  typename GridIn<dim>::Format format)
 {
index 4e367d370bb58f1e7f602d5125b4998f9fe3dafe..855744606608c6ec02638b74853f14e4afac47a4 100644 (file)
@@ -37,7 +37,7 @@
 std::ofstream logfile("output");
 
 
-template<int dim>
+template <int dim>
 void check_file (const std::string name,
                  typename GridIn<dim>::Format format)
 {
index c8a38f5dd9784cb74536e5a8a5a486a192a05b0d..3f9949aa9dc46f9feab8b327629b2426e7e25376 100644 (file)
@@ -37,7 +37,7 @@
 std::ofstream logfile("output");
 
 
-template<int dim>
+template <int dim>
 void check_file (const std::string name,
                  typename GridIn<dim>::Format format)
 {
index 64e95d23ccee3f9d31c3534c2ac4bf391dc5c7e9..cae63b38f989da193a0731926d1a39e2bbc14481 100644 (file)
@@ -36,7 +36,7 @@
 std::ofstream logfile("output");
 
 
-template<int dim>
+template <int dim>
 void check_file (const std::string name,
                  typename GridIn<dim>::Format format)
 {
index 3a9918ab2481a61b5c75eaabc65fe8cf5e779c15..2bfc90fe1b00ef2683f45361f4f4e03ab27c5873 100644 (file)
@@ -38,7 +38,7 @@
 std::ofstream logfile("output");
 
 
-template<int dim>
+template <int dim>
 void check_file (const std::string name,
                  typename GridIn<dim>::Format format)
 {
index 9d573eef05f007c9049449dbbd2e9040bcd7c782..f2979ddc3a54c9b90d53e3cc17db2eaea9d8e0cb 100644 (file)
@@ -38,7 +38,7 @@
 std::ofstream logfile("output");
 
 
-template<int dim>
+template <int dim>
 void check_file (const std::string name,
                  typename GridIn<dim>::Format format)
 {
index 63a621b227785b6366a6fdedd80547c44a5e3ca7..3070a8a22ac57d8977807987a69cc7f2da8e59f4 100644 (file)
@@ -39,7 +39,7 @@
 std::ofstream logfile("output");
 
 
-template<int dim>
+template <int dim>
 void check_file (const std::string name,
                  typename GridIn<dim>::Format format)
 {
index 6a316bdb7f156b472dbb601ff0729aeb396df818..8b7abf7d32e73d96e0b3a1baf1103f8f6b5918a0 100644 (file)
@@ -35,7 +35,7 @@
 std::ofstream logfile("output");
 
 
-template<int dim>
+template <int dim>
 void check_file (const std::string name,
                  typename GridIn<dim>::Format format)
 {
index 219d26c35580f77ece2ff6373644ef4c4bba69f9..1c293674f264a3b155b532f905ed469802620b3c 100644 (file)
@@ -35,7 +35,7 @@
 std::ofstream logfile("output");
 
 
-template<int dim>
+template <int dim>
 void check_file (const std::string name,
                  typename GridIn<dim>::Format format)
 {
index c82de7f73e76584bc8cb9230e981af54d34f0d18..cac1376c517b7433afeb1ded830fc715c4a13231 100644 (file)
@@ -35,7 +35,7 @@
 std::ofstream logfile("output");
 
 
-template<int dim>
+template <int dim>
 void check_file (const std::string name,
                  typename GridIn<dim>::Format format)
 {
index 72099181d8d95ab585a96cb2e61d7af6bd1b48cf..be2017112b59bd2c7832f7d78cc863df85234ad6 100644 (file)
@@ -35,7 +35,7 @@
 std::ofstream logfile("output");
 
 
-template<int dim>
+template <int dim>
 void check_file (const std::string name,
                  typename GridIn<dim>::Format format)
 {
index 0bf58e7e661b219d71cedcff35b47d0ab7117c74..54dac26c09736253b38e79424837beb85087c1b3 100644 (file)
@@ -35,7 +35,7 @@
 std::ofstream logfile("output");
 
 
-template<int dim>
+template <int dim>
 void check_file (const std::string name,
                  typename GridIn<dim>::Format format)
 {
index 5a505b09523d2512641233edc58ced2c81ff4de2..9764b8bbe38af190fbaa6e8c2f25471776393cac 100644 (file)
@@ -36,7 +36,7 @@
 
 #include <fstream>
 
-template<int dim>
+template <int dim>
 void output(const parallel::distributed::Triangulation<dim> &tr,
             const std::string                               &filename,
             const bool                                      view_levels,
@@ -61,7 +61,7 @@ void output(const parallel::distributed::Triangulation<dim> &tr,
     AssertThrow(false, ExcNotImplemented());
 }
 
-template<int dim>
+template <int dim>
 void test()
 {
   unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
index a49df5851974570950cddc43128b7b03782ffa30..4f3029701d39d8c064525b02430832c1075416c0 100644 (file)
@@ -37,7 +37,7 @@
 
 #include <fstream>
 
-template<int dim>
+template <int dim>
 void output(const parallel::shared::Triangulation<dim> &tr,
             const std::string                          &filename,
             const bool                                 view_levels,
@@ -60,7 +60,7 @@ void output(const parallel::shared::Triangulation<dim> &tr,
     AssertThrow(false, ExcNotImplemented());
 }
 
-template<int dim>
+template <int dim>
 void test()
 {
   unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
index 2e6624f0575ff4bdc8cf452ff9d68b26982294d1..2a1ac909c4d098746242a5a86eaa74073f57d44b 100644 (file)
 
 #include <fstream>
 
-template<int dim>
+template <int dim>
 void output(parallel::distributed::Triangulation<dim> &tr, std::ostream &stream)
 {
   GridOut out;
   out.write_vtk(tr, stream);
 }
 
-template<int dim>
+template <int dim>
 void test()
 {
   unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
index 60235a56d38e9c8c169d9c367d37751c0be21b0a..798cf027fbaae0f40c350db556dfb8bf6d0a2e6c 100644 (file)
@@ -30,7 +30,7 @@
 #include <iomanip>
 
 
-template<int dim>
+template <int dim>
 void test(std::ostream &out)
 {
   GridOut go;
index 8ddb15dcaabc76abe15eadb873aaccdd2904930d..6d34fabf5a04f366e8e5e5ad7b44a38ac610d5a0 100644 (file)
@@ -36,7 +36,7 @@ std::ofstream logfile ("output");
 
 // The simplest test case is to create a parallelepiped grid, output
 // the result, and hope for the best.
-template<int dim>
+template <int dim>
 void check_parallelepiped (bool colorize, bool log)
 {
   // Data structure defining dim coordinates that make up a
index 56fe676543a26a8583fd53e94996a18625847189..6258f26a488c5f07e278655b1d3c40b7eac8ac47 100644 (file)
@@ -41,7 +41,7 @@ std::ofstream logfile ("output");
 // grid), this test is not entirely trivial.
 //
 // Here is the implementation in nd:
-template<int dim>
+template <int dim>
 void check_nd_parallelepiped_by_comparison (bool log)
 {
 
index e76d0b8e145f151404a30d9fd5002d0a8fae79ac..e06dbd27ab4a002d8ca16259446a205692f19345 100644 (file)
@@ -36,7 +36,7 @@ std::ofstream logfile ("output");
 
 // The simplest test case is to create a parallelepiped grid with a
 // number of subdivisions and output the result.
-template<int dim>
+template <int dim>
 void check_subdivided_parallelepiped (bool colorize, bool log)
 {
   // Data structure defining dim coordinates that make up a
index b87069ad25bb4c2c85d9b666309553b873056efa..9c4115faa0c41ae6bbe7f6913ca59069abca8c5a 100644 (file)
@@ -44,7 +44,7 @@
 #include <iomanip>
 #include <map>
 
-template<int dim>
+template <int dim>
 void check_parallelepiped (bool colorize, bool log, const unsigned int (&subd)[dim])
 {
   deallog << "* checking dim=" << dim
index e0c7151d1810d6d85b1f2f117fd56a3a89861b3e..69de333d7d3c7336d358d94e8db07ecdea4d9e3d 100644 (file)
@@ -45,7 +45,7 @@ Point<dim> point(double x=0, double y=0, double z=0)
 
 // The simplest test case is to create a parallelepiped grid with a
 // number of subdivisions and output the result.
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void check (bool subdivide)
 {
   deallog << "dim " << dim << " spacedim " << spacedim << std::endl;
index 6442d0f978b2d6684fa6b18929cde36dc59d9401..3ce577124c95260b1cda67db855a3f3042f2fb68 100644 (file)
@@ -163,7 +163,7 @@ void generate_grid(Triangulation<3> &triangulation)
 /*
  * Print out the face vertices as well as the orientation of a match:
  */
-template<typename FaceIterator>
+template <typename FaceIterator>
 void print_match(const FaceIterator &face_1,
                  const FaceIterator &face_2,
                  const std::bitset<3> &orientation)
index 8b658cd48574a643f9196019bcf47691a5aa49f5..07e0dcadaa9d21d375b5464b4bf016cbc2ca530f 100644 (file)
@@ -180,7 +180,7 @@ void generate_grid(Triangulation<3> &triangulation, int orientation)
 /*
  * Print out the face vertices as well as the orientation of a match:
  */
-template<typename FaceIterator>
+template <typename FaceIterator>
 void print_match(const FaceIterator &face_1,
                  const FaceIterator &face_2,
                  const std::bitset<3> &orientation)
index abfed2663c05b029f40126e123a51a59cf0f1601..439e58152a503b2897a8a8d44f35c60e594e521b 100644 (file)
@@ -27,7 +27,7 @@
 #include <deal.II/grid/grid_tools.h>
 #include <deal.II/grid/grid_out.h>
 
-template<int dim>
+template <int dim>
 bool
 pred_mat_id(const typename Triangulation<dim>::active_cell_iterator &cell)
 {
index c937957b62d02ce162fd6a7963de2fbb099710f5..03591a141dd796244a9034cd7c7794ee380bd045 100644 (file)
@@ -35,7 +35,7 @@
 #include <vector>
 #include <cmath>
 
-template<int dim>
+template <int dim>
 bool
 pred_mat_id(const typename Triangulation<dim>::active_cell_iterator &cell)
 {
index 3ea31e69343e30c225be771cb14a1b101f449c98..540e289e8e93d168ce88bdd8fbde708913bebd73 100644 (file)
@@ -22,7 +22,7 @@
 #include <deal.II/grid/grid_tools.h>
 #include <deal.II/grid/grid_out.h>
 
-template<int dim>
+template <int dim>
 bool
 pred_mat_id(const typename Triangulation<dim>::active_cell_iterator &cell)
 {
index 8fb54f81874807706b4099b8a9c16db674b156e4..0249c5bec49c84d2ace0154ffa07d603b1b370e9 100644 (file)
@@ -22,7 +22,7 @@
 #include <deal.II/grid/grid_tools.h>
 #include <deal.II/grid/grid_out.h>
 
-template<int dim>
+template <int dim>
 bool
 pred_mat_id(const typename Triangulation<dim>::active_cell_iterator &cell)
 {
index c5be3e720972ecfe7b6aa23ed469a0220a11874f..efd55a8d9c9e97f5a8bbaa7d9ecb11d66f43d7ff 100644 (file)
 #include <fstream>
 #include <iomanip>
 
-template<int dim>
+template <int dim>
 Point<dim> trans_func(Point<dim> &p);
 
-template<>
+template <>
 Point<2> trans_func(Point<2> &p)
 {
   Point<2> r(p(0)+p(1)*p(1),p(1));
   return r;
 }
-template<>
+template <>
 Point<3> trans_func(Point<3> &p)
 {
   Point<3> r(p(0)+p(1)*p(1),p(1),p(2));
index ab3a8edf5fa903f3533fef777cec9ad4dfb61400..e55614e7437ec2ef9b0e52837332e8e7762347fb 100644 (file)
@@ -25,7 +25,7 @@
 #include <fstream>
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   // create 3 triangulations
index 5d591abf4238c5a7b5b44b0318f76d3b297dfd92..0e4b4f6854af8722f58451cccd470d9e6be6d541 100644 (file)
@@ -25,7 +25,7 @@
 #include <fstream>
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   // create 3 triangulations
index 6c5277aa5c4194190091d36f2f2480964025ced5..ac9a00505e8253e69691a1d4ab67343c1aa159e7 100644 (file)
@@ -25,7 +25,7 @@
 #include <fstream>
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   // create 3 triangulations
index 6a4dc1298295b162e14fab9c8d71504a1c1893ee..96369822eadfa401486ec945db8c3f9eb45c1e63 100644 (file)
@@ -27,7 +27,7 @@
 #define PRECISION 5
 
 
-template<int dim>
+template <int dim>
 void create_triangulation(const unsigned int,
                           Triangulation<dim> &)
 {
@@ -35,7 +35,7 @@ void create_triangulation(const unsigned int,
 }
 
 
-template<>
+template <>
 void create_triangulation(const unsigned int case_no,
                           Triangulation<2> &tria)
 {
@@ -61,7 +61,7 @@ void create_triangulation(const unsigned int case_no,
 }
 
 
-template<>
+template <>
 void create_triangulation(const unsigned int case_no,
                           Triangulation<3> &tria)
 {
@@ -83,7 +83,7 @@ void create_triangulation(const unsigned int case_no,
 }
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   Triangulation<dim> tria;
index 2f961b4c1f1cc4959185aedd04667f2eebe1d71e..233c279563ddbe226f76775b261bed38e0567ba1 100644 (file)
@@ -27,7 +27,7 @@
 #define PRECISION 5
 
 
-template<int dim>
+template <int dim>
 void create_triangulation(const unsigned int,
                           Triangulation<dim> &)
 {
@@ -35,7 +35,7 @@ void create_triangulation(const unsigned int,
 }
 
 
-template<>
+template <>
 void create_triangulation(const unsigned int case_no,
                           Triangulation<2> &tria)
 {
@@ -66,7 +66,7 @@ void create_triangulation(const unsigned int case_no,
 }
 
 
-template<>
+template <>
 void create_triangulation(const unsigned int case_no,
                           Triangulation<3> &tria)
 {
@@ -89,7 +89,7 @@ void create_triangulation(const unsigned int case_no,
 }
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   Triangulation<dim> tria;
index f16bae648b533477435218e6f9b71cf4320f20f3..f372cfa92bb8edcd42c15a4afd1db08ffef46dfe 100644 (file)
@@ -37,7 +37,7 @@
 
 std::ofstream logfile("output");
 
-template<int dim>
+template <int dim>
 void mesh_info(const Triangulation<dim> &tria)
 {
   deallog << "Mesh info:" << std::endl
index 4c443fc2d5d40e29464a6283762908b94e2cfe90..ac83568df9be361d6729051955b3166c3d51ec99 100644 (file)
@@ -84,7 +84,7 @@ void flatten_triangulation( Triangulation<dim> &tria_in, Triangulation<dim> &tri
 // eps image of the mesh so we can see the nodes are at the right
 // place.
 
-template<int dim>
+template <int dim>
 void mesh_info(const Triangulation<dim> &tria,
                const std::string        &filename)
 {
index 1d09dc900faa60b5dd81b167cd104afbc0ee93b9..ad4bb49c2ea0b50315e50dc1d1783ab8976ea57d 100644 (file)
@@ -29,7 +29,7 @@
 
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   for (unsigned int t=0; t<2; ++t)
index 44d61efc4d2eaa1bc609f1648391919445117efc..c3c4caccd550b36f4792e3805fac704530f9af5c 100644 (file)
@@ -47,21 +47,21 @@ void f_post_refinement ()
   return;
 }
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void f_pre_coarsening_on_cell (const typename Triangulation<dim, spacedim>::cell_iterator &)
 {
   ++signal_counter_pre_coarsening_on_cell;
   return;
 }
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void f_post_refinement_on_cell (const typename Triangulation<dim, spacedim>::cell_iterator &)
 {
   ++signal_counter_post_refinement_on_cell;
   return;
 }
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void f_copy (const Triangulation<dim, spacedim> &)
 {
   ++signal_counter_copy;
@@ -81,7 +81,7 @@ void f_any_change ()
 }
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void test()
 {
   signal_counter_create = 0;
index d0bf2b4e07d521a02ad8333af5ee2c669639e360..7bd6bb1ada24ff6027513db16d4ef2dff505591e 100644 (file)
@@ -31,7 +31,7 @@
  * when this function is called for invalid input.
  */
 
-template<int dim>
+template <int dim>
 void check_parallelepiped (std::ofstream &logfile)
 {
   // Data structure defining dim coordinates that make up a
index 2f3ce273d3ada73c349b49ef6c15862cbfc0b60f..bb94b4b8d86c3e5696e214925460fa032c3a03c9 100644 (file)
@@ -31,7 +31,7 @@
  * this function is called for invalid input.
  */
 
-template<int dim>
+template <int dim>
 void check_parallelepiped (std::ofstream &logfile)
 {
   // Data structure defining dim coordinates that make up a
index b18520f2ecac69d991f94fb3d2a153f9cbc176c9..4bb3c9323097981d10a848aa2c09886633b3fc74 100644 (file)
@@ -34,7 +34,7 @@
 /**
  * Check if user pointers are the same as entered below
  */
-template<int dim>
+template <int dim>
 void
 check_user_pointers(Triangulation<dim> &tr)
 {
@@ -83,7 +83,7 @@ check_user_pointers(Triangulation<dim> &tr)
 /**
  * Check if user indices are the same as entered below
  */
-template<int dim>
+template <int dim>
 void
 check_user_indices(Triangulation<dim> &tr)
 {
@@ -130,7 +130,7 @@ check_user_indices(Triangulation<dim> &tr)
 }
 
 
-template<int dim>
+template <int dim>
 void
 user_pointers(Triangulation<dim> &tr)
 {
@@ -192,7 +192,7 @@ user_pointers(Triangulation<dim> &tr)
 }
 
 
-template<int dim>
+template <int dim>
 void
 user_indices(Triangulation<dim> &tr)
 {
index 01345a4556f0c54b51820c6d918f6bbcedcb610b..f02e0b6f0791e77f6b08a34251f6fefbed40d653 100644 (file)
@@ -38,7 +38,7 @@
 #include <cstdlib>
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   Triangulation<dim> triangulation (Triangulation<dim>::limit_level_difference_at_vertices);
index 08248a594babb5bc4499ad99e256d3e9a9374c68..24d4d3097ab3f0b17f9b98fa21fa051868a47e1e 100644 (file)
@@ -77,7 +77,7 @@ const double eps = 1e-10;
 
 using namespace dealii;
 
-template<int dim>
+template <int dim>
 void test2cells(const unsigned int p1=2,
                 const unsigned int p2=1)
 {
index 0790546d9258c5789543295d9299b86c157ee2d6..532a4896a13412f560759863716a90de4305a12e 100644 (file)
@@ -102,7 +102,7 @@ struct less_than_key
 //  |-----| 2  |
 //  |1 |1 |    |
 //  ------------
-template<int dim>
+template <int dim>
 void test2cells(const FiniteElement<dim> &fe_0,
                 const FiniteElement<dim> &fe_1,
                 const FiniteElement<dim> &fe_2,
index 4875357334b85c7efeb315da27aa84fd03f783d4..3e92b7444689373878096d029a80fce0edb77a3c 100644 (file)
@@ -28,7 +28,7 @@
 
 using namespace dealii;
 
-template<int dim>
+template <int dim>
 void test(const bool apply_constrains, const unsigned int hp)
 {
   Triangulation<dim>   triangulation;
index a08b8ad04306f57dc416e3d71ab036c043c075e1..5cbf78da2105f41545a15b7ce43ede3d15905dd4 100644 (file)
@@ -44,7 +44,7 @@
 #include <fstream>
 
 
-template<int dim>
+template <int dim>
 class MySquareFunction : public Function<dim>
 {
 public:
index c1868c2d56da89b405637315b017fa0e194581a0..bdc832a32976485d3f6fc8117c4170e8fa04c3a6 100644 (file)
@@ -42,7 +42,7 @@
 #include <fstream>
 
 
-template<int dim>
+template <int dim>
 class MySquareFunction : public Function<dim>
 {
 public:
index 88164c484dfd95dd867739f7d9a85e569260c8ab..c18639ee32ab097c5fd2d2cf369d66d9dccaebf9 100644 (file)
@@ -38,7 +38,7 @@
 #include <cstdlib>
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   Triangulation<dim> triangulation;
index 028dcde3883c04e8a217fd3d74e5d12a58faacd0..b769b9ef8707e036ae817596e56371314f229106 100644 (file)
@@ -52,7 +52,7 @@ public:
 };
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   // create 2 triangulations with the
index 37cecfde209da0c3841383ebe9f73c237a837edf..e1a78a7d7f28cb32996dbee05e398dc9c98b5d6d 100644 (file)
@@ -61,7 +61,7 @@ public:
 };
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   HyperBallBoundary<dim> boundary;
index 2e89124158a85ddfd2644726e938d77f3fe3d84d..c09a59ec0c923d858a4627cd16072036ea428f88 100644 (file)
@@ -52,7 +52,7 @@ public:
 };
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   // create 2 triangulations with the
index e26239fd708bb6c04c0cf5545bf9a52d6c847d88..1426ba7677fa367b5806c2ccee98225d76808a5c 100644 (file)
@@ -42,7 +42,7 @@
 
 // a linear function that should be transferred exactly with Q1 and Q2
 // elements
-template<int dim>
+template <int dim>
 class MyFunction : public Function<dim>
 {
 public:
index 278c4fa0ffa64d03a01fd36eb3d3054c5b974149..4f1f71c25e8822296bcf5a8c02282469488cbe4e 100644 (file)
@@ -46,7 +46,7 @@
 // - FE_Q_Hierarchical
 // - manual interpolation as there is no general interpolation implemented
 //   for this FE currently, thus VectorTools::interpolate can't be used.
-template<int dim>
+template <int dim>
 class MyFunction : public Function<dim>
 {
 public:
index 3a701c9866f57b52cb5ae40c8d46afb9416ad806..d59da4e57a435beb5cfe59395ec58eac699ed048 100644 (file)
@@ -474,7 +474,7 @@ namespace Step27
   std::pair<bool,unsigned int>
   predicate_ind(const TableIndices<dim> &ind);
 
-  template<>
+  template <>
   std::pair<bool,unsigned int>
   predicate_ind<2>(const TableIndices<2> &ind)
   {
index b725dcff25590637f2739217244832fd883b56bf..b59aa7ddd9f43ea9fd043853fad7226f15250759 100644 (file)
@@ -44,7 +44,7 @@
 #include <fstream>
 
 
-template<int dim>
+template <int dim>
 class MySquareFunction : public Function<dim>
 {
 public:
index 40e630ba6f4ec8258052ae93ced1310720f6b13a..24d3bccb9c6eb3982ef2dee0cf0df9d4f863c0da 100644 (file)
@@ -44,7 +44,7 @@
 #include <fstream>
 
 
-template<int dim>
+template <int dim>
 class MySquareFunction : public Function<dim>
 {
 public:
index d211a985879aa4c696579ed05c4c5eeb7fb90353..b4de1c6e50ab357de406e364cd89be6af819e5b1 100644 (file)
@@ -44,7 +44,7 @@
 #include <fstream>
 
 
-template<int dim>
+template <int dim>
 class MySquareFunction : public Function<dim>
 {
 public:
index 720c084ac159997e03d49059456132658c2007cc..8afb6cadb094675c8d5b2d91eaca3b713daf2718 100644 (file)
@@ -44,7 +44,7 @@
 #include <fstream>
 
 
-template<int dim>
+template <int dim>
 class MySquareFunction : public Function<dim>
 {
 public:
index 3201de1c9b444f003f35a016ab306a2c3d761072..1febfbd99e6e3d4eb39904abaddb462b583d4fff 100644 (file)
@@ -44,7 +44,7 @@
 #include <fstream>
 
 
-template<int dim>
+template <int dim>
 class MySquareFunction : public Function<dim>
 {
 public:
index 89315fe5a0dd7cedd0ae22e4a17b819955346a7c..6fef7a5b5ffb3bf7763d79369a90f0c5afe559ec 100644 (file)
@@ -44,7 +44,7 @@
 #include <fstream>
 
 
-template<int dim>
+template <int dim>
 class MySquareFunction : public Function<dim>
 {
 public:
index 6ac3dace1a0ffe840a9d0a5ffbc38967ccc4ce68..3449713781f49bdabc7afe1b9cd0c910d452de20 100644 (file)
@@ -44,7 +44,7 @@
 #include <fstream>
 
 
-template<int dim>
+template <int dim>
 class MySquareFunction : public Function<dim>
 {
 public:
index 72edad087c2b34a73a87c60afe0a70387480d814..ad78fd930c9354d0a795908bb4de45d966762920 100644 (file)
@@ -44,7 +44,7 @@
 #include <fstream>
 
 
-template<int dim>
+template <int dim>
 class MySquareFunction : public Function<dim>
 {
 public:
index d29ad8d73dde07dab3ee7aa3bfc59086ce7df0c5..288f973be3757ee63b5afe4558aa823297578d7b 100644 (file)
@@ -44,7 +44,7 @@
 #include <fstream>
 
 
-template<int dim>
+template <int dim>
 class MySquareFunction : public Function<dim>
 {
 public:
index d1959ef2f669be34a1920fabd12074c2697680d6..00cad01c1b238722f34bc5fcb6d34e7cb0a1efd3 100644 (file)
@@ -44,7 +44,7 @@
 #include <fstream>
 
 
-template<int dim>
+template <int dim>
 class MySquareFunction : public Function<dim>
 {
 public:
index b62aef9f2d283e589a4d862fe335a178ca1cba1a..8b79c0443920ff0698a53dee0b26ef82b362ca94 100644 (file)
@@ -441,7 +441,7 @@ void RHSIntegrator<dim>::face(MeshWorker::DoFInfo<dim> &,
 /*
  * Main class
  */
-template<int dim>
+template <int dim>
 class MeshWorkerConstraintMatrixTest
 {
 public:
@@ -476,7 +476,7 @@ private:
 };
 
 
-template<int dim>
+template <int dim>
 MeshWorkerConstraintMatrixTest<dim>::MeshWorkerConstraintMatrixTest(const FiniteElement<dim> &fe) :
   mapping(),
   dof_handler(triangulation),
@@ -499,7 +499,7 @@ MeshWorkerConstraintMatrixTest<dim>::~MeshWorkerConstraintMatrixTest ()
 }
 
 
-template<int dim>
+template <int dim>
 void MeshWorkerConstraintMatrixTest<dim>::setup_system()
 {
   dof_handler.distribute_dofs(fe);
@@ -534,7 +534,7 @@ void MeshWorkerConstraintMatrixTest<dim>::setup_system()
 /*
  * Assemble with SystemSimple
  */
-template<int dim>
+template <int dim>
 void MeshWorkerConstraintMatrixTest<dim>::assemble_system_MeshWorker()
 {
 
@@ -567,7 +567,7 @@ void MeshWorkerConstraintMatrixTest<dim>::assemble_system_MeshWorker()
 /*
  * Assemble matrix and vector seperately
  */
-template<int dim>
+template <int dim>
 void MeshWorkerConstraintMatrixTest<dim>::assemble_MeshWorker()
 {
 
@@ -634,7 +634,7 @@ void MeshWorkerConstraintMatrixTest<dim>::createInhomConstraints()
 }
 
 
-template<int dim>
+template <int dim>
 void MeshWorkerConstraintMatrixTest<dim>::run()
 {
   setup_system();
index 8d8ce01cb7a05bc70cca32cc4cb274a17e5af170..184eabb4b7cc16cf602ae306a571c209abc122cf 100644 (file)
@@ -156,7 +156,7 @@ test_mesh(DoFHandler<dim> &mgdofs)
 }
 
 
-template<int dim>
+template <int dim>
 void
 test(const FiniteElement<dim> &fe)
 {
index 1a80d3cd5bafdd6cb33d0fc302d854d7af5051b8..1df185a06e50f8fdd9052a9d3ef90463b44d592b 100644 (file)
@@ -129,7 +129,7 @@ test_mesh(DoFHandler<dim> &mgdofs)
 }
 
 
-template<int dim>
+template <int dim>
 void
 test(const FiniteElement<dim> &fe)
 {
index ca82779f215f1740320455765efc0cdfd7d6b5b1..c002014627b68ef31b118f00a33bcddc75210fab 100644 (file)
@@ -165,7 +165,7 @@ test_simple(DoFHandler<dim> &mgdofs)
 }
 
 
-template<int dim>
+template <int dim>
 void
 test(const FiniteElement<dim> &fe)
 {
index e96015d877e1a02dc03b611400a9d20aec7e48d7..489dcf2a09676725974f606e18b0fe9cfe467b90 100644 (file)
@@ -257,7 +257,7 @@ test_simple(DoFHandler<dim> &mgdofs)
 }
 
 
-template<int dim>
+template <int dim>
 void
 test(const FiniteElement<dim> &fe)
 {
index 44d388f713a5073b0537eeea6a5cf6d009b075e2..1b325dcc4441ffc9965708aa6623ecec667df038 100644 (file)
@@ -270,7 +270,7 @@ test_simple(DoFHandler<dim> &mgdofs)
 }
 
 
-template<int dim>
+template <int dim>
 void
 test(const FiniteElement<dim> &fe)
 {
index 82cc1f00a8a689696feda269cbf79fdd085e2d38..806a9154cc78f35508c36599af249722707dfa1d 100644 (file)
@@ -166,7 +166,7 @@ test_simple(DoFHandler<dim> &dofs, bool faces)
 }
 
 
-template<int dim>
+template <int dim>
 void
 test(const FiniteElement<dim> &fe)
 {
index 1115012d6b9983ff54b9c41663bf9a0365950f24..8d6a641254d0de9fd8303cfa9a3e63da3385fc19 100644 (file)
@@ -26,7 +26,7 @@
 #include <fstream>
 
 
-template<typename VectorType>
+template <typename VectorType>
 void test (const FilteredMatrix<VectorType> &M)
 {
   deallog << "Iterator";
index 169f076f61fd66009beafe926067a579ee53db1e..7a14942909301af1d10233983c2fcce593e35715 100644 (file)
@@ -20,7 +20,7 @@
 #include <deal.II/lac/full_matrix.h>
 #include <deal.II/lac/vector.h>
 
-template<typename number>
+template <typename number>
 void
 checkVmult(FullMatrix<number> &A, Vector<number> &V,
            bool expect_constrained_source = false)
index 950a627cf74c8d137c10f6f693fb89248c22c2fe..75f3170622ecd581e4735d6eae3b4005445f1b63 100644 (file)
@@ -20,7 +20,7 @@
 #include <deal.II/lac/full_matrix.h>
 #include <deal.II/lac/vector.h>
 
-template<typename number>
+template <typename number>
 void
 checkTvmult(FullMatrix<number> &A, Vector<number> &V,
             bool expect_constrained_source = false)
index 9c6b31652ccc595578a08fc729ef7f74e1f869f7..63ab2755f5ab28f75feb7b6c958f923477f3a974 100644 (file)
@@ -20,7 +20,7 @@
 #include <deal.II/lac/full_matrix.h>
 #include <deal.II/lac/vector.h>
 
-template<typename number>
+template <typename number>
 void
 checkVmult_Add(FullMatrix<number> &A, Vector<number> &V,
                bool expect_constrained_source = false)
index c152a832286d98cac772794bcc76863ee0df0ec0..893b5fb921ebdea396041a775dd469ca02a39136 100644 (file)
@@ -20,7 +20,7 @@
 #include <deal.II/lac/full_matrix.h>
 #include <deal.II/lac/vector.h>
 
-template<typename number>
+template <typename number>
 void
 checkTvmult_Add(FullMatrix<number> &A, Vector<number> &V,
                 bool expect_constrained_source = false)
index 077471942485ea13426b438eda4d299836088284..13c908d53d9a65741e5c5fc06d788d6e2f199f21 100644 (file)
@@ -20,7 +20,7 @@
 #include <deal.II/lac/full_matrix.h>
 #include <deal.II/lac/vector.h>
 
-template<typename number>
+template <typename number>
 void
 checkApply_Constraints(FullMatrix<number> &A, Vector<number> &V,
                        bool matrix_is_symmetric = false)
index 6c29b79706fe61449c7dae168bc9fa5a49f28c32..12dc74b716a77a39223c675e768b27c4761d0c0e 100644 (file)
@@ -22,7 +22,7 @@
 #include <deal.II/lac/solver_gmres.h>
 #include <deal.II/lac/precondition.h>
 
-template<class NUMBER>
+template <class NUMBER>
 void output_eigenvalues(const std::vector<NUMBER> &eigenvalues,const std::string &text)
 {
   deallog<< text;
index 21b0797eec78df65cc8ecfe41f682a96d07b545e..0f72cbd1575f93359b887f90106b0dfc59b8e671 100644 (file)
@@ -26,7 +26,7 @@
 #include <iomanip>
 #include <cmath>
 
-template<typename number>
+template <typename number>
 void
 check_vmult()
 {
index 5a24d1d79208609267d2ce2b1c891fd594667337..6d84cf0edad082816c0528685b9502c80b0971a0 100644 (file)
@@ -27,7 +27,7 @@
 #include <iomanip>
 #include <cmath>
 
-template<typename number>
+template <typename number>
 void
 check_vmult()
 {
index 3d3209215713c10c8755f97ab4b86f9188c7dac7..1480ae2379a995b6078a5d9f1e20ab73ab0e3756 100644 (file)
@@ -27,7 +27,7 @@
 #include <iomanip>
 #include <cmath>
 
-template<typename number>
+template <typename number>
 void
 check_vmult()
 {
index 707aaee836d18a743a6029075a37da5510dc7d53..075e8ac1da36c640029ae9fb71673f520405ee41 100644 (file)
@@ -27,7 +27,7 @@
 #include <iomanip>
 #include <cmath>
 
-template<typename number>
+template <typename number>
 void
 check_vmult()
 {
index 45a082ca60c5580f9d3f593c80a88667c297cc3d..5cd2420d243d71ef9aa51ff43abe9e40d239eef3 100644 (file)
@@ -27,7 +27,7 @@
 #include <iomanip>
 #include <cmath>
 
-template<typename number>
+template <typename number>
 void
 check_vmult()
 {
index 0cc70115ca0fe97b95c9abf83bcb905f8e75bb70..71ea2c5753f6bd341ab84ae2a3927adf2db674b9 100644 (file)
@@ -31,7 +31,7 @@
 #include <iomanip>
 #include <cmath>
 
-template<typename number>
+template <typename number>
 void
 check_vmult()
 {
index 36787e1e17b42f763316bad3d311ef1a8d4b4e7e..47a086418258df0f7509222553e9377e21777ec7 100644 (file)
@@ -90,25 +90,25 @@ public:
     return 1;
   };
 
-  template<typename OutVector, typename InVector>
+  template <typename OutVector, typename InVector>
   void vmult(OutVector &, const InVector &) const
   {
     deallog << "MyMatrix3::vmult" << std::endl;
   }
 
-  template<typename OutVector, typename InVector>
+  template <typename OutVector, typename InVector>
   void Tvmult(OutVector &, const InVector &) const
   {
     deallog << "MyMatrix3::Tvmult" << std::endl;
   }
 
-  template<typename OutVector, typename InVector>
+  template <typename OutVector, typename InVector>
   void vmult_add(OutVector &, const InVector &) const
   {
     deallog << "MyMatrix3::vmult_add" << std::endl;
   }
 
-  template<typename OutVector, typename InVector>
+  template <typename OutVector, typename InVector>
   void Tvmult_add(OutVector &, const InVector &) const
   {
     deallog << "MyMatrix3::Tvmult_add" << std::endl;
@@ -127,25 +127,25 @@ public:
     return 1;
   };
 
-  template<typename OutVector, typename InVector>
+  template <typename OutVector, typename InVector>
   void vmult(OutVector &, const InVector &, bool = true) const
   {
     deallog << "MyMatrix4::vmult" << std::endl;
   }
 
-  template<typename OutVector, typename InVector>
+  template <typename OutVector, typename InVector>
   void Tvmult(OutVector &, const InVector &, bool = true) const
   {
     deallog << "MyMatrix4::Tvmult" << std::endl;
   }
 
-  template<typename OutVector, typename InVector>
+  template <typename OutVector, typename InVector>
   void vmult_add(OutVector &, const InVector &, bool = true) const
   {
     deallog << "MyMatrix4::vmult_add" << std::endl;
   }
 
-  template<typename OutVector, typename InVector>
+  template <typename OutVector, typename InVector>
   void Tvmult_add(OutVector &, const InVector &, bool = true) const
   {
     deallog << "MyMatrix4::Tvmult_add" << std::endl;
@@ -164,25 +164,25 @@ public:
     return 1;
   };
 
-  template<typename number>
+  template <typename number>
   void vmult(Vector<number> &, const Vector<number> &, bool = true) const
   {
     deallog << "MyMatrix5::vmult" << std::endl;
   }
 
-  template<typename number>
+  template <typename number>
   void Tvmult(Vector<number> &, const Vector<number> &, bool = true) const
   {
     deallog << "MyMatrix5::Tvmult" << std::endl;
   }
 
-  template<typename number>
+  template <typename number>
   void vmult_add(Vector<number> &, const Vector<number> &, bool = true) const
   {
     deallog << "MyMatrix5::vmult_add" << std::endl;
   }
 
-  template<typename number>
+  template <typename number>
   void Tvmult_add(Vector<number> &, const Vector<number> &, bool = true) const
   {
     deallog << "MyMatrix5::Tvmult_add" << std::endl;
@@ -201,19 +201,19 @@ public:
     return 1;
   };
 
-  template<typename number, typename number2>
+  template <typename number, typename number2>
   void vmult(Vector<number> &, const Vector<number2> &, bool = true) const
   {
     deallog << "MyMatrix6::vmult" << std::endl;
   }
 
-  template<typename number, typename number2>
+  template <typename number, typename number2>
   void Tvmult(Vector<number> &, const Vector<number2> &, bool = true) const
   {
     deallog << "MyMatrix6::Tvmult" << std::endl;
   }
 
-  template<typename number, typename number2>
+  template <typename number, typename number2>
   void vmult_add(Vector<number> &, const Vector<number2> &, bool = true) const
   {
     deallog << "MyMatrix6::vmult_add" << std::endl;
index 0a57a1c989ae276329841532537552f98fb595be..bc59c054bb3e199f05d0e58d9145896a719b2d34 100644 (file)
@@ -50,8 +50,8 @@
 using namespace dealii;
 
 
-template<class PRECONDITIONER, typename MatrixType, typename VectorType,
-         class ADDITIONAL_DATA = typename PRECONDITIONER::AdditionalData>
+template <class PRECONDITIONER, typename MatrixType, typename VectorType,
+          class ADDITIONAL_DATA = typename PRECONDITIONER::AdditionalData>
 void
 test_preconditioner_block (const MatrixType &A,
                            const VectorType &b,
@@ -88,7 +88,7 @@ test_preconditioner_block (const MatrixType &A,
 // For Vector <double>
 // Cannot use more generic function as Vector <double>
 // does not define vector_type
-template<class PRECONDITIONER>
+template <class PRECONDITIONER>
 void
 test_preconditioner (const SparseMatrix<double> &A,
                      const Vector<double> &b,
@@ -130,7 +130,7 @@ test_preconditioner (const SparseMatrix<double> &A,
   }
 }
 
-template<typename SolverType>
+template <typename SolverType>
 void
 test_solver (const SparseMatrix<double> &A,
              const Vector<double> &b)
@@ -194,14 +194,14 @@ public:
                               matrix.n_block_cols());
   }
 
-  template<typename VectorType>
+  template <typename VectorType>
   void
   vmult(VectorType &dst, const VectorType &src) const
   {
     dst = src;
   }
 
-  template<typename VectorType>
+  template <typename VectorType>
   void
   Tvmult(VectorType &dst, const VectorType &src) const
   {
index 813a9c088f5a37be80b8b2ef4e1f302a49d803ef..007b5210aa3e3032b3e8a1a92a881d69ec00a4c8 100644 (file)
@@ -31,7 +31,7 @@
 
 using namespace dealii;
 
-template<typename VECTOR>
+template <typename VECTOR>
 void
 print (const VECTOR &vec)
 {
@@ -43,8 +43,8 @@ print (const VECTOR &vec)
 }
 
 
-template<class PRECONDITIONER, class MATRIX, class VECTOR,
-         class ADDITIONAL_DATA = typename PRECONDITIONER::AdditionalData>
+template <class PRECONDITIONER, class MATRIX, class VECTOR,
+          class ADDITIONAL_DATA = typename PRECONDITIONER::AdditionalData>
 void
 test_preconditioner (const MATRIX &A,
                      const VECTOR &b,
@@ -145,7 +145,7 @@ test_preconditioner (const MATRIX &A,
   deallog.pop();
 }
 
-template<class SOLVER, class MATRIX, class VECTOR>
+template <class SOLVER, class MATRIX, class VECTOR>
 void
 test_solver (const MATRIX &A,
              const VECTOR &b)
index 9f5a403bf71172d5ec1e221a581d10d64f01da4b..c482e6295c99d1f17b54e9c4f26f2670e18670e8 100644 (file)
@@ -37,7 +37,7 @@
 
 using namespace dealii;
 
-template<typename VECTOR>
+template <typename VECTOR>
 void
 print (const VECTOR &vec)
 {
@@ -49,8 +49,8 @@ print (const VECTOR &vec)
 }
 
 
-template<class PRECONDITIONER, class MATRIX, class VECTOR,
-         class ADDITIONAL_DATA = typename PRECONDITIONER::AdditionalData>
+template <class PRECONDITIONER, class MATRIX, class VECTOR,
+          class ADDITIONAL_DATA = typename PRECONDITIONER::AdditionalData>
 void
 test_preconditioner (const MATRIX &A,
                      const VECTOR &b,
@@ -151,7 +151,7 @@ test_preconditioner (const MATRIX &A,
   deallog.pop();
 }
 
-template<class SOLVER, class MATRIX, class VECTOR>
+template <class SOLVER, class MATRIX, class VECTOR>
 void
 test_solver (const MATRIX &A,
              const VECTOR &b)
index e034b0e77e1613d1c1ff4fc8e12c2425646c05ec..c564cff57e868d74ece4409e890cba1583683c38 100644 (file)
@@ -48,7 +48,7 @@
 
 using namespace dealii;
 
-template<int dim>
+template <int dim>
 void build_matrix_vector(TrilinosWrappers::BlockSparseMatrix &matrix,
                          TrilinosWrappers::MPI::BlockVector       &vector,
                          const FE_Q<dim>                     &fe_test,
index 4b9c3394e93b30f4dc4b05f4d89202ed6f90aaa3..2f670b7db32cf04d8f54eff36e0d9273612a5fa9 100644 (file)
@@ -50,7 +50,7 @@
 
 using namespace dealii;
 
-template<int dim>
+template <int dim>
 void build_matrix_vector(TrilinosWrappers::BlockSparseMatrix &matrix,
                          TrilinosWrappers::MPI::BlockVector  &vector,
                          const FE_Q<dim>                     &fe_test,
index 1026d1d1fa53f58cba5d6d8dd856a973b38b3638..0d3aa85d3b5b2257a47594469f82329c429ee349 100644 (file)
@@ -40,7 +40,7 @@
 #include <fstream>
 
 
-template<int dim>
+template <int dim>
 class MySquareFunction : public Function<dim>
 {
 public:
index 460537aadbf7600fe861b29c8937852f30f18b52..713a7e1a735b9c8fb29775864f09b3c243b12397 100644 (file)
@@ -21,7 +21,7 @@
 #include <deal.II/lac/full_matrix.h>
 #include <deal.II/lac/vector.h>
 
-template<typename number>
+template <typename number>
 void
 checkConstructor1()
 {
index a8604dccb9eec6ef08173cfb7054d726cc9bb3bd..6c67b97da73f1c5d9ffdd9fc0fc0fc7b64c7ed5a 100644 (file)
@@ -21,7 +21,7 @@
 #include <deal.II/lac/full_matrix.h>
 #include <deal.II/lac/vector.h>
 
-template<typename number>
+template <typename number>
 void
 checkConstructor2(FullMatrix<number> &A)
 {
index 8484ac00cb09712234ef0bb2b5d775d9bedec28d..933cbf8294593d2290d77fe56eaf86039845d10e 100644 (file)
@@ -21,7 +21,7 @@
 #include <deal.II/lac/full_matrix.h>
 #include <deal.II/lac/vector.h>
 
-template<typename number>
+template <typename number>
 void
 checkConstructor3(char *name)
 {
index 085d9d2556b65ee09e7f12c900af151f210d1489..a341c2bddbe02d830014cbb0b45dde5afec9ed9d 100644 (file)
@@ -21,7 +21,7 @@
 #include <deal.II/lac/full_matrix.h>
 #include <deal.II/lac/vector.h>
 
-template<typename number>
+template <typename number>
 void
 checkConstructor4(const FullMatrix<number> &A, char *name)
 {
index e26ce37a61bf3eb1437d47403597eecce177822d..8ede99d41e70a5b95da0d7dc29fa5d72b626d4c9 100644 (file)
@@ -21,7 +21,7 @@
 #include <deal.II/lac/full_matrix.h>
 #include <deal.II/lac/vector.h>
 
-template<typename number>
+template <typename number>
 void
 checkVmult(FullMatrix<number> &A, Vector<number> &V, char *name =
              "Test Matrix")
index 91845f6cead56720e774b0155119312fc1dbd227..656d2225587482f57c52e03b5fc27300c4921755 100644 (file)
@@ -21,7 +21,7 @@
 #include <deal.II/lac/full_matrix.h>
 #include <deal.II/lac/vector.h>
 
-template<typename number>
+template <typename number>
 void
 checkTvmult(FullMatrix<number> &A, Vector<number> &V, char *name =
               "Test Matrix")
index ee7ccd75ddcfe766f14593bb89a8c96db6a22953..535665fba88c45de3e9a0d8f0835f7c11410a3d7 100644 (file)
@@ -21,7 +21,7 @@
 #include <deal.II/lac/full_matrix.h>
 #include <deal.II/lac/vector.h>
 
-template<typename number>
+template <typename number>
 void
 checkTvmult_add(FullMatrix<number> &A, Vector<number> &V, char *name =
                   "Test Matrix")
index dfcf40229f578d633a864bf388d33776a680ea03..fc934306cb2f6a0f1a673d94716b89d9093f6431 100644 (file)
@@ -21,7 +21,7 @@
 #include <deal.II/lac/full_matrix.h>
 #include <deal.II/lac/vector.h>
 
-template<typename number>
+template <typename number>
 void
 checkVmult_add(FullMatrix<number> &A, Vector<number> &V, char *name =
                  "Test Matrix")
index 0f318fc8d8fa86d22ca880cc9ef4d05fac997d07..2f4c27eb3a017d7a0d58d65cee1077da1bc1c6be 100644 (file)
@@ -21,7 +21,7 @@
 #include <deal.II/lac/full_matrix.h>
 #include <deal.II/lac/vector.h>
 
-template<typename number>
+template <typename number>
 void
 checkClear(FullMatrix<number> &A)
 {
index e4ba0661742d274b76e1681b9d03e4c4423434df..c9d06124a1ad96a2464f669cf175112036595732 100644 (file)
@@ -21,7 +21,7 @@
 #include <deal.II/lac/full_matrix.h>
 #include <deal.II/lac/vector.h>
 
-template<typename number>
+template <typename number>
 void
 checkAssign(FullMatrix<number> &A, FullMatrix<number> &B)
 {
index a2da7f85fa04ea82d04669ef3d39c5155ce5ff2a..c3541390f27ffc152165bb10919e6d5a3a3c8ab2 100644 (file)
@@ -7,7 +7,7 @@
  * The diagonal is scaled to 1, resulting in an effective mesh width of 1/2.
  */
 
-template<typename number>
+template <typename number>
 class QuickMatrix
 {
 public:
@@ -27,13 +27,13 @@ protected:
 };
 
 
-template<typename number>
+template <typename number>
 QuickMatrix<number>::QuickMatrix(unsigned int nx, unsigned int ny)
   :
   nx(nx), ny(ny)
 {}
 
-template<typename number>
+template <typename number>
 template <typename number2>
 void
 QuickMatrix<number>::vmult(Vector<number2> &d,
index a1e64bebb5c0c1cc1aa28247539ab9ca75b55259..582bc7a4a41f07cde34c927753d6595362e11736 100644 (file)
@@ -33,7 +33,7 @@
 #include <deal.II/lac/solver_qmrs.h>
 #include <deal.II/lac/precondition.h>
 
-template<typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
+template <typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
 void
 check_solve (SolverType         &solver,
              const MatrixType   &A,
@@ -53,7 +53,7 @@ check_solve (SolverType         &solver,
     }
 }
 
-template<typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
+template <typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
 void
 check_Tsolve (SolverType         &solver,
               const MatrixType   &A,
index e56c313920a70c3dee4ba4a286750ac7f414289c..631cdea223435a5b6b9a1e27f0160cec2b8fe790 100644 (file)
@@ -32,7 +32,7 @@
 #include <deal.II/lac/precondition.h>
 #include <deal.II/base/point.h>
 
-template<typename SolverType>
+template <typename SolverType>
 void test()
 {
   const unsigned int size = 3;
index 42f765fac88f4d89fcaf394bfedc1dece1a9ff25..1154d8e01345c2fbaa808a57027405132fe05960 100644 (file)
@@ -33,7 +33,7 @@
 #include <deal.II/lac/solver_relaxation.h>
 #include <deal.II/lac/precondition.h>
 
-template<typename MatrixType, typename VectorType, class PRECONDITION>
+template <typename MatrixType, typename VectorType, class PRECONDITION>
 void
 check_solve (SolverControl       &solver_control,
              const MatrixType    &A,
index 9686acfb77fcd3fe2f6693b9e71e971a85af377d..962f1104fabe048799f06cc4ddec10605950710e 100644 (file)
@@ -33,7 +33,7 @@
 #include <deal.II/lac/solver_relaxation.h>
 #include <deal.II/lac/precondition.h>
 
-template<typename MatrixType, typename VectorType, class PRECONDITION>
+template <typename MatrixType, typename VectorType, class PRECONDITION>
 void
 check_solve (SolverControl       &solver_control,
              const MatrixType    &A,
index 85cb45dda0768ec79eab4c669f6ab23cd55b6a2e..c6afa9fbed1d9fee52d4e94c9dafbfaa9536fd4d 100644 (file)
@@ -33,7 +33,7 @@
 #include <deal.II/lac/solver_relaxation.h>
 #include <deal.II/lac/precondition.h>
 
-template<typename MatrixType, typename VectorType, class PRECONDITION>
+template <typename MatrixType, typename VectorType, class PRECONDITION>
 void
 check_solve (SolverControl       &solver_control,
              const MatrixType    &A,
index e710158f385fc1918d3930b5188b2f05efcfc9ad..e2ce122fdaebfbd9ae086dc53fc8315219a47d36 100644 (file)
@@ -33,7 +33,7 @@
 #include <deal.II/lac/solver_relaxation.h>
 #include <deal.II/lac/precondition.h>
 
-template<typename MatrixType, typename VectorType, class PRECONDITION>
+template <typename MatrixType, typename VectorType, class PRECONDITION>
 void
 check_solve (SolverControl       &solver_control,
              const MatrixType    &A,
index 2145fccbacc74f15985b4322b0815ad0505e3da4..7492218186a8e2c77fbfc3ae7eb64bcfce20af3c 100644 (file)
@@ -39,7 +39,7 @@
 #include <deal.II/lac/solver_qmrs.h>
 #include <deal.II/lac/precondition.h>
 
-template<typename SolverType, typename MatrixType, typename VectorType>
+template <typename SolverType, typename MatrixType, typename VectorType>
 void
 check_solve (const MatrixType &A,
              VectorType       &u,
index 6d216d6e5bb8d98cb1f75708141c0a4be1a400e7..811681a7907dfee0148ac8ee63dfc19eea1f7f4d 100644 (file)
@@ -56,7 +56,7 @@ SolverControl::State monitor_mean (const unsigned int    iteration,
 
 
 
-template<typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
+template <typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
 void
 check_solve (SolverType         &solver,
              const MatrixType   &A,
index c7e0cdbfda143b7d17ae8ea61f076754500f90a2..4e596fc78c8c5b2fa990d9ea69e6070fd8058836 100644 (file)
@@ -57,7 +57,7 @@ SolverControl::State monitor_mean (const unsigned int    iteration,
 
 
 
-template<typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
+template <typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
 void
 check_solve (SolverType         &solver,
              const MatrixType   &A,
index 81b7ee88418f8c70da0f104ca1d605886940dc34..205a50da0a85d53da2db0d7eb042520c88c5b334 100644 (file)
@@ -31,7 +31,7 @@
 #include <deal.II/lac/solver_relaxation.h>
 #include <deal.II/lac/precondition.h>
 
-template<typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
+template <typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
 double
 check_solve (SolverType         &solver,
              const MatrixType   &A,
index 3883ce0689bb962cc4f999ab016ac629295cba67..e47da4000794e9304014072eeed39254bdb6c0ca 100644 (file)
@@ -32,7 +32,7 @@
 #include <deal.II/lac/precondition_block.h>
 #include <deal.II/lac/relaxation_block.h>
 
-template<typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
+template <typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
 double
 check_solve (SolverType         &solver,
              const MatrixType   &A,
index a1f83fdd91f394b3a4c7b749fee7dc0f755b0a27..ce9a53104c86f3fa74eda77955bee73ba26aee9b 100644 (file)
@@ -33,7 +33,7 @@
 #include <deal.II/lac/precondition_block.h>
 #include <deal.II/lac/relaxation_block.h>
 
-template<typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
+template <typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
 double
 check_solve (SolverType         &solver,
              const MatrixType   &A,
index 52b63bd3c2d191d3642c5a15b2eebb45236b153f..098bc4cc3a99433054b3edcc54f8f9e26aeeccb1 100644 (file)
@@ -32,7 +32,7 @@
 #include <iomanip>
 
 
-template<typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
+template <typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
 double
 check_solve (SolverType         &solver,
              const MatrixType   &A,
index 8b71d03eac584c149c676b0c0cc28e943b715313..1e0bd1369ef6d47d70525f8552b7fb313beb851b 100644 (file)
@@ -45,7 +45,7 @@ void output_coefficients(double alpha,double beta)
   deallog<<"alpha: "<< alpha << " beta: "<< beta << std::endl;
 }
 
-template<class NUMBER>
+template <class NUMBER>
 void output_eigenvalues(const std::vector<NUMBER> &eigenvalues,const std::string &text)
 {
   deallog<< text;
@@ -56,7 +56,7 @@ void output_eigenvalues(const std::vector<NUMBER> &eigenvalues,const std::string
   deallog << std::endl;
 }
 
-template<class NUMBER>
+template <class NUMBER>
 void output_hessenberg_matrix(const FullMatrix<NUMBER> &H,const std::string &text)
 {
   deallog << text << std::endl;
@@ -68,7 +68,7 @@ void output_hessenberg_matrix(const FullMatrix<NUMBER> &H,const std::string &tex
     }
 }
 
-template<class NUMBER>
+template <class NUMBER>
 void output_arnoldi_vectors_norms(const internal::SolverGMRES::TmpVectors<Vector<NUMBER> > &tmp_vector,const std::string &text)
 {
   deallog << text << std::endl;
@@ -76,7 +76,7 @@ void output_arnoldi_vectors_norms(const internal::SolverGMRES::TmpVectors<Vector
     deallog << tmp_vector[i].l2_norm() << std::endl;
 }
 
-template<typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
+template <typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
 void
 check_solve(SolverType         &solver,
             const MatrixType   &A,
index 6277f4947481bb7c0f79060cc85c204c2988cffd..c4f3797a64da8ce61f8cc2625ae4698443d5b975 100644 (file)
@@ -41,7 +41,7 @@
   deallog.pop(); \
   residuals.push_back(control.last_value())
 
-template<typename MatrixType>
+template <typename MatrixType>
 void
 check_vmult_quadratic (std::vector<double> &residuals,
                        const MatrixType    &A,
index 83a8322ddb8af9eab56a1e70de776f299fd56831..642401685b21b1a596289e6017ead955112ca87d 100644 (file)
@@ -35,7 +35,7 @@
 
 
 // Symmetric matrix with constant diagonals [-1,2,-1]
-template<typename number>
+template <typename number>
 void
 matrix1(TridiagonalMatrix<number> &M)
 {
@@ -50,7 +50,7 @@ matrix1(TridiagonalMatrix<number> &M)
 
 
 // Nonsymmetric matrix with constant diagonals [-1,2,-3]
-template<typename number>
+template <typename number>
 void
 matrix2(TridiagonalMatrix<number> &M)
 {
@@ -65,7 +65,7 @@ matrix2(TridiagonalMatrix<number> &M)
 
 
 // Matrix with increasing diagonals and symmetric rows
-template<typename number>
+template <typename number>
 void
 matrix3(TridiagonalMatrix<number> &M)
 {
@@ -80,7 +80,7 @@ matrix3(TridiagonalMatrix<number> &M)
 
 
 // Symmetric matrix with increasing diagonals
-template<typename number>
+template <typename number>
 void
 matrix4(TridiagonalMatrix<number> &M)
 {
@@ -95,7 +95,7 @@ matrix4(TridiagonalMatrix<number> &M)
 
 
 // Nonsymmetric matrix with increasing diagonals
-template<typename number>
+template <typename number>
 void
 matrix5(TridiagonalMatrix<number> &M)
 {
@@ -109,7 +109,7 @@ matrix5(TridiagonalMatrix<number> &M)
 }
 
 
-template<typename number>
+template <typename number>
 void
 check_vmult(TridiagonalMatrix<number> &M)
 {
@@ -164,7 +164,7 @@ check_vmult(TridiagonalMatrix<number> &M)
 }
 
 
-template<typename number>
+template <typename number>
 void
 check(unsigned int size)
 {
index 51239892d4f598b579cea82c7dcfa724ce5903d6..6a9f7d4d05bc5c54ae8cae25d40abe8fe05256a4 100644 (file)
@@ -38,7 +38,7 @@
 
 
 // Symmetric matrix with constant diagonals [-1,2,-1]
-template<typename number>
+template <typename number>
 void
 matrix1(TridiagonalMatrix<number> &M)
 {
@@ -55,7 +55,7 @@ matrix1(TridiagonalMatrix<number> &M)
 
 
 // Symmetric matrix with increasing diagonals
-template<typename number>
+template <typename number>
 void
 matrix4(TridiagonalMatrix<number> &M)
 {
@@ -69,7 +69,7 @@ matrix4(TridiagonalMatrix<number> &M)
 }
 
 
-template<typename number>
+template <typename number>
 void
 check_vmult(TridiagonalMatrix<number> &M)
 {
@@ -124,7 +124,7 @@ check_vmult(TridiagonalMatrix<number> &M)
 }
 
 
-template<typename number>
+template <typename number>
 void
 check(unsigned int size)
 {
index 5774106e43ae65813d4d2f77ac5afdbed0f0079f..2d924bf13e8ace4bd29b4b48ce9e7350bc2d7c0f 100644 (file)
@@ -24,7 +24,7 @@
 
 using namespace dealii;
 
-template<typename VectorType>
+template <typename VectorType>
 void
 test_leak()
 {
@@ -34,7 +34,7 @@ test_leak()
 }
 
 
-template<typename VectorType>
+template <typename VectorType>
 void
 test_stat()
 {
index 8aff3b8429e1e7ff31f16bb0d9826043a0e1f608..56bc05c111bdfafab777e8c2135e41f365aaf295 100644 (file)
@@ -34,7 +34,7 @@ void print (const Vector<number> &v)
   deallog << std::endl;
 }
 
-template<typename T>
+template <typename T>
 void fill( T &a)
 {
   for (unsigned int i=0; i<a.size(); ++i)
index 490fa6a544ee094bb145b41a7e5b94760182b184..708bf6ca78c0b6cefaa8a6fda7a45e1148533700 100644 (file)
@@ -23,7 +23,7 @@
 #include <fstream>
 #include <iomanip>
 
-template<typename number>
+template <typename number>
 void
 checkReadOnlyConstructor(const Vector<number> &V)
 {
index 842cfe824d0ef6871e6f2acc9cff866f30a460b1..65b6d5deca9681cbd8a55c4084c86bdde17b8803 100644 (file)
@@ -23,7 +23,7 @@
 #include <fstream>
 #include <iomanip>
 
-template<typename number, typename size_type>
+template <typename number, typename size_type>
 void
 checkReinit1(const size_type N, const bool fast = false)
 {
index 4963a1fbe7280021e715630e581cb077dc5d74ad..b9f02dac856044762072bd8dc810edea96ff737b 100644 (file)
@@ -23,7 +23,7 @@
 #include <fstream>
 #include <iomanip>
 
-template<typename number>
+template <typename number>
 void
 checkReinit3(const Vector<number> &V)
 {
index 38f07b2bb7c61f2d7840e0b20ae7e3ddf0f6d131..4b249df0fde56e6dc814a2e6cbf5f05650e943c3 100644 (file)
@@ -23,7 +23,7 @@
 #include <fstream>
 #include <iomanip>
 
-template<typename number>
+template <typename number>
 void
 checkReinit2(Vector<number> &V)
 {
index 00188ee092785e0a508d51bd8e47c53d0e7fab78..4b5bb2c1cdf9c1756dffabad0caa1360a0aaa8b4 100644 (file)
@@ -23,7 +23,7 @@
 #include <fstream>
 #include <iomanip>
 
-template<typename number>
+template <typename number>
 void
 checkReadWriteConstructor(Vector<number> &V)
 {
index d84dc6e1195a2ca1697e1894286c74a5e25b4b66..d83577b2dc1195ceaa85660b6c62ceb7e5df87ee 100644 (file)
@@ -36,7 +36,7 @@ void output_double_number(double input,const std::string &text)
   deallog<<text<< input<<std::endl;
 }
 
-template<class NUMBER>
+template <class NUMBER>
 void output_eigenvalues(const std::vector<NUMBER> &eigenvalues,const std::string &text)
 {
   deallog<< text;
@@ -48,7 +48,7 @@ void output_eigenvalues(const std::vector<NUMBER> &eigenvalues,const std::string
 }
 
 
-template<typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
+template <typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
 void
 check_solve (SolverType         &solver,
              const MatrixType   &A,
@@ -68,7 +68,7 @@ check_solve (SolverType         &solver,
     }
 }
 
-template<typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
+template <typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
 void
 check_Tsolve (SolverType         &solver,
               const MatrixType   &A,
index bc1f4dd43da39234514ca295fc0f792a6e8cac60..be715e8e0c3129c92a2f4c0b3fc7f9038ce9f49e 100644 (file)
@@ -25,7 +25,7 @@
 #include <deal.II/grid/grid_tools.h>
 #include <deal.II/grid/grid_out.h>
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void print_info(Triangulation<dim,spacedim> &tria)
 {
   typename Triangulation<dim,spacedim>::active_cell_iterator cell;
index 1cf744c01d1111fa43a1ebff5da186864ae97a74..028389690c24a357344f19c9ba30121845751aa5 100644 (file)
@@ -25,7 +25,7 @@
 #include <deal.II/grid/grid_tools.h>
 #include <deal.II/grid/grid_out.h>
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void print_info(Triangulation<dim,spacedim> &tria)
 {
   typename Triangulation<dim,spacedim>::active_cell_iterator cell;
index 579bfb20ede778e346ceb853103ba7b1cb1664ce..ed38f488ab91f588813f30df9468a3723d69e3ca 100644 (file)
@@ -26,7 +26,7 @@
 
 #include <numeric>
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void test()
 {
   deallog << "dim=" << dim << ", spacedim=" << spacedim << std::endl;
index b69d64b25782a35cef0ea2562a548ba0e3576d18..b6c20fe5a87ac8a6d58491491a59399c85776670 100644 (file)
@@ -23,7 +23,7 @@
 #include <deal.II/grid/grid_tools.h>
 #include <deal.II/grid/grid_out.h>
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void print_info(Triangulation<dim,spacedim> &tria)
 {
   typename Triangulation<dim,spacedim>::active_cell_iterator cell;
index 686cf85934136d64c86f4295ac22e57b7df35544..eb2d9be10fca002f48d5d0f0cbd1e0d1c20273b9 100644 (file)
@@ -23,7 +23,7 @@
 #include <deal.II/grid/grid_tools.h>
 #include <deal.II/grid/grid_out.h>
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void print_info(Triangulation<dim,spacedim> &tria)
 {
   typename Triangulation<dim,spacedim>::active_cell_iterator cell;
index 908c1120301030c0597dae65f19b72626dcde995..80b7cb7757a4ff1e8616810237010adf35cdf50d 100644 (file)
@@ -42,7 +42,7 @@
 
 
 
-template<int dim>
+template <int dim>
 inline void
 plot_faces(Mapping<dim> &mapping,
            FiniteElement<dim> &fe,
@@ -87,7 +87,7 @@ plot_faces(Mapping<dim> &mapping,
 
 
 
-template<int dim>
+template <int dim>
 inline void
 plot_subfaces(Mapping<dim> &mapping,
               FiniteElement<dim> &fe,
@@ -137,7 +137,7 @@ plot_subfaces(Mapping<dim> &mapping,
 }
 
 
-template<int dim>
+template <int dim>
 void mapping_test()
 {
   deallog << "dim=" << dim << std::endl;
index 04632f5408ea8ab47f10be6408ecb2efa2d5e4af..d45ca869c66e620af65dc16f46912d710830e9e3 100644 (file)
@@ -42,7 +42,7 @@
 
 
 
-template<int dim>
+template <int dim>
 inline void
 plot_faces(Mapping<dim> &mapping,
            FiniteElement<dim> &fe,
@@ -87,7 +87,7 @@ plot_faces(Mapping<dim> &mapping,
 
 
 
-template<int dim>
+template <int dim>
 inline void
 plot_subfaces(Mapping<dim> &mapping,
               FiniteElement<dim> &fe,
@@ -137,7 +137,7 @@ plot_subfaces(Mapping<dim> &mapping,
 }
 
 
-template<int dim>
+template <int dim>
 void mapping_test()
 {
   deallog << "dim=" << dim << std::endl;
index 56a7d65ce725e3a53eb4dc598fee9e5f318464f0..bf6a33b76d3a519567c6a1341589683759cd72e9 100644 (file)
@@ -41,7 +41,7 @@
 #define PRECISION 2
 
 
-template<int dim>
+template <int dim>
 inline void
 plot_transformation(Mapping<dim> &mapping,
                     FiniteElement<dim> &fe,
@@ -81,7 +81,7 @@ plot_transformation(Mapping<dim> &mapping,
 
 
 
-template<int dim>
+template <int dim>
 inline void
 plot_faces(Mapping<dim> &mapping,
            FiniteElement<dim> &fe,
@@ -125,7 +125,7 @@ plot_faces(Mapping<dim> &mapping,
 
 
 
-template<int dim>
+template <int dim>
 inline void
 plot_subfaces(Mapping<dim> &mapping,
               FiniteElement<dim> &fe,
@@ -171,7 +171,7 @@ plot_subfaces(Mapping<dim> &mapping,
 
 
 
-template<>
+template <>
 inline void
 plot_faces(Mapping<1> &,
            FiniteElement<1> &,
@@ -181,7 +181,7 @@ plot_faces(Mapping<1> &,
 
 
 
-template<>
+template <>
 inline void
 plot_subfaces(Mapping<1> &,
               FiniteElement<1> &,
@@ -191,7 +191,7 @@ plot_subfaces(Mapping<1> &,
 
 
 
-template<int dim>
+template <int dim>
 inline void
 compute_area(Mapping<dim> &mapping,
              FiniteElement<dim> &fe,
@@ -210,7 +210,7 @@ compute_area(Mapping<dim> &mapping,
 }
 
 
-template<int dim>
+template <int dim>
 void create_triangulations(std::vector<Triangulation<dim> *> &,
                            std::vector<Boundary<dim> *> &,
                            std::vector<double> &)
@@ -224,7 +224,7 @@ std::vector<std::vector<unsigned int> > show;
 unsigned int mapping_size;
 
 
-template<>
+template <>
 void create_triangulations(std::vector<Triangulation<1> *> &tria_ptr,
                            std::vector<Boundary<1> *> &,
                            std::vector<double> &exact_areas)
@@ -241,7 +241,7 @@ void create_triangulations(std::vector<Triangulation<1> *> &tria_ptr,
 
 
 
-template<>
+template <>
 void create_triangulations(std::vector<Triangulation<2> *> &tria_ptr,
                            std::vector<Boundary<2> *> &boundary_ptr,
                            std::vector<double> &exact_areas)
@@ -355,7 +355,7 @@ void create_triangulations(std::vector<Triangulation<2> *> &tria_ptr,
 
 
 
-template<>
+template <>
 void create_triangulations(std::vector<Triangulation<3> *> &tria_ptr,
                            std::vector<Boundary<3> *> &boundary_ptr,
                            std::vector<double> &exact_areas)
@@ -424,7 +424,7 @@ void create_triangulations(std::vector<Triangulation<3> *> &tria_ptr,
 }
 
 
-template<int dim>
+template <int dim>
 void mapping_test()
 {
   deallog << "dim=" << dim << std::endl;
index e3a2d9d111c0036eec03020eba903f5b42bdebd6..953d7e30dfeecb8b39ef5be54b17a3b44ded1b9d 100644 (file)
@@ -42,7 +42,7 @@
 
 #define PRECISION 2
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void test(const unsigned int degree)
 {
   deallog << "dim = " << dim << ", spacedim = " << spacedim << std::endl;
index d60c40f700904907f7509840ba703c1a6879ff27..1740eada93c172f7d2e00d4bfc541301e721a3bd 100644 (file)
@@ -37,7 +37,7 @@
 using namespace dealii;
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void test_real_to_unit_cell()
 {
   deallog << "dim=" << dim << ", spacedim=" << spacedim << std::endl;
index 7c483e3fe756bcca43e915cd66606520c27867fe..c028f06236d38e7796f6c7f076dbb8ed0c8eab3e 100644 (file)
@@ -43,7 +43,7 @@
 using namespace dealii;
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void test_real_to_unit_cell()
 {
   deallog << "dim=" << dim << ", spacedim=" << spacedim << std::endl;
index b21a357751c23e47a4322047ad0b4f163d16ae14..04e117b2c7fe0dc0c1c643342a700ddf5a1c553c 100644 (file)
@@ -39,7 +39,7 @@
 using namespace dealii;
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void test_real_to_unit_cell()
 {
   deallog << "dim=" << dim << ", spacedim=" << spacedim << std::endl;
index 97a8c5f038ef749083f4a1c7ebf7203ea6b0e27b..a9d4f22d79bbe3dc19f5af8c97cf1ffc13b3b28e 100644 (file)
@@ -43,7 +43,7 @@
 using namespace dealii;
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void test_real_to_unit_cell()
 {
   deallog << "dim=" << dim << ", spacedim=" << spacedim << std::endl;
index 6fe4464ca1e079bf4ff997ac8e46eb5c9df58182..b09bf04d6c1b06b137468216b8d7405dab82fe4d 100644 (file)
@@ -43,7 +43,7 @@
 using namespace dealii;
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void test_real_to_unit_cell()
 {
   deallog << "dim=" << dim << ", spacedim=" << spacedim << std::endl;
index 1a85378d43175ade6fdecfda73f03dc598307c71..3c308efe86b0452118d807e4475bc4840ad41235 100644 (file)
@@ -43,7 +43,7 @@
 using namespace dealii;
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void test_real_to_unit_cell()
 {
   deallog << "dim=" << dim << ", spacedim=" << spacedim << std::endl;
index e3d18f8c096cfd8f17a78e576e26ae7f8ed30c16..720041a80bbbd3e234f64bcccf0de4d97b114afe 100644 (file)
@@ -36,7 +36,7 @@
 using namespace dealii;
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void test_real_to_unit_cell()
 {
   deallog << "dim=" << dim << ", spacedim=" << spacedim << std::endl;
index 33de2b4926604a592db48f1490330a19ad1183a6..7e81e046d83cf6fa94b277f0bc9b97424202af6f 100644 (file)
@@ -45,7 +45,7 @@
 using namespace dealii;
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void test_real_to_unit_cell()
 {
   deallog << "dim=" << dim << ", spacedim=" << spacedim << std::endl;
index 639e9825c478e575b0a83d7fa6b6b639e372eeaa..cc09ecee40e9ef22331ee9b52b33785e1613f83c 100644 (file)
@@ -36,7 +36,7 @@
 using namespace dealii;
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void test_real_to_unit_cell()
 {
   deallog << "dim=" << dim << ", spacedim=" << spacedim << std::endl;
index ac77aa310cfd6f04b1eb546f2dc5e371fb10ec82..b61e0581da459371adc078d715983b47717cd9ea 100644 (file)
@@ -45,7 +45,7 @@
 using namespace dealii;
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void test_real_to_unit_cell()
 {
   deallog << "dim=" << dim << ", spacedim=" << spacedim << std::endl;
index a13d9e4d434a7ce783ed8abd84b9ddd8d2ef079a..5edc20ea2e22258a24494db1d192336ae29aa0c3 100644 (file)
@@ -42,7 +42,7 @@
 using namespace dealii;
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void test_real_to_unit_cell()
 {
   deallog << "dim=" << dim << ", spacedim=" << spacedim << std::endl;
index 7292ada14eac089f4ee2ff1a97f681d7f554e496..6f4b00c62a66446fb622f115e7fa6da0aa36ec0c 100644 (file)
@@ -42,7 +42,7 @@
 using namespace dealii;
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void test_real_to_unit_cell()
 {
   deallog << "dim=" << dim << ", spacedim=" << spacedim << std::endl;
index 430154f53bc85a380549a0a04a31f5d73187dad0..48e39f4cf97b74966ab6c3aed55621cc0a64ed88 100644 (file)
@@ -25,7 +25,7 @@
 #include <deal.II/fe/mapping_manifold.h>
 #include <deal.II/grid/manifold_lib.h>
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void test()
 {
   deallog << "dim=" << dim << ", spacedim=" << spacedim << std::endl;
index be22112226cf370036372257904d1db3f1736b47..d7b3e07b0b1b0d5a70e75328f12fdfe5b122c748 100644 (file)
@@ -30,7 +30,7 @@
 #include <deal.II/fe/fe_q.h>
 #include <deal.II/fe/fe_values.h>
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void test()
 {
   deallog << "dim=" << dim << ", spacedim=" << spacedim << std::endl;
index 8d91e0703ad4f7d0d5a23ae900bfa9ba8d5ebcc7..838882a8b7ebf86d5542a7625f7d2f1b06e9b5cc 100644 (file)
@@ -29,7 +29,7 @@
 #include <deal.II/fe/fe_q.h>
 #include <deal.II/fe/fe_values.h>
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void test()
 {
   deallog << "dim=" << dim << ", spacedim=" << spacedim << std::endl;
index 7c13d7c8afee00b43cbb758a995d2c0d61fb115c..fcde9ca351e3d4c296b96b3f4063a3df9ba739ff 100644 (file)
@@ -30,7 +30,7 @@
 #include <deal.II/fe/fe_q.h>
 #include <deal.II/fe/fe_values.h>
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void test()
 {
   deallog << "dim=" << dim << ", spacedim=" << spacedim << std::endl;
index 71920559910176850baeed53ef50dc5ba412a47b..00bea664e098aa8130bc20ec3842bebdb22da8c3 100644 (file)
@@ -31,7 +31,7 @@
 #include <deal.II/fe/fe_q.h>
 #include <deal.II/fe/fe_values.h>
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void test()
 {
   deallog << "dim=" << dim << ", spacedim=" << spacedim << std::endl;
index 21e21ca565d8387c1a386ebe484d214803918e38..aea044f21da73602ff276350aee19db24145f9d2 100644 (file)
@@ -27,7 +27,7 @@
 #include <deal.II/fe/fe_values.h>
 #include <deal.II/grid/manifold_lib.h>
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void test()
 {
   std::ostream &out = deallog.get_file_stream();
index 0f0555def3647e3177dfcbcfc28e4dcce548e943..d1030554c5c9fd3381d3ba81a79f005f51b7d76f 100644 (file)
@@ -25,7 +25,7 @@
 #include <deal.II/fe/fe_values.h>
 #include <deal.II/grid/manifold_lib.h>
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void test()
 {
   std::ostream &out = deallog.get_file_stream();
index 6e0e4739e51c5c71d78bc29d6d3100fc1e907f44..df97f16ea4c67f0200c18ff8a579f6dbe9bd054c 100644 (file)
@@ -31,7 +31,7 @@
 
 
 
-template<int dim>
+template <int dim>
 inline void
 show_values(FiniteElement<dim> &fe,
             const char *name)
@@ -87,7 +87,7 @@ show_values(FiniteElement<dim> &fe,
 
 
 
-template<int dim>
+template <int dim>
 void show_values()
 {
   FE_Q<dim> q1(1);
index 751e69074338f1502fad9a5af2167d6bc66b952f..067f1d69e4e55ff83bcd302a9892ebd60a103919 100644 (file)
@@ -100,7 +100,7 @@ double zvalue (const double x, const double y)
   return (xh * exp(-xh*xh - yh*yh)) / 10.;
 }
 
-template<int dim>
+template <int dim>
 class Geometry: public ChartManifold<dim>
 {
 public:
@@ -108,7 +108,7 @@ public:
   virtual Point<dim> push_forward(const Point<dim> &chart_point) const;
 };
 
-template<int dim>
+template <int dim>
 Point<dim> Geometry<dim>::pull_back(const Point<dim> &space_point) const
 {
   const double d = space_point[dim - 1];
@@ -128,7 +128,7 @@ Point<dim> Geometry<dim>::pull_back(const Point<dim> &space_point) const
   return p;
 }
 
-template<int dim>
+template <int dim>
 Point<dim> Geometry<dim>::push_forward(const Point<dim> &chart_point) const
 {
   const double d_hat = chart_point[dim - 1];
@@ -150,7 +150,7 @@ Point<dim> Geometry<dim>::push_forward(const Point<dim> &chart_point) const
 
 
 
-template<int dim>
+template <int dim>
 class TranscendentalManufacturedSolution : public Function<dim>
 {
 public:
index 8a49a78fe00919cb38198deb0199cabc9f20e91e..21d7ae5916a520247ecdcea41da5dc911527b3ee 100644 (file)
@@ -44,7 +44,7 @@ double zvalue (const double x, const double y)
   return (xh * exp(-xh*xh - yh*yh)) / 10.;
 }
 
-template<int dim>
+template <int dim>
 class Geometry: public ChartManifold<dim>
 {
 public:
@@ -52,7 +52,7 @@ public:
   virtual Point<dim> push_forward(const Point<dim> &chart_point) const;
 };
 
-template<int dim>
+template <int dim>
 Point<dim> Geometry<dim>::pull_back(const Point<dim> &space_point) const
 {
   const double d = space_point[dim - 1];
@@ -72,7 +72,7 @@ Point<dim> Geometry<dim>::pull_back(const Point<dim> &space_point) const
   return p;
 }
 
-template<int dim>
+template <int dim>
 Point<dim> Geometry<dim>::push_forward(const Point<dim> &chart_point) const
 {
   const double d_hat = chart_point[dim - 1];
@@ -92,7 +92,7 @@ Point<dim> Geometry<dim>::push_forward(const Point<dim> &chart_point) const
   return p;
 }
 
-template<int dim>
+template <int dim>
 class VectorFunction : public Function<dim>
 {
 public:
@@ -104,26 +104,26 @@ public:
   virtual void vector_value(const Point<dim> &p, Vector<double> &values) const;
 };
 
-template<>
+template <>
 double VectorFunction<3>::value(const Point<3> &p, const unsigned int component) const
 {
   return (1 - p(0)*p(0)) * (1 - p(1)*p(1)) * (1 - p(2)*p(2));
 }
 
-template<>
+template <>
 double VectorFunction<2>::value(const Point<2> &p, const unsigned int component) const
 {
   return (1 - p(0)*p(0)) * (1 - p(1)*p(1));
 }
 
-template<int dim>
+template <int dim>
 void VectorFunction<dim>::value(const Point<dim> &p, Vector<double> &values) const
 {
   for (unsigned i = 0; i < values.size(); ++i)
     values[i] = value(p, i);
 }
 
-template<int dim>
+template <int dim>
 void VectorFunction<dim>::vector_value(const Point<dim> &p, Vector<double> &values) const
 {
   for (int i = 0; i < dim; ++i)
index 76447d0980fbd79e9b8e5ae8ffa7aa3e1910225a..de1fa58fc104186e37037acf50a0386038150a2b 100644 (file)
@@ -66,7 +66,7 @@ double f_x(double x_m)
   return y_m;
 }
 
-template<int dim>
+template <int dim>
 class PushForward : public Function<dim>
 {
 public:
@@ -98,7 +98,7 @@ private:
 };
 
 
-template<int dim>
+template <int dim>
 double PushForward<dim>::value(const Point<dim> &p,const unsigned int component) const
 {
   double result = 0;
@@ -124,7 +124,7 @@ double PushForward<dim>::value(const Point<dim> &p,const unsigned int component)
   return result;
 }
 
-template<int dim>
+template <int dim>
 class PullBack : public Function<dim>
 {
 public:
@@ -152,7 +152,7 @@ private:
   const double y_FoR;
 };
 
-template<int dim>
+template <int dim>
 double PullBack<dim>::value(const Point<dim> &p,const unsigned int component) const
 {
   double result = 0;
index b64719f80085b6411a90ec327a67d12931b526b3..22c41d7a72860a0041e63efb57c1fef843d76d47 100644 (file)
@@ -33,7 +33,7 @@
 
 
 
-template<int dim>
+template <int dim>
 void test2()
 {
   const HyperBallBoundary<dim> boundary_description;
index 1a045e514d86561734674fa60ebb722f4bb6bcf3..8e28110d495d6f47174e3438b98868066c2e6a57 100644 (file)
@@ -28,7 +28,7 @@
 #include <deal.II/fe/mapping_q1.h>
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void test_real_to_unit_cell()
 {
   deallog << "dim=" << dim << ", spacedim=" << spacedim << std::endl;
index 717a3c4d06c8039b68b3cb2fea390fc5696f28bc..8ec302554cdd82a76837f55e0f03cee3cf80fa44 100644 (file)
@@ -26,7 +26,7 @@
 #include <deal.II/fe/mapping_q1.h>
 
 
-template<int dim>
+template <int dim>
 void test_real_to_unit_cell()
 {
   deallog << "dim=" << dim << std::endl;
index 481173e8966b785d0f7180c348ef3d4fb5e555ec..93e38951bedeac6a415e551a3d7534d93d3e242d 100644 (file)
@@ -33,7 +33,7 @@
 #include <deal.II/fe/mapping_q.h>
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void test_real_to_unit_cell()
 {
   deallog << "dim=" << dim << ", spacedim=" << spacedim << std::endl;
index bf4349fb5504d396d991f8e252754c085ead053d..691add225b0bea626a63cc9cf2e7067d7dc175be 100644 (file)
@@ -33,7 +33,7 @@
 #include <deal.II/fe/mapping_q.h>
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void test_real_to_unit_cell()
 {
   deallog << "dim=" << dim << ", spacedim=" << spacedim << std::endl;
index a2edb4c7d576357386cb9bfd672058a1373a9ea2..2922a64a5c7b2c7603b9493cbe040bee40170936 100644 (file)
@@ -33,7 +33,7 @@
 #include <deal.II/fe/mapping_q.h>
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void test_real_to_unit_cell()
 {
   deallog << "dim=" << dim << ", spacedim=" << spacedim << std::endl;
index 8907a897348d8ce6b02b4e43c9521810d563346c..5ed3f9388afd534633d7e2a322b30c92d4b9e8dc 100644 (file)
@@ -277,7 +277,7 @@ private:
 
 
 
-template<typename MatrixType, typename Number>
+template <typename MatrixType, typename Number>
 class MGCoarseIterative : public MGCoarseGridBase<LinearAlgebra::distributed::Vector<Number> >
 {
 public:
index 13f2547b19b0298f8caac2709eac6ae44f318863..b949877670b6b3e8296b6743fdd5f2f2deda3e48 100644 (file)
@@ -48,7 +48,7 @@ std::ofstream logfile("output");
 
 
 
-template<typename MatrixType, typename Number>
+template <typename MatrixType, typename Number>
 class MGCoarseIterative : public MGCoarseGridBase<LinearAlgebra::distributed::Vector<Number> >
 {
 public:
index a41c7e67371cccbc648e82f51371249e37e3bb43..2a45efa54cdc2a7c8f6f211201746cee220078c0 100644 (file)
@@ -404,7 +404,7 @@ private:
 
 
 
-template<typename MatrixType, typename Number>
+template <typename MatrixType, typename Number>
 class MGCoarseIterative : public MGCoarseGridBase<LinearAlgebra::distributed::Vector<Number> >
 {
 public:
index b6ee95fc609cc33cf3c0218503f6847110751316..c3041b9058e63581ced9cbbf7ba42ac55698c7c8 100644 (file)
@@ -85,7 +85,7 @@ private:
 
 
 
-template<typename MatrixType, typename Number>
+template <typename MatrixType, typename Number>
 class MGCoarseIterative : public MGCoarseGridBase<LinearAlgebra::distributed::Vector<Number> >
 {
 public:
index 59de7964f3318219a30bd1d4da59583cbe2e88e9..0bba8bc319928e4dc5a7aa1217113fbadabae037 100644 (file)
@@ -409,7 +409,7 @@ private:
 
 
 
-template<typename MatrixType, typename Number>
+template <typename MatrixType, typename Number>
 class MGCoarseIterative : public MGCoarseGridBase<LinearAlgebra::distributed::Vector<Number> >
 {
 public:
index 690842f2cb9f69b2a40376be233f6a60023095d1..5dd707ccaae90ee4654843b28bdf7e922f3ac88e 100644 (file)
@@ -85,7 +85,7 @@ private:
 
 
 
-template<typename MatrixType, typename Number>
+template <typename MatrixType, typename Number>
 class MGCoarseIterative : public MGCoarseGridBase<LinearAlgebra::distributed::Vector<Number> >
 {
 public:
index 8355c969bcf473504924991b53f5c5e42b457509..7a1071dc1d6b658409aee8800e31b743b9bb408f 100644 (file)
@@ -406,7 +406,7 @@ private:
 
 
 
-template<typename MatrixType, typename Number>
+template <typename MatrixType, typename Number>
 class MGCoarseIterative : public MGCoarseGridBase<LinearAlgebra::distributed::Vector<Number> >
 {
 public:
index 3d79899b272da3ad9f53e136ef03c3db6f13f2c0..60f54c5e7699ff9cc44c6f967c3f5ae749b31deb 100644 (file)
@@ -278,7 +278,7 @@ private:
 
 
 
-template<typename MatrixType, typename Number>
+template <typename MatrixType, typename Number>
 class MGCoarseIterative : public MGCoarseGridBase<LinearAlgebra::distributed::Vector<Number> >
 {
 public:
index 5f4e786d513d7c4912b6ffb077e9a339ecf7e9f9..fb0e4eff72a9a749cde22c7efbb68864e60783db 100644 (file)
@@ -37,7 +37,7 @@
 
 using namespace dealii;
 
-template<int dim,int spacedim>
+template <int dim,int spacedim>
 class TestIntegrator : public MeshWorker::LocalIntegrator<dim,spacedim>
 {
 public:
@@ -59,7 +59,7 @@ public:
   {};
 };
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void test()
 {
   MappingQ1<dim,spacedim> mapping;
index 372004bd4cb3943a37b2aa841855db1679e37cf6..8e657332eae5984f056b88e7c1597151f61cd45b 100644 (file)
@@ -31,7 +31,7 @@
 
 #include <fstream>
 
-template<int dim>
+template <int dim>
 void pack_function (const typename parallel::distributed::Triangulation<dim,dim>::cell_iterator &cell,
                     const typename parallel::distributed::Triangulation<dim,dim>::CellStatus status,
                     void *data)
@@ -61,7 +61,7 @@ void pack_function (const typename parallel::distributed::Triangulation<dim,dim>
   ++some_number;
 }
 
-template<int dim>
+template <int dim>
 void unpack_function (const typename parallel::distributed::Triangulation<dim,dim>::cell_iterator &cell,
                       const typename parallel::distributed::Triangulation<dim,dim>::CellStatus status,
                       const void *data)
@@ -88,7 +88,7 @@ void unpack_function (const typename parallel::distributed::Triangulation<dim,di
 }
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
index f24945893d8b8a76c94beb8d89755196d4295c31..852c4eeb0f00e3098a22b089b83a76d8bba94a63 100644 (file)
@@ -33,7 +33,7 @@
 #include <fstream>
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
index 0746275ee569216b4859cef85fe08b2f03e413ab..e9fd3eb8610e8a4384d0f413f6643d92781ab822 100644 (file)
@@ -53,7 +53,7 @@ cell_weight_2(const typename parallel::distributed::Triangulation<dim>::cell_ite
 }
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
index 40e43b07f964fe64f847c0013b85667011aaef9d..d021783b761bcd7e395eb5931edc8c3d34176fda 100644 (file)
@@ -43,7 +43,7 @@ cell_weight_1(const typename parallel::distributed::Triangulation<dim>::cell_ite
   return current_cell_weight++;
 }
 
-template<int dim>
+template <int dim>
 void test()
 {
   unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
index 810de1b0bdbf4c144c35d96b13b756c0359f7cf1..d645e726ff88c80808d4a6b60602f44cf2eff219 100644 (file)
@@ -41,7 +41,7 @@ cell_weight(const typename parallel::distributed::Triangulation<dim>::cell_itera
   return 100;
 }
 
-template<int dim>
+template <int dim>
 void test()
 {
   unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
index 3cc22d4940743b0f3c6bf512bd0f6cfe7e882fbc..04bab205c0e6164cd3fad71ff71ea145b1febfef 100644 (file)
@@ -49,7 +49,7 @@ cell_weight(const typename parallel::distributed::Triangulation<dim>::cell_itera
   return cell_weight;
 }
 
-template<int dim>
+template <int dim>
 void test()
 {
   unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
index baea133563f4677ae543945f97d0e587b30abfb3..f133a6d6073f4ab6eca358cdacfc85d9f72866ed 100644 (file)
@@ -47,7 +47,7 @@ cell_weight(const typename parallel::distributed::Triangulation<dim>::cell_itera
   return cell_weight;
 }
 
-template<int dim>
+template <int dim>
 void test()
 {
   unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
index 62c99ca05b896e3c9c5008c93a63a41caf0d2310..7966d9a30dc71fde2f18fb862789d3d31aef8542 100644 (file)
@@ -63,7 +63,7 @@ cell_weight(const typename parallel::distributed::Triangulation<dim>::cell_itera
            0);
 }
 
-template<int dim>
+template <int dim>
 void test()
 {
   unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
index 40ddbb47b344c559cc0f04b64ffedcb1bae40aa8..4a1a747da3af4ef198fa9b892b38d33e51e581e6 100644 (file)
@@ -62,7 +62,7 @@ cell_weight(const typename parallel::distributed::Triangulation<dim>::cell_itera
            0);
 }
 
-template<int dim>
+template <int dim>
 void test()
 {
   unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
index 34ff612f193846bec043efe7d62309b17284a01b..455f4972f5a8279d87419698ae290c9a1e4572e9 100644 (file)
@@ -58,7 +58,7 @@ void write_vtk (const parallel::distributed::Triangulation<dim,spacedim> &tria,
 
 }
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void test(std::ostream & /*out*/)
 {
   parallel::distributed::Triangulation<dim,spacedim> tr(MPI_COMM_WORLD);
index f8995dd00afc45b2ff5625702c91f14004560c9b..9219e05c56ad779067310afdde6ea21f5b03698b 100644 (file)
@@ -33,7 +33,7 @@
 #include <fstream>
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   const unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
index 0249c8bc71477aab7ed0b0796f75ce915091323f..f144277b414e5450bfff7e6f989c2c3a69378bbc 100644 (file)
@@ -34,7 +34,7 @@
 #include <fstream>
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   const unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
index 43140d4b4dbea0880bc42117cdabeeb23c2c49df..c48c9b9d451bcfda0e886fd8fa1aa22124d9d894 100644 (file)
@@ -54,7 +54,7 @@ public:
 };
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   parallel::distributed::Triangulation<dim> tr(MPI_COMM_WORLD);
index 9f24dc4b7069d078377310146ecf0e9b9be13c00..b7583925639f52a195e859709dc67c0358d580e9 100644 (file)
@@ -35,7 +35,7 @@
 #include <fstream>
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   const unsigned int myid = Utilities::MPI::this_mpi_process(MPI_COMM_WORLD);
index 6ddd7ed03dd48036090ca49c57112a2b448f0268..f2969e2f25ce0c41232044b68b23e7e91fb20de8 100644 (file)
@@ -49,7 +49,7 @@
 
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
index d786583e54784bd913ab8667519d6ec70b005745..ce6fd702c188f56b2a704ad49ae975cc378aad95 100644 (file)
@@ -38,7 +38,7 @@
 #include <numeric>
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   parallel::distributed::Triangulation<dim>
index ac01afd2dfbe9523d054abdcab25870bc179cd1c..66ea6d97a05625299a7c9c0cd25d592c72d80594 100644 (file)
@@ -38,7 +38,7 @@
 #include <cstdlib>
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   parallel::distributed::Triangulation<dim>
index d92b1857105e866c766aa2b2c19339e9afa11b6f..60e35bcdefc7238d2e524b93b3f3f94e07eb10ba 100644 (file)
@@ -38,7 +38,7 @@
 #include <cstdlib>
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   parallel::distributed::Triangulation<dim>
index 8d85d9f7bfa5bbe71133a01382b71e7f7647a9e8..98125ff93114b37ec08e7d828de16d3f190427ec 100644 (file)
@@ -37,7 +37,7 @@
 #include <numeric>
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   parallel::distributed::Triangulation<dim>
index 91913dab8ef8518221d76520fa4468bb50a37224..4e903ae94a2e6caf241b441bd5d113c3a9f1e26c 100644 (file)
@@ -37,7 +37,7 @@
 #include <numeric>
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   parallel::distributed::Triangulation<dim>
index a7434a84878a29de6ed442ba070e787af7209f9f..951ff0b98ef30d99f05d3af666e2102907b37fc0 100644 (file)
@@ -38,7 +38,7 @@
 #include <cstdlib>
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   parallel::distributed::Triangulation<dim>
index 5e813f0a21c64540a94e8c9bd02dbc9e4726547b..f2c3164845cfdc1260e08edda375051ea3405b35 100644 (file)
@@ -39,7 +39,7 @@
 #include <cstdlib>
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   parallel::distributed::Triangulation<dim>
index 443eb527c37906afb20742673c598f728c075cdb..f9f5c301e454745abe2e3d97867e82ca0d5fb6d9 100644 (file)
@@ -50,7 +50,7 @@
 #include <numeric>
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   parallel::distributed::Triangulation<dim> triangulation(MPI_COMM_WORLD);
index 935c558f33b210e0d5a7e9cab0bdffc2f5e41603..8a8ba66a3d6d4ef54d9401a5a020ed6af2beb484 100644 (file)
@@ -41,7 +41,7 @@
 #include <numeric>
 
 
-template<int dim>
+template <int dim>
 void test(FiniteElement<dim> &fe)
 {
   deallog << "dim=" << dim << std::endl;
index ab83a2a3156469c0a85230363f3ff3cf550ad294..50385187ca87a11c812c6a4d9622c4b2fd5f1eb6 100644 (file)
@@ -31,7 +31,7 @@
 #include <fstream>
 
 using namespace dealii;
-template<int dim>
+template <int dim>
 void test()
 {
   parallel::distributed::Triangulation < dim > tr(MPI_COMM_WORLD);
index 45519d5cb317e26f37baebe8e6b2659e1e8e0a23..a80de494fbb205e28298cbc54990c1967037bf48 100644 (file)
@@ -52,7 +52,7 @@ namespace LinearAdvectionTest
 {
   using namespace dealii;
 
-  template<int dim>
+  template <int dim>
   class AdvectionProblem
   {
   public:
@@ -84,7 +84,7 @@ namespace LinearAdvectionTest
 
 
 
-  template<int dim>
+  template <int dim>
   AdvectionProblem<dim>::AdvectionProblem()
     : triangulation(MPI_COMM_WORLD),
       fe(1),
@@ -100,7 +100,7 @@ namespace LinearAdvectionTest
                                               p0, p1);
   }
 
-  template<int dim>
+  template <int dim>
   void AdvectionProblem<dim>::setup_system()
   {
     dof_handler.distribute_dofs(fe);
@@ -133,7 +133,7 @@ namespace LinearAdvectionTest
 
 
 
-  template<int dim>
+  template <int dim>
   void AdvectionProblem<dim>::calculate_flux_terms
   (const TriaActiveIterator<DoFCellAccessor<DoFHandler<dim>, false> > &current_cell,
    FEFaceValues<dim> &current_face_values,
@@ -197,7 +197,7 @@ namespace LinearAdvectionTest
 
 
 
-  template<int dim>
+  template <int dim>
   void AdvectionProblem<dim>::assemble_system()
   {
     const unsigned int dofs_per_cell = fe.dofs_per_cell;
@@ -300,7 +300,7 @@ namespace LinearAdvectionTest
 
 
 
-  template<int dim>
+  template <int dim>
   void AdvectionProblem<dim>::run()
   {
     setup_system();
index 808bb5ad00ee805b23c932c4d5606175e0349ff9..e41b2bb9eb57ff573cb9761941b84d1ebe099056 100644 (file)
@@ -40,7 +40,7 @@
 #include <numeric>
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   parallel::distributed::Triangulation<dim>
index c745ee65a195019f44fafa498de6b39dc43e6f59..2e65dec68ffb345886a50b860474720a5f114972 100644 (file)
@@ -28,7 +28,7 @@
 #include <fstream>
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   parallel::distributed::Triangulation<dim> tr(MPI_COMM_WORLD);
index 3ee85fc528ecd756f9d9c22959145c7bcd957ac7..58ba72167fdac5eeb4a9544cda05f46c0f389790 100644 (file)
@@ -39,7 +39,7 @@
 #include <fstream>
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
index dde7814394f823b4471d06e5c59534df662850ae..926af78cf9ffcd668a9f581f42e960d5efc14614 100644 (file)
@@ -37,7 +37,7 @@
 #include <fstream>
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
index c5575293e7f198e35adafa4c7560d6adfcde1169..01d61837eed5fa1f9020cce9b4e0a01711b04d41 100644 (file)
@@ -38,7 +38,7 @@
 #include <fstream>
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   parallel::distributed::Triangulation<dim> tr(MPI_COMM_WORLD);
index 9845fcd1e31de8543f9615b89af6f3146c934524..14e2b002fb72ca28cff0f5088bb299fec5614056 100644 (file)
@@ -55,7 +55,7 @@ public:
 };
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   parallel::distributed::Triangulation<dim> tr(MPI_COMM_WORLD);
index c58c1c55e68e1d13526800209d10a21511d9f0e2..1a8fb95c227f60f54f6f87e36c214ce3f19688ff 100644 (file)
@@ -60,7 +60,7 @@ public:
 };
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   parallel::distributed::Triangulation<dim> tr(MPI_COMM_WORLD);
index 6f2510fe3efdc43d32796f0c262be60bf9723c3e..442f536110201d4f554e9a90b1046d7ca966cbed 100644 (file)
@@ -66,7 +66,7 @@ public:
 };
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   parallel::distributed::Triangulation<dim> tr(MPI_COMM_WORLD);
index ab4b714a35b23147cd5eba8ea2f5ea2861f09bb2..10515bc35acdea53d1a86c68d7a31b2482acd9ec 100644 (file)
@@ -32,7 +32,7 @@
 #include <fstream>
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
index 47853bf769bdacb1b068e4c2740f3f5b9978715e..50ae6a5e31a45312216c1dfc74063bb59c7b8b71 100644 (file)
@@ -32,7 +32,7 @@
 #include <fstream>
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
index 5706af46dc487e5137551149947af9cea6543da5..9cb72e4798b6dffd2f0377bf944dcbcc49379cf5 100644 (file)
@@ -34,7 +34,7 @@
 #include <fstream>
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
index 14d87ab431e23b3770f403bf0ce1af9520b8f565..e9188e18102033acbcb30af32676804c793b241f 100644 (file)
@@ -68,7 +68,7 @@ using namespace dealii;
 
 //#define DISTRIBUTED
 
-template<int dim>
+template <int dim>
 void test_int(const unsigned int n_global = 0,
               const unsigned int n_local = 0)
 {
index 67eab07ddf723e260a1efab2cdeec67e898d6582..02459ac686f68f32069f720448c9992ba975c117 100644 (file)
@@ -52,7 +52,7 @@ public:
 };
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   parallel::distributed::Triangulation<dim> tr(MPI_COMM_WORLD);
index d0a9050166c49f6a4c635804136e8061757df086..f64941d42338446ee4bdefd6853afd14ab19df2a 100644 (file)
@@ -48,7 +48,7 @@
 #include <sstream>
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
index 6be2dd05aa4a4b1db523e3f0ff01a8f540731f00..995813dffef91b4320bcf03d60497c06cc8f7b6b 100644 (file)
@@ -49,7 +49,7 @@
 #include <sstream>
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
index c201526d3d4fc8e3763e53c3233766a8bb7f3d6b..7283d979c2d11c80892a2cdd5f37c975c5550e40 100644 (file)
@@ -55,7 +55,7 @@ public:
 };
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   parallel::distributed::Triangulation<dim> tr(MPI_COMM_WORLD);
index 1daefe95c3b57087340f22d073f51b7b5cd4938e..b166387eb1da0be68bd6bdfd0b57d24daadc696d 100644 (file)
@@ -44,7 +44,7 @@
 
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   parallel::distributed::Triangulation<dim> tr(MPI_COMM_WORLD);
index 1117921b937cc8032c36d5fee537ec8c59fc99b7..d8e31f020bc897b7dc82d27f42e4be71775756b1 100644 (file)
@@ -38,7 +38,7 @@ public:
   }
 };
 
-template<int dim>
+template <int dim>
 void setup(DoFHandler<dim> &dh,
            FE_Q<dim> &fe,
            LA::MPI::Vector &vec,
@@ -51,7 +51,7 @@ void setup(DoFHandler<dim> &dh,
   lr_vec.reinit(locally_relevant, MPI_COMM_WORLD);
 }
 
-template<int dim>
+template <int dim>
 void output(DoFHandler<dim> &dh, LA::MPI::Vector &v, unsigned int loop, const std::string filename_)
 {
   unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
@@ -86,7 +86,7 @@ void output(DoFHandler<dim> &dh, LA::MPI::Vector &v, unsigned int loop, const st
     }
 }
 
-template<int dim>
+template <int dim>
 void test()
 {
   unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
index 1e9f363d5d6cd1f19e265f5859e09d0c8b5baf5c..60a80caadbb2f2462cb04db15e81ef2944a5eb67 100644 (file)
@@ -32,7 +32,7 @@
 #include <fstream>
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
index 19e296c4b8d60157b4e826956fa1413906cc22a4..82603b8c51bebc976c5dd15f608e6f0105c613d0 100644 (file)
@@ -28,7 +28,7 @@
 #include <fstream>
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   parallel::distributed::Triangulation<dim> tr(MPI_COMM_WORLD);
index 7f34f124bde6ac3d4641771ae65fe7f1d84099de..22309dbe3fddc90bcbe531b0a61e36e7b16f4beb 100644 (file)
@@ -29,7 +29,7 @@
 #include <fstream>
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   parallel::distributed::Triangulation<dim> tr(MPI_COMM_WORLD);
index a32300856f6b10761f70d08eaae5f45b72f170fc..07f6c8291ed0452e14ea7aa3208e9d609f4e037c 100644 (file)
@@ -79,9 +79,9 @@ class DoNothingAssembler
 public:
   template <class DOFINFO>
   void initialize_info(DOFINFO &info, bool face) const {}
-  template<class DOFINFO>
+  template <class DOFINFO>
   void assemble(const DOFINFO &info) {}
-  template<class DOFINFO>
+  template <class DOFINFO>
   void assemble(const DOFINFO &info1,
                 const DOFINFO &info2) {}
 
@@ -129,7 +129,7 @@ test_simple(DoFHandler<dim> &dofs, MeshWorker::LoopControl &lctrl)
 //     lctrl);
 }
 
-template<int dim>
+template <int dim>
 void test_loop(DoFHandler<dim> &dofs, MeshWorker::LoopControl &lctrl)
 {
   deallog << "* own_cells=" << lctrl.own_cells
@@ -140,7 +140,7 @@ void test_loop(DoFHandler<dim> &dofs, MeshWorker::LoopControl &lctrl)
   test_simple(dofs, lctrl);
 }
 
-template<int dim>
+template <int dim>
 void
 test()
 {
index 6c5a2c4bead18424d10751e9172b5df8459bd4ec..efb2cb580d2d9d9d48e32eeba5d2e2d966006a10 100644 (file)
@@ -79,9 +79,9 @@ class DoNothingAssembler
 public:
   template <class DOFINFO>
   void initialize_info(DOFINFO &info, bool face) const {}
-  template<class DOFINFO>
+  template <class DOFINFO>
   void assemble(const DOFINFO &info) {}
-  template<class DOFINFO>
+  template <class DOFINFO>
   void assemble(const DOFINFO &info1,
                 const DOFINFO &info2) {}
 
@@ -128,7 +128,7 @@ test_simple(DoFHandler<dim> &dofs, MeshWorker::LoopControl &lctrl)
 //     lctrl);
 }
 
-template<int dim>
+template <int dim>
 void test_loop(DoFHandler<dim> &dofs, MeshWorker::LoopControl &lctrl)
 {
   deallog << "* own_cells=" << lctrl.own_cells
@@ -139,7 +139,7 @@ void test_loop(DoFHandler<dim> &dofs, MeshWorker::LoopControl &lctrl)
   test_simple(dofs, lctrl);
 }
 
-template<int dim>
+template <int dim>
 void
 test()
 {
index 7b0fc2a9cad3e7f7b67b317cf0bcbe904124714b..24488ec45b15e209404b6d93e08afb3a1896b3a0 100644 (file)
@@ -79,9 +79,9 @@ class DoNothingAssembler
 public:
   template <class DOFINFO>
   void initialize_info(DOFINFO &info, bool face) const {}
-  template<class DOFINFO>
+  template <class DOFINFO>
   void assemble(const DOFINFO &info) {}
-  template<class DOFINFO>
+  template <class DOFINFO>
   void assemble(const DOFINFO &info1,
                 const DOFINFO &info2) {}
 
@@ -128,7 +128,7 @@ test_simple(DoFHandler<dim> &dofs, MeshWorker::LoopControl &lctrl)
 //     lctrl);
 }
 
-template<int dim>
+template <int dim>
 void test_loop(DoFHandler<dim> &dofs, MeshWorker::LoopControl &lctrl)
 {
   deallog << "* own_cells=" << lctrl.own_cells
@@ -139,7 +139,7 @@ void test_loop(DoFHandler<dim> &dofs, MeshWorker::LoopControl &lctrl)
   test_simple(dofs, lctrl);
 }
 
-template<int dim>
+template <int dim>
 void
 test()
 {
index c830290bedfc4deadbe5a613035d51100ecc5d36..28e14f2b42195903fb82378221323b165688c11e 100644 (file)
@@ -80,9 +80,9 @@ class DoNothingAssembler
 public:
   template <class DOFINFO>
   void initialize_info(DOFINFO &info, bool face) const {}
-  template<class DOFINFO>
+  template <class DOFINFO>
   void assemble(const DOFINFO &info) {}
-  template<class DOFINFO>
+  template <class DOFINFO>
   void assemble(const DOFINFO &info1,
                 const DOFINFO &info2) {}
 
@@ -129,7 +129,7 @@ test_simple(DoFHandler<dim> &dofs, MeshWorker::LoopControl &lctrl)
 //     lctrl);
 }
 
-template<int dim>
+template <int dim>
 void test_loop(DoFHandler<dim> &dofs, MeshWorker::LoopControl &lctrl)
 {
   deallog << "* own_cells=" << lctrl.own_cells
@@ -140,7 +140,7 @@ void test_loop(DoFHandler<dim> &dofs, MeshWorker::LoopControl &lctrl)
   test_simple(dofs, lctrl);
 }
 
-template<int dim>
+template <int dim>
 void
 test()
 {
index 9246bc174e3db08f06bd385e4651bc48f71acea5..46fc93b35e7d7e397e89f9ca2ee84947f8e460ed 100644 (file)
@@ -80,9 +80,9 @@ class DoNothingAssembler
 public:
   template <class DOFINFO>
   void initialize_info(DOFINFO &info, bool face) const {}
-  template<class DOFINFO>
+  template <class DOFINFO>
   void assemble(const DOFINFO &info) {}
-  template<class DOFINFO>
+  template <class DOFINFO>
   void assemble(const DOFINFO &info1,
                 const DOFINFO &info2) {}
 
@@ -130,7 +130,7 @@ test_simple(DoFHandler<dim> &dofs, MeshWorker::LoopControl &lctrl)
 //     lctrl);
 }
 
-template<int dim>
+template <int dim>
 void test_loop(DoFHandler<dim> &dofs, MeshWorker::LoopControl &lctrl)
 {
   deallog << "* own_cells=" << lctrl.own_cells
@@ -141,7 +141,7 @@ void test_loop(DoFHandler<dim> &dofs, MeshWorker::LoopControl &lctrl)
   test_simple(dofs, lctrl);
 }
 
-template<int dim>
+template <int dim>
 void
 test()
 {
index d89ccd02ba3c0fb8388a4f944e5da476ee2cf679..93927048a9c83a381bd192736ed581d5128641f8 100644 (file)
@@ -172,7 +172,7 @@ test_simple(DoFHandler<dim> &dofs, bool faces)
 }
 
 
-template<int dim>
+template <int dim>
 void
 test(const FiniteElement<dim> &fe)
 {
index 1e482a47fd95c2d11f5dea462fe172d22371f4f4..c86dfeedeec9b191de996f7b6def61a67c98ffce 100644 (file)
@@ -36,7 +36,7 @@
 
 #include <fstream>
 
-template<int dim>
+template <int dim>
 void output(parallel::distributed::Triangulation<dim> &tr)
 {
   const std::string filename = ("mesh." +
@@ -53,7 +53,7 @@ void output(parallel::distributed::Triangulation<dim> &tr)
   out.write_xfig(tr, stream);
 }
 
-template<int dim>
+template <int dim>
 void test()
 {
   unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
index a3385c9b3feb70f82334d0c84f14f8d22509a919..b9b084df26859052c3d8f6fa9b6caa49aba6091c 100644 (file)
@@ -38,7 +38,7 @@
 
 #include <fstream>
 
-template<int dim>
+template <int dim>
 void test()
 {
   unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
index 80b6f2b99733cedc41b2672372370449125e33cf..2a4ed6d30755ab142f729827f473348f6d644ba6 100644 (file)
@@ -51,7 +51,7 @@
 
 #include <fstream>
 
-template<int dim>
+template <int dim>
 void output(parallel::distributed::Triangulation<dim> &tr)
 {
   const std::string filename = ("mesh." +
@@ -62,7 +62,7 @@ void output(parallel::distributed::Triangulation<dim> &tr)
 
 }
 
-template<int dim>
+template <int dim>
 void test()
 {
   unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
index e7fddc1aca31b02fdfa38e1619a31ec8b9e1551f..17f73bfce1ad2eece7cc7cca6949545379aeec6c 100644 (file)
@@ -48,7 +48,7 @@ Additional Information:
 
 #include <fstream>
 
-template<int dim>
+template <int dim>
 void output(parallel::distributed::Triangulation<dim> &tr)
 {
   const std::string filename = ("mesh." +
@@ -59,7 +59,7 @@ void output(parallel::distributed::Triangulation<dim> &tr)
 
 }
 
-template<int dim>
+template <int dim>
 void test()
 {
   unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
index b511f2cc91ef8b2033a3d5b45819258d303b1c18..d2b3e0aaaddb6cd954a771d9450025f5e7c76016 100644 (file)
@@ -48,7 +48,7 @@ Additional Information:
 
 #include <fstream>
 
-template<int dim>
+template <int dim>
 void output(parallel::distributed::Triangulation<dim> &tr)
 {
   const std::string filename = ("mesh." +
@@ -81,7 +81,7 @@ void output(parallel::distributed::Triangulation<dim> &tr)
 
 }
 
-template<int dim>
+template <int dim>
 void test()
 {
   unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
index 3b8006362bd675c408a0f397671f890a97819fa3..12be2cc6be9ec1b7fc252be0dcbdda4feb76b826 100644 (file)
@@ -48,7 +48,7 @@ Additional Information:
 
 #include <fstream>
 
-template<int dim>
+template <int dim>
 void output(parallel::distributed::Triangulation<dim> &tr)
 {
   const std::string filename = ("mg_06/mesh." +
@@ -81,7 +81,7 @@ void output(parallel::distributed::Triangulation<dim> &tr)
 
 }
 
-template<int dim>
+template <int dim>
 void test()
 {
   unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
index f31371cdf8b66755bd208afba42446bbe23b392c..7570f230c1674e772bf255d0806295221b164ffe 100644 (file)
@@ -39,7 +39,7 @@
 #include <fstream>
 #include <sstream>
 
-template<int dim>
+template <int dim>
 void test()
 {
   Assert (dim == 3, ExcNotImplemented());
index 101aad39e1af8c002831790ff8c60fd6c9848dbf..5e3958d06d507c0bd046196adcc6b3dd450cec18 100644 (file)
@@ -41,7 +41,7 @@
 #include <fstream>
 #include <sstream>
 
-template<int dim>
+template <int dim>
 void test()
 {
   Assert (dim == 3, ExcNotImplemented());
index bd441ca19bc86489de81a590de898e0e6fa97c88..e1c472dbe3373f7891cf2f461af9eb434fa5c208 100644 (file)
@@ -40,7 +40,7 @@
 #include <fstream>
 #include <sstream>
 
-template<int dim>
+template <int dim>
 void test()
 {
   Assert (dim == 3, ExcNotImplemented());
index 633bd35c7cd9a1f4a3edb12b4b5b221d6ce8e132..f973249a2b98468783f70b6ecf3002a3d21788c4 100644 (file)
@@ -39,7 +39,7 @@
 #include <fstream>
 #include <sstream>
 
-template<int dim>
+template <int dim>
 void test()
 {
   Assert (dim == 3, ExcNotImplemented());
index a89c85ed3877e34786d0efb9ef450522cd1fdab5..b7e4cad6da01898f8980d8dfb299fb4caeb99219 100644 (file)
@@ -33,7 +33,7 @@
 #include <fstream>
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
index 465813ef074cce1fe8715da0e0d87f45e8c59e88..4f25e9f1a4df54baf1bf0f7fdcbaac8b080c9a83 100644 (file)
@@ -38,7 +38,7 @@
 #include <fstream>
 #include <sstream>
 
-template<int dim>
+template <int dim>
 void test()
 {
   unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
index d5e68c540f956cdbe267b9bb0ab93b9e98ed49ed..2cac26cb1e8b649fa1dbe38456d9da0701c61af4 100644 (file)
@@ -38,7 +38,7 @@
 #include <fstream>
 #include <sstream>
 
-template<int dim>
+template <int dim>
 void test()
 {
   unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
index c1b2406948fb636c27ad979cdb83dbee60703ca2..9b55d14c077ee5cb8754cb43ee7b7c28684f0725 100644 (file)
@@ -47,7 +47,7 @@
 #include <sstream>
 
 
-template<int dim>
+template <int dim>
 class FilteredDataOut : public DataOut<dim>
 {
 public:
@@ -92,7 +92,7 @@ private:
 
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
index e88bd0d2ab0c978690c85dac480f3d2acb26993b..8e43ccc15dec03bb4ab9c64dabfdcf6cdfc798c4 100644 (file)
@@ -54,7 +54,7 @@ const double T1 = 2.0;
 
 
 
-template<int dim>
+template <int dim>
 class FilteredDataOut : public DataOut<dim>
 {
 public:
@@ -130,7 +130,7 @@ TemperatureInitialValues<dim>::vector_value (const Point<dim> &p,
 }
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   parallel::distributed::Triangulation<dim> tr(MPI_COMM_WORLD);
index b62ed09cb30d9a59d7520a8f5ae6edc521ec692f..f19ab36b3b0262d8980e63348b0aa22552e19141 100644 (file)
@@ -33,7 +33,7 @@
 #include <deal.II/fe/fe_q.h>
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   parallel::distributed::Triangulation<dim> tr(MPI_COMM_WORLD);
index e30823293660b5d45ac31a9e11cbe5aa6a5daf0b..40056fbb6cee44e275f3a1dcfb359f622bc5b075 100644 (file)
@@ -36,7 +36,7 @@
 #include <fstream>
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
index 5d62bacb6fd18471ec2f513a504c94bf7202ce32..e1a16ff20de6e854d0c7f1a91fcadd7a8a8e3d31 100644 (file)
@@ -36,7 +36,7 @@
 #include <fstream>
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
index 081b0b803dcaa0899511cb538e71b0d8c983922f..5b3f87e179b2006b258f19f2bd491edee5ef4244 100644 (file)
@@ -37,7 +37,7 @@
 #include <fstream>
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
index c176301ccfbc3bef7bd28be64fa3bb95401f0720..16ff05c05c14739180007c3f032f7395d26ab5f0 100644 (file)
@@ -37,7 +37,7 @@
 #include <fstream>
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
index e8d716c508100897d61bf5382324440f5214641a..c6dc686d632c404ca33f76065b6c4533a3b074cc 100644 (file)
@@ -38,7 +38,7 @@
 #include <fstream>
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   parallel::distributed::Triangulation<dim> tr(MPI_COMM_WORLD);
index d3c3ad2cffba9c8d9b9e73de2571b136af5249f2..ebeb6157c923aeb592924f80add54e870ffaa33a 100644 (file)
@@ -32,7 +32,7 @@
 #include <fstream>
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
index 4c0402db1b2d996bdd8e05940b9268a4ff0df999..e7e59fbb4b87ec98b07a8a221345eb5de30cf303 100644 (file)
@@ -32,7 +32,7 @@
 #include <fstream>
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
index b6683d6c1e28a38937a32561d41afa9536b50b95..5392e89de23e98d2c3e7a39d00e39f2594d3e9ef 100644 (file)
@@ -32,7 +32,7 @@
 #include <fstream>
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
index 0d8cdf9d7c188694a5594c76aa0d67b55b9896ba..6961e0f56a139f87426d21836568dc520e2f09e0 100644 (file)
@@ -49,7 +49,7 @@ void check (TRIA &tr)
 }
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
index e5787f45bf9b13dd61d1ee832b425c89b9f65dce..841959c3bceedd70d73029807ec33b767a8dee08 100644 (file)
@@ -31,7 +31,7 @@
 #include <fstream>
 #include <ostream>
 
-template<int dim>
+template <int dim>
 void test()
 {
   unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
index b28c7f68bd823897c8be0e5db05fb58b38ab24c7..9b7a9d4cad45f2292a077501d9b1c6618c06b319 100644 (file)
@@ -40,7 +40,7 @@
 #include <fstream>
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
index 132f3dbbb1fd36449441a7eeae57095ff5f808d0..55ccfd3e6846464b04532f390fa90bcbe6c57ec1 100644 (file)
@@ -43,7 +43,7 @@
 #include <fstream>
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
index 3fb66c0bb90ff901add7a65bf6b42cea6c86de6b..52c1d0b1bd2bc5d18c7c8b42802d8b743c11567d 100644 (file)
@@ -31,7 +31,7 @@
 #include <fstream>
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
index 4755167a35e263e701550b78ff5dc8e659650e4f..b9e85b575a7bd93d09e4674f0fcd247153102402 100644 (file)
@@ -38,7 +38,7 @@
 #include <fstream>
 #include <sstream>
 
-template<int dim>
+template <int dim>
 void test()
 {
   unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
index 1e06f7a71b2cbdd7c2559306d93543881eb31eaf..356bf589807d346014f1db3bd4d2392aca5932b9 100644 (file)
@@ -38,7 +38,7 @@
 #include <fstream>
 #include <sstream>
 
-template<int dim>
+template <int dim>
 void test()
 {
   unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
index a9b76065093b859afa1f2cd3db9ab9792f1817a0..33dff145579869a622f7a24739bd0016de90bf11 100644 (file)
@@ -53,7 +53,7 @@ const double T1 = 2.0;
 
 
 
-template<int dim>
+template <int dim>
 class FilteredDataOut : public DataOut<dim>
 {
 public:
@@ -129,7 +129,7 @@ TemperatureInitialValues<dim>::vector_value (const Point<dim> &p,
 }
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   parallel::distributed::Triangulation<dim> tr(MPI_COMM_WORLD);
index 6e63dcff8c5ea01e63facc69ac8fa68795575f26..ea980301ca477f984f41d17ff8c71945e9ac5b5b 100644 (file)
@@ -33,7 +33,7 @@
 #include <fstream>
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
index e897814000b9bb1a1bc97b92070b9eadb9a5793a..e1e2e87769b61a00ea9f8ed3510b2ce95bc710fe 100644 (file)
@@ -31,7 +31,7 @@
 #include <fstream>
 #include <ostream>
 
-template<int dim>
+template <int dim>
 void test()
 {
   unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
index 8f94846add9d0ec09c010b99e8d1cf718a66a53a..302995e9809f2654ccf47cf64159a399d8595986 100644 (file)
@@ -37,7 +37,7 @@
 #include <fstream>
 #include <ostream>
 
-template<int dim>
+template <int dim>
 void test()
 {
   unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
index 9da268da245f6aec97c076b60c79123ac24002c5..3d8650add83fd31459b9f315b4cd3e130f47f4d2 100644 (file)
@@ -49,7 +49,7 @@
 #include <fstream>
 #include <ostream>
 
-template<int dim>
+template <int dim>
 void test()
 {
   unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
index d1c0b8d43ef3d84e025bbcb36b461105261f0d03..68d55246be33c0586944a84b11bd3b3bb0ba2c60 100644 (file)
@@ -37,7 +37,7 @@
 #include <ostream>
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
index f1992ca8ac1a960bbef5065758dd88c7c6b238d8..f569c794f6019ec4b4ae423b92843fa0e69d973d 100644 (file)
@@ -44,7 +44,7 @@
 #include <fstream>
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
index a8622dbd9821ff624c5391330d3229efcad7d0b7..b057d4bd075fd0c74b6ad8023f26d4871bea0379 100644 (file)
@@ -40,7 +40,7 @@
 #include <fstream>
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
index bf4e14c9d62673969a43844337de071e4e25c702..01febacc768854e24d00696a0af6c31b0d2470d8 100644 (file)
@@ -31,7 +31,7 @@
 #include <fstream>
 #include <ostream>
 
-template<int dim>
+template <int dim>
 void test()
 {
   unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
index af4f861911a4c1a1a27efbd1b3760812732206b1..9359ccda3d0d23b8845bb4736234400aacc31ba8 100644 (file)
@@ -41,7 +41,7 @@
 
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
index b492582e7e429e9b151ce42e8bea7f5d57975639..f3683f3524a4b92b40360d52b4d4348e1148101b 100644 (file)
@@ -41,7 +41,7 @@
 
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
index 02cf47a5682816a5c40628de7f60171fb19d5ccd..97b9471dfd15b4319ad2e1e662bde6de11f779c5 100644 (file)
@@ -42,7 +42,7 @@
 
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
index c18005a8d7d299f2213eaeb911e992d74f497489..e7a302a7da6a7ff1b3d7dc104d6c158e373054a1 100644 (file)
@@ -41,7 +41,7 @@
 
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
index 4ae30fa71a31df77d2f1da8244f20295724c0907..95eef1801017cc24e187cf049fcf75b50d1a913b 100644 (file)
@@ -39,7 +39,7 @@
 #include <fstream>
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
index 82d477b0700a9095c3d6097a8f8c1a8ce79baba8..6935ccf5f2965c6b8222b1d705b5994136a6f594 100644 (file)
@@ -163,7 +163,7 @@ void generate_grid(parallel::distributed::Triangulation<3> &triangulation, int o
   triangulation.create_triangulation(vertices, cells, SubCellData());
 }
 
-template<int dim>
+template <int dim>
 void check
 (const unsigned int  orientation,
  bool                reverse)
index 9a184fd235a4747cac4223c8e77156450627b5c3..ff59d82ce02f06e34cc351c73709765944448fc6 100644 (file)
@@ -30,7 +30,7 @@
 #include <fstream>
 //#include <mpi.h>
 
-template<class v>
+template <class v>
 void testit()
 {
   GrowingVectorMemory<v> m;
index 6ce696507f7be6f53df648a10bc000b247bce9f2..60ecc488fd55c7d6b0913f0cb67fdb23deb52292 100644 (file)
@@ -43,7 +43,7 @@
 #include <fstream>
 #include <iostream>
 
-template<int dim>
+template <int dim>
 void test()
 {
   parallel::distributed::Triangulation<dim> triangulation(MPI_COMM_WORLD);
index 64883205a91f04ddfb4ce8bfb3d29464bcc82d4c..9e66f36876bcdc068bcca0e223ae9f954cf786eb 100644 (file)
@@ -34,7 +34,7 @@
 #include <fstream>
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
index 3e8a493b7aff2baf436f17d73362e211afbd1fb6..3b9ee95278fa9db84dc9d10a51366795975b97f8 100644 (file)
@@ -34,7 +34,7 @@
 #include <fstream>
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
index 77192a882cdda3cd57d04a02b0d8523a645fb6be..06293ced7bef82a0577a681a538fdbdb63d9e725 100644 (file)
@@ -44,7 +44,7 @@
 #include <boost/concept_check.hpp>
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
index 8b8906bdcfeb43a34faceb490b5462fddf9014bb..b2d0a211706b0d82f73064772a4aa975c915011d 100644 (file)
@@ -43,7 +43,7 @@
 #include <fstream>
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
index 7561803586330d302f87142158952b23a1a25dc4..f85df627042780e4b7bce2b67f54c6fd2272822b 100644 (file)
@@ -32,7 +32,7 @@
 #include <fstream>
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
index a03c8a7e342cad6cf4911e461bc6824e91d69a97..376cc67a1fbbc2112790c1660035a2e3541c68cf 100644 (file)
@@ -31,7 +31,7 @@
 
 #include <fstream>
 
-template<int dim>
+template <int dim>
 void pack_function (const typename parallel::distributed::Triangulation<dim,dim>::cell_iterator &cell,
                     const typename parallel::distributed::Triangulation<dim,dim>::CellStatus status,
                     void *data)
@@ -61,7 +61,7 @@ void pack_function (const typename parallel::distributed::Triangulation<dim,dim>
   ++some_number;
 }
 
-template<int dim>
+template <int dim>
 void unpack_function (const typename parallel::distributed::Triangulation<dim,dim>::cell_iterator &cell,
                       const typename parallel::distributed::Triangulation<dim,dim>::CellStatus status,
                       const void *data)
@@ -87,7 +87,7 @@ void unpack_function (const typename parallel::distributed::Triangulation<dim,di
     }
 }
 
-template<int dim>
+template <int dim>
 void test()
 {
   unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
index 88deae9b90ed7104da13bc58638a7b13b2d8f0bf..91ee268bbe5f33230c331cd4f80a66e735fbdd89 100644 (file)
@@ -31,7 +31,7 @@
 
 #include <fstream>
 
-template<int dim>
+template <int dim>
 void print_cells(parallel::distributed::Triangulation<dim> &tr)
 {
   for (typename Triangulation<dim>::active_cell_iterator
@@ -41,7 +41,7 @@ void print_cells(parallel::distributed::Triangulation<dim> &tr)
       deallog << cell->id() << std::endl;
 }
 
-template<int dim>
+template <int dim>
 void test()
 {
   unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
index 5ba7f624362e6c7d6437865f1f16e952c1910efb..88663976aba8e7b757bc9fd590d78b60a061d19d 100644 (file)
@@ -47,7 +47,7 @@
 #include <sstream>
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   parallel::distributed::Triangulation<2> tria(MPI_COMM_WORLD,
index 8d39914e81c99e756b4c311f1c2e7b734155a9b9..1babcd341b8d7fb8931caa9465beb59c762972e4 100644 (file)
@@ -34,7 +34,7 @@
 #include <fstream>
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
index d98e55cba6f5ab821dd165cae7f888e5435debac..37f51b847c306c16ca855570bccbf705fb00559c 100644 (file)
@@ -46,7 +46,7 @@
 #include <cstdlib>
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
index b4ae7b63514a737102e8aa972a11a0ccad24f2bc..2c070f6a713e1ee1db414a8550da419be4f4c024 100644 (file)
@@ -50,21 +50,21 @@ void f_post_refinement ()
   return;
 }
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void f_pre_coarsening_on_cell (const typename Triangulation<dim, spacedim>::cell_iterator &)
 {
   ++signal_counter_pre_coarsening_on_cell;
   return;
 }
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void f_post_refinement_on_cell (const typename Triangulation<dim, spacedim>::cell_iterator &)
 {
   ++signal_counter_post_refinement_on_cell;
   return;
 }
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void f_copy (const Triangulation<dim, spacedim> &)
 {
   ++signal_counter_copy;
@@ -84,7 +84,7 @@ void f_any_change ()
 }
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void test()
 {
   signal_counter_create = 0;
index 85c807957bc9f490ced44b874e01b43dd41f3259..217c97739fc9469823aad605174582c8c76d554e 100644 (file)
@@ -29,7 +29,7 @@
 // calls and then compare the result against n_active_cells reported by Tria
 // object. Absolute value change in n_active_cells is not concerned in this test.
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 class SignalListener
 {
 public:
@@ -77,7 +77,7 @@ private:
 };
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void test()
 {
   typedef parallel::distributed::Triangulation<dim, spacedim> TriaType;
index ba7b98da953eefdea486b03f97ff88ca2b5dc09a..5250e66849d7a7327c1cc84ca7fff6fcec5cca87 100644 (file)
@@ -32,7 +32,7 @@
 // This test is based on tria_signals_02. The difference is here we have random
 // and mix refinement and coarsening.
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 class SignalListener
 {
 public:
@@ -80,7 +80,7 @@ private:
 };
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void test()
 {
   typedef parallel::distributed::Triangulation<dim, spacedim> TriaType;
index 10754067e3038acdc95343a52b1e1a83932cdd44..3b32c298e2644208bca588d7b1ced6813c7b807d 100644 (file)
@@ -33,7 +33,7 @@
 // smoothing flags enabled. Also increase refine fraction to one third to prevent
 // refine flags getting smoothed out.
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 class SignalListener
 {
 public:
@@ -81,7 +81,7 @@ private:
 };
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void test()
 {
   typedef parallel::distributed::Triangulation<dim, spacedim> TriaType;
index 54188463e9864ee994567f1e3c728ac40b3daee5..663f00e019b28718c784c1ac1a778c7d5f82a7c3 100644 (file)
@@ -33,7 +33,7 @@
 // that p4est is doing mesh smoothing beyond class Triangulation. The case setup
 // is borrowed from tests/distributed_grids/2d_refinement_10.
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 class SignalListener
 {
 public:
@@ -81,7 +81,7 @@ private:
 };
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void test()
 {
   typedef parallel::distributed::Triangulation<dim, spacedim> TriaType;
index ab0d1e160e97d1cab4671aa8a1d88c6328140a24..3ae58477c1d36e414954141a7277e03e638ecd7e 100644 (file)
@@ -33,7 +33,7 @@
 //
 // This test is modified from tria_signals_04.
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 class SignalListener
 {
 public:
@@ -81,7 +81,7 @@ private:
 };
 
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void test()
 {
   typedef parallel::distributed::Triangulation<dim, spacedim> TriaType;
index b4c279d27e6ecd24e1a0af79de5eae76b4e2f176..9a88748ea633ac43e9512bf2a2409a6481754957 100644 (file)
@@ -408,7 +408,7 @@ namespace Step50
       }
   }
 
-  template<typename VECTOR>
+  template <typename VECTOR>
   class MGCoarseAMG : public MGCoarseGridBase<VECTOR>
   {
   public:
index 6f779c54d543bfa2d535bb2fd05ba0efb923caef..4b86beb1c8a8ce71eb27a7f8f0e4ab5e235697da 100644 (file)
@@ -62,7 +62,7 @@ reinit_vector (const dealii::DoFHandler<dim,spacedim> &mg_dof,
 }
 
 
-template<int dim>
+template <int dim>
 void refine_mesh (Triangulation<dim> &triangulation)
 {
   bool cell_refined = false;
index 1a2d4c047ebec331d18cba67471474ea818b52a3..487effb5c59ad90b946e83f7590b1c00bbb3abb7 100644 (file)
@@ -62,7 +62,7 @@ reinit_vector (const dealii::DoFHandler<dim,spacedim> &mg_dof,
 }
 
 
-template<int dim>
+template <int dim>
 void refine_mesh (Triangulation<dim> &triangulation)
 {
   bool cell_refined = false;
index a2dc3d27977372a3e28e7428c2b0bd4a861187ff..5083fee845e67f86321a9f3c2bc4f6b82f03cd7e 100644 (file)
@@ -43,7 +43,7 @@ public:
   /**
   * Apply preconditioner.
   */
-  template<typename VectorType>
+  template <typename VectorType>
   void vmult (VectorType &, const VectorType &) const;
 
   /**
@@ -53,12 +53,12 @@ public:
    * the same as
    * vmult().
    */
-  template<typename VectorType>
+  template <typename VectorType>
   void Tvmult (VectorType &, const VectorType &) const;
   /**
    * Apply preconditioner, adding to the previous value.
    */
-  template<typename VectorType>
+  template <typename VectorType>
   void vmult_add (VectorType &, const VectorType &) const;
 
   /**
@@ -68,7 +68,7 @@ public:
    * the same as
    * vmult_add().
    */
-  template<typename VectorType>
+  template <typename VectorType>
   void Tvmult_add (VectorType &, const VectorType &) const;
 
 private:
@@ -78,31 +78,31 @@ private:
 
 //----------------------------------------------------------------------//
 
-template<typename number>
+template <typename number>
 ScalingMatrix<number>::ScalingMatrix(number factor)
   :
   factor(factor)
 {}
 
 
-template<typename number>
-template<typename VectorType>
+template <typename number>
+template <typename VectorType>
 inline void
 ScalingMatrix<number>::vmult (VectorType &dst, const VectorType &src) const
 {
   dst.equ(factor, src);
 }
 
-template<typename number>
-template<typename VectorType>
+template <typename number>
+template <typename VectorType>
 inline void
 ScalingMatrix<number>::Tvmult (VectorType &dst, const VectorType &src) const
 {
   dst.equ(factor, src);
 }
 
-template<typename number>
-template<typename VectorType>
+template <typename number>
+template <typename VectorType>
 inline void
 ScalingMatrix<number>::vmult_add (VectorType &dst, const VectorType &src) const
 {
@@ -111,8 +111,8 @@ ScalingMatrix<number>::vmult_add (VectorType &dst, const VectorType &src) const
 
 
 
-template<typename number>
-template<typename VectorType>
+template <typename number>
+template <typename VectorType>
 inline void
 ScalingMatrix<number>::Tvmult_add (VectorType &dst, const VectorType &src) const
 {
@@ -121,7 +121,7 @@ ScalingMatrix<number>::Tvmult_add (VectorType &dst, const VectorType &src) const
 
 //----------------------------------------------------------------------//
 
-template<typename MatrixType, class RELAX>
+template <typename MatrixType, class RELAX>
 void check_smoother(const MGLevelObject<MatrixType> &m,
                     const MGLevelObject<RELAX> &r)
 {
index 1e03bc08f3899a6f927c20dc71cba2523fdc22b5..fcc0fd8949385320512ba351e41b1987ef7c0008 100644 (file)
@@ -59,7 +59,7 @@ reinit_vector (const dealii::DoFHandler<dim,spacedim> &mg_dof,
 }
 
 
-template<int dim>
+template <int dim>
 void refine_mesh (Triangulation<dim> &triangulation)
 {
   bool cell_refined = false;
index ec1d21241dbd44247918969d4261dca1eb55376d..784bd4126ba7ec24a7359015e76db244317faa11 100644 (file)
@@ -61,7 +61,7 @@ reinit_vector (const dealii::DoFHandler<dim,spacedim> &mg_dof,
 }
 
 
-template<int dim>
+template <int dim>
 void refine_mesh (Triangulation<dim> &triangulation)
 {
   bool cell_refined = false;
index 8a667b1f4bcf15c980aece732cb94e91f6a05129..1555b5dd327ef4babe58747da6d4352f7d8b004e 100644 (file)
@@ -86,7 +86,7 @@ void print_matrix (const FullMatrix<double> &m)
 }
 
 
-template<int dim>
+template <int dim>
 void refine_mesh (Triangulation<dim> &triangulation)
 {
   bool cell_refined = false;
index 65053d111edb1bc169e6347d590cdcf53fabd2e2..03d5a7e4756e947ca4745262a41cb4e4ee488b26 100644 (file)
@@ -86,7 +86,7 @@ void print_matrix (const FullMatrix<double> &m)
 }
 
 
-template<int dim>
+template <int dim>
 void refine_mesh (Triangulation<dim> &triangulation)
 {
   bool cell_refined = false;
index 1a33ab8b9582dd4955b92349cd31f10fac74ec69..4bafaf36d9df8d6c97ffaab5ffbf8d1543e5cd61 100644 (file)
@@ -87,7 +87,7 @@ void print_matrix (const FullMatrix<double> &m)
 }
 
 
-template<int dim>
+template <int dim>
 void refine_mesh (Triangulation<dim> &triangulation)
 {
   bool cell_refined = false;
index ed78526c3506b81b0df80260c0377234881ebf96..0eb37daa21524d1e0ea556c4578e0f4508032c6a 100644 (file)
@@ -86,7 +86,7 @@ void print_matrix (const FullMatrix<double> &m)
 }
 
 
-template<int dim>
+template <int dim>
 void refine_mesh (Triangulation<dim> &triangulation)
 {
   bool cell_refined = false;
index ab5d52109e6d2e23ebb5e22cc708b2567b336ffb..4c1e2c46a0e460c2991579d420a7c4c6e3e2f8b6 100644 (file)
@@ -87,7 +87,7 @@ void print_matrix (const FullMatrix<double> &m)
 }
 
 
-template<int dim>
+template <int dim>
 void refine_mesh (Triangulation<dim> &triangulation)
 {
   bool cell_refined = false;
index df006f786ba88ca755222009dc386443a80fde7e..763a0181b09da32f8381bdfd3d52fefdb2de708b 100644 (file)
@@ -86,7 +86,7 @@ void print_matrix (const FullMatrix<double> &m)
 }
 
 
-template<int dim>
+template <int dim>
 void refine_mesh (Triangulation<dim> &triangulation)
 {
   bool cell_refined = false;
index 46df3a16a95c08e6f2b1aa8344784dde908fcc48..fdbcc981a9364e0e37c9103d84e6807cc38fe8f7 100644 (file)
@@ -88,7 +88,7 @@ void print_matrix (const FullMatrix<double> &m)
 }
 
 
-template<int dim>
+template <int dim>
 void refine_mesh (Triangulation<dim> &triangulation)
 {
   bool cell_refined = false;
index ed00bd0b8621a8eb07ba07718c5638ab84b6f3c9..5d6de31e4e4e7d95b68ea0dfc0ea38499b8f6da8 100644 (file)
@@ -87,7 +87,7 @@ void print_matrix (const FullMatrix<double> &m)
 }
 
 
-template<int dim>
+template <int dim>
 void refine_mesh (Triangulation<dim> &triangulation)
 {
   bool cell_refined = false;
index ba794e42a321bcb2c23964326d5016fddbc9ed0d..9dc2ba75389e60429ece17dfd46cea336def93d6 100644 (file)
@@ -42,7 +42,7 @@
 using namespace std;
 
 
-template<int dim>
+template <int dim>
 void refine_mesh (Triangulation<dim> &triangulation)
 {
   bool cell_refined = false;
index c5be172d7b81dc71272cf0ff5f8afbd58bea748d..720f0c0892f2a22a823ef6859bd11a13824bd871 100644 (file)
@@ -40,7 +40,7 @@
 #include <fstream>
 
 
-template<int dim>
+template <int dim>
 class MySquareFunction : public Function<dim>
 {
 public:
index f332c0d289b3eb34b0afa4105eb59a7e3b25ea5f..3d80415914bd95f6080d2e610875bdb167b189b2 100644 (file)
@@ -40,7 +40,7 @@
 #include <deal.II/fe/fe_dgq.h>
 
 
-template<int dim>
+template <int dim>
 class FilteredDataOut : public DataOut<dim>
 {
 public:
index 46e6a918a00efd18694c1e6bfcd3d8e3460a3b20..73175f0ff54b2bc44b196a877df67a3ac0488ee6 100644 (file)
@@ -42,7 +42,7 @@ using namespace std;
 const double a=4,b=5;
 
 
-template<int dim>
+template <int dim>
 class MyFunction : public Function<dim>
 {
 public:
index 3d398811dbbfd69690b882a05fb55c5c741fdd86..4e222749b344285eae68d118f5851d4fd849b22b 100644 (file)
@@ -41,7 +41,7 @@ using namespace std;
 const double a=4,b=5;
 
 
-template<int dim>
+template <int dim>
 class MyFunction : public Function<dim>
 {
 public:
index f8f28a282d25576940d4f5a42feb1c839eb60d8f..ed7aa218f328241c79378fdb04529767f6c05e52 100644 (file)
@@ -37,7 +37,7 @@
 #include <fstream>
 
 
-template<int dim>
+template <int dim>
 class MySquareFunction : public Function<dim>
 {
 public:
index 6ec450ae4be27ae3f83671481327b09674a4583e..35be164a94a60d106648e7c6b39928ff18020d8d 100644 (file)
@@ -97,7 +97,7 @@
 
 using namespace dealii;
 
-template<int dim>
+template <int dim>
 class MyFunction : public dealii::Function<dim>
 {
 public:
@@ -112,7 +112,7 @@ private:
   const double k;
 };
 
-template<int dim>
+template <int dim>
 MyFunction<dim>::MyFunction(const double k)
   :
   dealii::Function<dim>(1),
@@ -121,7 +121,7 @@ MyFunction<dim>::MyFunction(const double k)
 
 }
 
-template<int dim>
+template <int dim>
 double MyFunction<dim>::value(const dealii::Point<dim> &point,
                               const unsigned int ) const
 {
@@ -133,14 +133,14 @@ double MyFunction<dim>::value(const dealii::Point<dim> &point,
     return k * x;
 }
 
-template<int dim>
+template <int dim>
 double MyFunction<dim>::get_k() const
 {
   return k;
 }
 
 // neuman bc
-template<int dim>
+template <int dim>
 class NeumanBC : public dealii::Function<dim>
 {
 public:
@@ -155,7 +155,7 @@ private:
   const double c;
 };
 
-template<int dim>
+template <int dim>
 NeumanBC<dim>::NeumanBC(const double c)
   :
   dealii::Function<dim>(1),
@@ -163,14 +163,14 @@ NeumanBC<dim>::NeumanBC(const double c)
 {
 }
 
-template<int dim>
+template <int dim>
 double NeumanBC<dim>::value(const dealii::Point<dim> &point,
                             const unsigned int ) const
 {
   return c;
 }
 
-template<int dim>
+template <int dim>
 double NeumanBC<dim>::get_c() const
 {
   return c;
@@ -178,17 +178,17 @@ double NeumanBC<dim>::get_c() const
 
 // helper function to get diagonal and
 // area of the squared element with lenght h
-template<int dim>
+template <int dim>
 void get_h_area(double &h, double &a, const double L);
 
-template<>
+template <>
 void get_h_area<2>(double &h, double &a, const double L)
 {
   h = L;
   a = L;
 }
 
-template<>
+template <>
 void get_h_area<3>(double &h, double &a, const double L)
 {
   h = std::sqrt(2.0)*L;
@@ -197,17 +197,17 @@ void get_h_area<3>(double &h, double &a, const double L)
 
 // helper function to get diagonal and area of the
 // h-refined face.
-template<int dim>
+template <int dim>
 void get_h_area_sub(double &h, double &a, const double L);
 
-template<>
+template <>
 void get_h_area_sub<2>(double &h, double &a, const double L)
 {
   h = L/2;
   a = L/2;
 }
 
-template<>
+template <>
 void get_h_area_sub<3>(double &h, double &a, const double L)
 {
   h = std::sqrt(2.0)*L/2;
@@ -215,7 +215,7 @@ void get_h_area_sub<3>(double &h, double &a, const double L)
 }
 
 // output for inspection
-template<int dim>
+template <int dim>
 void output(const std::string          name,
             const Triangulation<dim>  &triangulation,
             const hp::DoFHandler<dim> &dof_handler,
@@ -246,7 +246,7 @@ void output(const std::string          name,
 }
 
 // case 1)
-template<int dim>
+template <int dim>
 void test_neumann(const NeumanBC<dim> &func)
 {
   deallog << "NeumanBC case:"<<std::endl;
@@ -326,7 +326,7 @@ void test_neumann(const NeumanBC<dim> &func)
 }
 
 // case 2)
-template<int dim>
+template <int dim>
 void test_regular(const MyFunction<dim> &func)
 {
   deallog << std::endl;
@@ -438,7 +438,7 @@ void test_regular(const MyFunction<dim> &func)
 }
 
 // case 3)
-template<int dim>
+template <int dim>
 void test_irregular(const MyFunction<dim> &func)
 {
   deallog << std::endl;
@@ -586,7 +586,7 @@ void test_irregular(const MyFunction<dim> &func)
   dof_handler.clear();
 }
 
-template<int dim>
+template <int dim>
 class MySecondFunction : public dealii::Function<dim>
 {
 public:
@@ -596,7 +596,7 @@ public:
                        const unsigned int component = 0 ) const;
 };
 
-template<int dim>
+template <int dim>
 MySecondFunction<dim>::MySecondFunction()
   :
   dealii::Function<dim>(1)
@@ -604,7 +604,7 @@ MySecondFunction<dim>::MySecondFunction()
 
 }
 
-template<int dim>
+template <int dim>
 double MySecondFunction<dim>::value(const dealii::Point<dim> &point,
                                     const unsigned int ) const
 {
@@ -616,7 +616,7 @@ double MySecondFunction<dim>::value(const dealii::Point<dim> &point,
   return (1.-x)*(1.-y)*(1.-y)+std::pow(1.0-y,4)*std::exp(-x);
 }
 
-template<int dim>
+template <int dim>
 void test(const MySecondFunction<dim> &func)
 {
   deallog << std::endl;
index ef1a19ccbbf64fdbb90b7bbcb514a4701a58094a..34b0267346e36d0a89203b911b92124e6cb827e1 100644 (file)
@@ -35,7 +35,7 @@
 #include <fstream>
 
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr,
            const FiniteElement<dim> &fe)
 {
@@ -60,7 +60,7 @@ void test (const Triangulation<dim> &tr,
 }
 
 
-template<int dim>
+template <int dim>
 void test_hyper_cube()
 {
   Triangulation<dim> tr;
index 4543851b7ea4faee67afd6e3ae668a762cba00ad..99a32d2456756f518283aa69d2c5da10dca37b92 100644 (file)
@@ -37,7 +37,7 @@
 
 
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr,
            const FiniteElement<dim> &fe)
 {
@@ -62,7 +62,7 @@ void test (const Triangulation<dim> &tr,
 }
 
 
-template<int dim>
+template <int dim>
 void test_hyper_cube()
 {
   Triangulation<dim> tr;
index 6e343768d2e4e86330dd5378beead5068999689f..903dafa4a35d7a3e138adfa632f13732a99337ec 100644 (file)
@@ -38,7 +38,7 @@
 #include <fstream>
 
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr,
            const FiniteElement<dim> &fe)
 {
@@ -59,7 +59,7 @@ void test (const Triangulation<dim> &tr,
 
 
 
-template<int dim>
+template <int dim>
 void test_hyper_sphere()
 {
   Triangulation<dim> tr;
index 810711fcb60035e64d22fa4703cf17b145f4bb6a..c20f54f8fee34d9debab72dc41b16b3db74e4720 100644 (file)
@@ -71,7 +71,7 @@ public:
 
 
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr,
            const FiniteElement<dim> &fe)
 {
@@ -118,7 +118,7 @@ void test (const Triangulation<dim> &tr,
 
 
 
-template<int dim>
+template <int dim>
 void test_hyper_sphere()
 {
   Triangulation<dim> tr;
index 34bcf8736f7aaf3c46f46bcc1d214a6d49b09a07..d7c0ca01b45da50ebe9144c0c185573a920a0f53 100644 (file)
@@ -45,7 +45,7 @@
 
 
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr,
            const FiniteElement<dim> &fe)
 {
@@ -72,7 +72,7 @@ void test (const Triangulation<dim> &tr,
 }
 
 
-template<int dim>
+template <int dim>
 void test_hyper_cube()
 {
   Triangulation<dim> tr;
index 9a2f84f49477914719f380846b0da1d55c7cfd01..63d38f22c54f5af7a62d843b44c78150da474c69 100644 (file)
@@ -37,7 +37,7 @@
 
 
 
-template<int dim>
+template <int dim>
 void test_hyper_cube()
 {
   Triangulation<dim> tr;
index eb0d35ad8172a1c692eb16751a880e8ee27c0dc5..99f05b8ae9f9ea8782a79c4be6a4b74fdfe5406a 100644 (file)
@@ -43,7 +43,7 @@
 #include <fstream>
 
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr,
            const FiniteElement<dim> &fe)
 {
@@ -60,7 +60,7 @@ void test (const Triangulation<dim> &tr,
 }
 
 
-template<int dim>
+template <int dim>
 void test_hyper_cube()
 {
   Triangulation<dim> tr;
index 9e47a059cbc7e51147249a91b4956f32823afaa8..4c22b890eef71ba27e68d21f4fbbb023f60d1708 100644 (file)
@@ -31,7 +31,7 @@
 #include <fstream>
 
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr,
            const hp::FECollection<dim> &fe)
 {
@@ -56,7 +56,7 @@ void test (const Triangulation<dim> &tr,
 }
 
 
-template<int dim>
+template <int dim>
 void test_hyper_cube()
 {
   Triangulation<dim> tr;
index d542c3f4f71e40dd06dda523d2b6a8db97dbd853..149398a9e07fbe508247e043ca593d0d5632ed52 100644 (file)
@@ -33,7 +33,7 @@
 
 
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr,
            const hp::FECollection<dim> &fe)
 {
@@ -58,7 +58,7 @@ void test (const Triangulation<dim> &tr,
 }
 
 
-template<int dim>
+template <int dim>
 void test_hyper_cube()
 {
   Triangulation<dim> tr;
index 53228b035d527b0cedc995fa953b833421afe1c0..4ee6c663a3c8f9d0730d593a4ad1c8faf0e71bdc 100644 (file)
@@ -32,7 +32,7 @@
 #include <fstream>
 
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr,
            const hp::FECollection<dim> &fe)
 {
@@ -53,7 +53,7 @@ void test (const Triangulation<dim> &tr,
 
 
 
-template<int dim>
+template <int dim>
 void test_hyper_sphere()
 {
   Triangulation<dim> tr;
index 08d53f877e847a9efd70ce239dab84a739d64d67..9d511a8d19a69e64da322943c9eb14d4e30d132c 100644 (file)
@@ -64,7 +64,7 @@ public:
 
 
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr,
            const hp::FECollection<dim> &fe)
 {
@@ -111,7 +111,7 @@ void test (const Triangulation<dim> &tr,
 
 
 
-template<int dim>
+template <int dim>
 void test_hyper_sphere()
 {
   Triangulation<dim> tr;
index a819c80c00d537acc8e91630b27c95b45c7a5546..b5bbd8f9b7ae2819aa6af486a02fc8b65b2c5d48 100644 (file)
@@ -36,7 +36,7 @@
 
 
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr,
            const hp::FECollection<dim> &fe)
 {
@@ -63,7 +63,7 @@ void test (const Triangulation<dim> &tr,
 }
 
 
-template<int dim>
+template <int dim>
 void test_hyper_cube()
 {
   Triangulation<dim> tr;
index 997661fb6da704f9165176f3f02ed64aaf2ac663..50b6de4fe2a31eb5e90b765af5d50827a809f051 100644 (file)
@@ -35,7 +35,7 @@
 #include <fstream>
 
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr,
            const FiniteElement<dim> &fe)
 {
@@ -60,7 +60,7 @@ void test (const Triangulation<dim> &tr,
 }
 
 
-template<int dim>
+template <int dim>
 void test_hyper_cube()
 {
   Triangulation<dim> tr;
index bf687ae9ead564943dc3d7a463051c3e084a4888..4d4e1dcd188e3477dd3db4873dbe48955a72c7cd 100644 (file)
@@ -37,7 +37,7 @@
 
 
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr,
            const FiniteElement<dim> &fe)
 {
@@ -62,7 +62,7 @@ void test (const Triangulation<dim> &tr,
 }
 
 
-template<int dim>
+template <int dim>
 void test_hyper_cube()
 {
   Triangulation<dim> tr;
index 4bb896c9e661893f44c6be47d06ae1be04bcdab9..beb24fb86dd789119d27bae6671c838d2302b900 100644 (file)
@@ -33,7 +33,7 @@
 #include <fstream>
 
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr,
            const FiniteElement<dim> &fe)
 {
@@ -54,7 +54,7 @@ void test (const Triangulation<dim> &tr,
 
 
 
-template<int dim>
+template <int dim>
 void test_hyper_sphere()
 {
   Triangulation<dim> tr;
index 77db5df5c2e10ae888b3e27954a0cd78d031b031..2532278eaf5bc393efebae9af36c010149628f6e 100644 (file)
@@ -31,7 +31,7 @@
 #include <fstream>
 
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr,
            const hp::FECollection<dim> &fe)
 {
@@ -59,7 +59,7 @@ void test (const Triangulation<dim> &tr,
 }
 
 
-template<int dim>
+template <int dim>
 void test_hyper_cube()
 {
   Triangulation<dim> tr;
index 98b7e61bdcea55c9c0434d436303dd7aa37dbf6e..50b891e02fc41750b70f7d5035f9b70bcfad811b 100644 (file)
@@ -36,7 +36,7 @@
 #include <fstream>
 
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr,
            const FiniteElement<dim> &fe)
 {
@@ -96,7 +96,7 @@ void test (const Triangulation<dim> &tr,
 }
 
 
-template<int dim>
+template <int dim>
 void test_hyper_cube()
 {
   Triangulation<dim> tr;
index e52ee80c6dab965396e4b1deae2118d00bfcfd8b..4924634e5b38cd633048db853a5e4cf1fd4195cc 100644 (file)
@@ -51,7 +51,7 @@ public:
 };
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   // create 2 triangulations with the
index 073612fc569d23e667c2c92ba28503444afa3cfc..f7ffcb19a54c7dd9b7cae6e0fc8ecb3dc88435d4 100644 (file)
@@ -61,7 +61,7 @@ public:
 };
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   HyperBallBoundary<dim> boundary;
index ac9394d0e540c82dbd17fd9723eb6619e7e80024..c259149aa0bc15331f820f9c99d9b65a5a126a3d 100644 (file)
@@ -51,7 +51,7 @@ public:
 };
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   // create 2 triangulations with the
index 3d389f6e0c1eb472a43b43d9e20c0d66c73c80b1..673e980be961ead83e97345d1b811a245b568737 100644 (file)
@@ -40,7 +40,7 @@
 #include <fstream>
 
 
-template<int dim>
+template <int dim>
 class MySquareFunction : public Function<dim>
 {
 public:
index 4f603971ee9b2f71fc2a2a8370dc2a4e8612386a..fe4a5495253cdfa2af189dd4a68f4e84823648a7 100644 (file)
@@ -33,7 +33,7 @@
 /**
  * A vector-valued polynomial for testing RT elements.
  */
-template<int dim>
+template <int dim>
 class TestFunction : public Function<dim>
 {
 public:
@@ -48,14 +48,14 @@ private:
 };
 
 
-template<int dim>
+template <int dim>
 TestFunction<dim>::TestFunction (unsigned int p)
   :
   Function<dim>(dim), degree(p)
 {}
 
 
-template<int dim>
+template <int dim>
 void
 TestFunction<dim>::vector_value_list (const std::vector<Point<dim> > &points,
                                       std::vector<Vector<double> >   &values) const
@@ -87,7 +87,7 @@ TestFunction<dim>::vector_value_list (const std::vector<Point<dim> > &points,
 
 
 
-template<int dim>
+template <int dim>
 double integrate_error(const DoFHandler<dim> &dof,
                        FEFaceValues<dim> &fe,
                        const Vector<double> &u,
@@ -120,7 +120,7 @@ double integrate_error(const DoFHandler<dim> &dof,
 }
 
 
-template<int dim>
+template <int dim>
 void test_projection (const Triangulation<dim> &tr,
                       const FiniteElement<dim> &fe)
 {
@@ -162,7 +162,7 @@ void test_projection (const Triangulation<dim> &tr,
 }
 
 
-template<int dim>
+template <int dim>
 void test_hyper_cube(const FiniteElement<dim> &fe)
 {
   Triangulation<dim> tr;
index 1e0aeb0801cc35e4ce12617524d894b7c73e1a7e..cacf6cf66d585529d355b401331a7297e31df4fb 100644 (file)
@@ -37,7 +37,7 @@
 #include <fstream>
 
 
-template<int dim>
+template <int dim>
 void test (const Triangulation<dim> &tr,
            const FiniteElement<dim> &fe)
 {
@@ -95,7 +95,7 @@ void test (const Triangulation<dim> &tr,
 }
 
 
-template<int dim>
+template <int dim>
 void test_hyper_cube()
 {
   Triangulation<dim> tr;
index ddad97156c81d323f78b2a30d1a427a0590be705..3082f91f38b84293662d1f87fb2a48edff9ae96b 100644 (file)
@@ -42,7 +42,7 @@
 #include <fstream>
 
 
-template<int dim>
+template <int dim>
 class MySquareFunction : public Function<dim>
 {
 public:
index 132618113f6717289faccfb1891c0055063117f4..522f3952da56eca9098134da165bfc91780eb392 100644 (file)
@@ -44,7 +44,7 @@
 
 
 
-template<int dim>
+template <int dim>
 class MySquareFunction : public Function<dim>
 {
 public:
index 1b6c9f203341b4fe2376aee35f63255f9f01adc8..78be31576417d8d078858f1e0cd6fb26f9ba880e 100644 (file)
@@ -43,7 +43,7 @@
 #include <fstream>
 
 
-template<int dim>
+template <int dim>
 class MySquareFunction : public Function<dim>
 {
 public:
index d42fe9ace59a1fbd68913384fe172d6df80019be..50362286fe1a16188bdf6d2d684d882117d30bde 100644 (file)
@@ -43,7 +43,7 @@
 #include <fstream>
 
 
-template<int dim>
+template <int dim>
 class MySquareFunction : public Function<dim>
 {
 public:
index 4f03477c5b9f9fa72aa412606b35d563bb75aaa2..f4fe64889b725eaff83c5906a76970fe08d1f2a3 100644 (file)
@@ -42,7 +42,7 @@
 #include <fstream>
 
 
-template<int dim>
+template <int dim>
 class MySquareFunction : public Function<dim>
 {
 public:
index 6de936827c88ad800015ce3a629afddf72edc755..0109919ba4b918aab6c49908693dada1ea1b0f79 100644 (file)
@@ -43,7 +43,7 @@
 #include <fstream>
 
 
-template<int dim>
+template <int dim>
 class MySquareFunction : public Function<dim>
 {
 public:
index 0e0eea128e57a472f5747ea3e06bcd1024c4eff5..d90e20d203604e3e0a2197bdaabc703440f45baf 100644 (file)
@@ -30,7 +30,7 @@
 #include <vector>
 
 
-template<typename MatrixType>
+template <typename MatrixType>
 void test (MatrixType &m)
 {
   m.add(0,0,1);
index 988f1b4e3e447f6f3270d6a30c83da43e14ffdf0..44b2ef05e6ae35558661870e8600a5d1e05eaaec 100644 (file)
@@ -36,7 +36,7 @@
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
+template <typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
 void
 check_solve(SolverType          &solver,
             const SolverControl &solver_control,
index 26052bf9863e296e2e77ca37db2dfc45a6b6b2ca..09e9c664eb6b15c6dcd56195898c0213dae1eb3e 100644 (file)
@@ -38,7 +38,7 @@
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
+template <typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
 void
 check_solve(SolverType          &solver,
             const SolverControl &solver_control,
index ac76462285b5502f0fb4ac2f44ac84bb72203ec3..268e208b0e61b5790a60a11ca82218079e3adfed 100644 (file)
@@ -38,7 +38,7 @@
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
+template <typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
 void
 check_solve(SolverType          &solver,
             const SolverControl &solver_control,
index 5a28f798854061ef507e33776a6da1b83a2cf2a8..49fa00fd1a48336776c34ae1b1cb7686568e9b5e 100644 (file)
@@ -37,7 +37,7 @@
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
+template <typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
 void
 check_solve(SolverType          &solver,
             const SolverControl &solver_control,
index 3da07e9a3b54f385b23907a14cc5dfa106eb2817..291378d5db49d7bf719e46b867df78182d5efd05 100644 (file)
@@ -36,7 +36,7 @@
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
+template <typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
 void
 check_solve(SolverType          &solver,
             const SolverControl &solver_control,
index ca0cdc1a09336ef4f64c204e3806bafb1a672993..877053b04e219902acc35db2b74cdb600d323481 100644 (file)
@@ -31,7 +31,7 @@
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
+template <typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
 void
 check_solve(SolverType          &solver,
             const SolverControl &solver_control,
index 6d0ea169f05ff3510aa95a23a63eb497937bf5f5..32b1768d202b6f757f68176de189e1f8a276fa33 100644 (file)
@@ -31,7 +31,7 @@
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
+template <typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
 void
 check_solve(SolverType          &solver,
             const SolverControl &solver_control,
index b3402712d12f1c628db234dedc6be01ade089432..5163b149a9d0da77e2ceb0f7c200685622b927b3 100644 (file)
@@ -32,7 +32,7 @@
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
+template <typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
 void
 check_solve(SolverType          &solver,
             const SolverControl &solver_control,
index 51c9e7742254c4d6f40e48ca64647d5d54f6f3d2..594721f7b8050228647b1d9303b912614a8b5707 100644 (file)
@@ -33,7 +33,7 @@
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
+template <typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
 void
 check_solve(SolverType          &solver,
             const SolverControl &solver_control,
index ea59ec342391f189b62a069cde2a0a7720953838..4e82eb6fce376885fa93434ef911f0e574fb5dae 100644 (file)
@@ -31,7 +31,7 @@
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
+template <typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
 void
 check_solve(SolverType          &solver,
             const SolverControl &solver_control,
index b1de5b810c77c44c8c971e38a107dc9b3f2d5bfb..7d4cb5e4cf34e37b4d92dcb10708f8a3e4fa46eb 100644 (file)
@@ -31,7 +31,7 @@
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
+template <typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
 void
 check_solve(SolverType          &solver,
             const SolverControl &solver_control,
index faf8d63d802ace6a6dc27b4a3a912aae5a8b904c..3fc5c010b7d4be0730d0a48c49318192e5cefdbe 100644 (file)
@@ -31,7 +31,7 @@
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
+template <typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
 void
 check_solve(SolverType          &solver,
             const SolverControl &solver_control,
index 628b3a911e54d6a47de6956a23aa640c69c05959..4316a41c25f1e3392f99919a47a88fc53f3b729f 100644 (file)
@@ -32,7 +32,7 @@
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
+template <typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
 void
 check_solve(SolverType          &solver,
             const SolverControl &solver_control,
index 3e99f147e2d9f323cfed6d94628efcc78cafc115..a73225564513090082301a4eebcec7981b4b9d29 100644 (file)
@@ -31,7 +31,7 @@
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
+template <typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
 void
 check_solve(SolverType          &solver,
             const SolverControl &solver_control,
index 2b42ca367930bf6ceb957ba38d59f3cdf8bbec32..3923263fc3ecbfba56c8eae6ae03a86613405456 100644 (file)
@@ -31,7 +31,7 @@
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
+template <typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
 void
 check_solve(SolverType          &solver,
             const SolverControl &solver_control,
index 70c88ab39b36070c04dcba24f41b0e272d511d9b..54cf6d49e11c948e2cba9d02c57d6340e44f0dcb 100644 (file)
@@ -31,7 +31,7 @@
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
+template <typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
 void
 check_solve(SolverType          &solver,
             const SolverControl &solver_control,
index c0e15d2c79e2553133458837bd9312028fca1be5..16af79ec64f08b543f88b27a50169416f7534a78 100644 (file)
@@ -31,7 +31,7 @@
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
+template <typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
 void
 check_solve(SolverType          &solver,
             const SolverControl &solver_control,
index 329eb8bf7647c532265f193dce01663dcca7612e..bcdbe9330d80108f2d1a94e6eeb95740074e02b7 100644 (file)
@@ -31,7 +31,7 @@
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
+template <typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
 void
 check_solve(SolverType          &solver,
             const SolverControl &solver_control,
index 757c6f4cfaccb194da6085881f0f4298b25838de..5884307595c26dcae3ae001b22b53f7c9fefa8b1 100644 (file)
@@ -31,7 +31,7 @@
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
+template <typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
 void
 check_solve(SolverType          &solver,
             const SolverControl &solver_control,
index d8ac25cf28295232803a17dca78e7857dd697d37..bbc8741b6a3242e2b9425e28043c6f3ad08c1265 100644 (file)
@@ -31,7 +31,7 @@
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
+template <typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
 void
 check_solve(SolverType          &solver,
             const SolverControl &solver_control,
index 67fae993d5e2a5107959958eaf5a56e782758e8e..6916a06cbd46f77be5c632c2b9707c1941a5659d 100644 (file)
@@ -31,7 +31,7 @@
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
+template <typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
 void
 check_solve(SolverType          &solver,
             const SolverControl &solver_control,
index 094a2256bd9beff02e73360a511b660edb15d9bc..03abcd32135e4f2b934f9da6a658bfb64ebd1b57 100644 (file)
@@ -35,7 +35,7 @@
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
+template <typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
 void
 check_solve(SolverType          &solver,
             const SolverControl &solver_control,
index 2e438591bdc6efd5b1cc561f73bfe9d8d103b35b..b5e5997f7cb0c095e96c8347ffa83eb9370c5cea 100644 (file)
@@ -31,7 +31,7 @@
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
+template <typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
 void
 check_solve(SolverType          &solver,
             const SolverControl &solver_control,
index 99965ee9d64e99ff2c47bf264d9f38e520fd3fc1..da8dd49cee6664f72dca97a6b8fbcbe834d73b42 100644 (file)
@@ -31,7 +31,7 @@
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
+template <typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
 void
 check_solve(SolverType          &solver,
             const SolverControl &solver_control,
index dd6e419aded989a65ae381ebe5379faa072872f2..959a05f7269d7e0d52c67629c4192af73cc71323 100644 (file)
@@ -31,7 +31,7 @@
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
+template <typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
 void
 check_solve(SolverType          &solver,
             const SolverControl &solver_control,
index b58ed172d99d0492c5f33d4e04e4b941b50d1b2b..193e35766882e70c20e3f40a08b3c1ea6572cdad 100644 (file)
@@ -50,7 +50,7 @@
 
 using namespace dealii;
 
-template<int dim>
+template <int dim>
 void test (const unsigned int poly_degree = 1)
 {
 
index fcf16fd39b0cc4d0cef354ced8fa386709612bb3..ab0b95be76ccb8bf137281218f4a0ac0df8a74b5 100644 (file)
@@ -32,7 +32,7 @@
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<class SOLVER, class MATRIX, class VECTOR, class PRECONDITION>
+template <class SOLVER, class MATRIX, class VECTOR, class PRECONDITION>
 void
 check_solve( SOLVER &solver, const MATRIX &A,
              VECTOR &u, VECTOR &f, const PRECONDITION &P)
index c6d50c0e65bf309e4574b5a9faf766f78b1f68e4..dc0b9ee0877ed3a27bd0fb2ed7ae58dce7254f6f 100644 (file)
@@ -44,7 +44,7 @@
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<class SOLVER, class MATRIX, class VECTOR, class PRECONDITION>
+template <class SOLVER, class MATRIX, class VECTOR, class PRECONDITION>
 void
 check_solve( SOLVER &solver, const MATRIX &A,
              VECTOR &u, VECTOR &f, const PRECONDITION &P)
index 9eaeb3674469c0c70385b14ea9929ea509af85df..6ba5cca727b76910e3abbbbb5391c9952fbd5ed7 100644 (file)
@@ -32,7 +32,7 @@
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<class SOLVER, class MATRIX, class VECTOR, class PRECONDITION>
+template <class SOLVER, class MATRIX, class VECTOR, class PRECONDITION>
 void
 check_solve( SOLVER &solver, const MATRIX &A,
              VECTOR &u, VECTOR &f, const PRECONDITION &P)
index 1b7921564fb83034d39b55abc6ecf2a983fdcc61..25ad8a3f57d302fe40a95fb7ffcb3dfb7b172b4c 100644 (file)
@@ -45,7 +45,7 @@ using namespace dealii;
 using namespace dealii::Physics;
 using namespace dealii::Physics::Elasticity;
 
-template<int dim>
+template <int dim>
 void
 test_kinematic_tensors ()
 {
index 2e9b08c4d8a329fe142f15ee159dfcab15e07b69..d8825f53016eb3963c173c4a6d6cdf9800e2f185 100644 (file)
@@ -34,7 +34,7 @@ const double c01 = 20.0;
 // where I1 = I1(C), I2 = I2(C)
 // Then dI1/dC = I and dI2/dC = I1.I - C
 // and S = 2 dpsi/dC
-template<int dim>
+template <int dim>
 SymmetricTensor<2,dim>
 get_S (const Tensor<2,dim> &F)
 {
@@ -46,7 +46,7 @@ get_S (const Tensor<2,dim> &F)
 // For isotropic media, tau = 2.b.dpsi/db == 2.dpsi/db . b
 // where b = F.F^{T}, I1(b) == I1(C) and
 //  I2(b) == I2(C)
-template<int dim>
+template <int dim>
 SymmetricTensor<2,dim>
 get_tau (const Tensor<2,dim> &F)
 {
@@ -58,7 +58,7 @@ get_tau (const Tensor<2,dim> &F)
   return symmetrize(static_cast< Tensor<2,dim> >(tmp)*static_cast< Tensor<2,dim> >(b));
 }
 
-template<int dim>
+template <int dim>
 void
 test_standard_tensors ()
 {
index 79913e626dba6ad2786f73a7a57e70280b91b8b9..9b105ddedbda270fd262ba8bd632182596ce8932 100644 (file)
@@ -38,7 +38,7 @@
 
 using namespace dealii;
 
-template<int dim>
+template <int dim>
 void test()
 {
   parallel::distributed::Triangulation<dim>
index ba6e7f40107512481949f1ce703e93a266d419bf..9ce0b7c0c6c8ac0f6d13222f01be6bf5a221e2a7 100644 (file)
@@ -22,7 +22,7 @@
 #include <deal.II/distributed/shared_tria.h>
 #include <deal.II/grid/grid_generator.h>
 
-template<int dim>
+template <int dim>
 void test()
 {
   Triangulation<dim> tr1;
index c0d49953696c136a0cc6bd048de6952397a71952..96abb79ec8bb7b8646dee94e0eff3c8b62c343ed 100644 (file)
@@ -37,7 +37,7 @@
 #include <numeric>
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   parallel::shared::Triangulation<dim>
index dd15f637058be12751709d0bb5a72fa2fdcd00a5..7ea096edcce219c278384d8f8a8769dc62093910 100644 (file)
@@ -38,7 +38,7 @@
 #include <numeric>
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   parallel::shared::Triangulation<dim>
index 09fb7105942db7428c9060bc19404e1f7d884fe1..3ec702875a6034d0fc610558fc9580dc336819b1 100644 (file)
@@ -37,7 +37,7 @@
 #include <numeric>
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   parallel::shared::Triangulation<dim>
index 632cc25dbdd3749c7bb87302eebe5df5589604e2..09c2cb885560bbfee450c35d9aef9f9373efd6c4 100644 (file)
@@ -38,7 +38,7 @@
 #include <numeric>
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   parallel::shared::Triangulation<dim>
index daf2e4fbca760c3787ec686dcf2cada227413f68..aa18aa3921bb697891d5b3cdbd12cf70a55334f3 100644 (file)
@@ -54,7 +54,7 @@ void write_mesh (const parallel::shared::Triangulation<dim,spacedim> &tria,
 
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   parallel::shared::Triangulation<dim> tr(MPI_COMM_WORLD);
index 53b9a3c635f8c5ab9f219e897d2932506b3eec90..a7829dec8de9bf6e1d2b78129eee33b84c681be7 100644 (file)
@@ -56,7 +56,7 @@ void write_mesh (const parallel::shared::Triangulation<dim,spacedim> &tria,
 
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   parallel::shared::Triangulation<dim> tr(MPI_COMM_WORLD,
index 7422ee3bd6e9ad625180e2c6c52e9826a2a4e9ab..745317937819c88a58bb0d665f5e55bfcbc2db2a 100644 (file)
@@ -52,7 +52,7 @@ void mypartition(parallel::shared::Triangulation<dim> &tria)
     }
 }
 
-template<int dim>
+template <int dim>
 void test()
 {
   parallel::shared::Triangulation<dim> shared_tria(MPI_COMM_WORLD,typename Triangulation<dim>::MeshSmoothing
index ac4ba9d340acd062fac7100f396dbde62c5aff05..d6fd388a25eec8a99ee248bdd08cac20c87ed7f6 100644 (file)
@@ -61,7 +61,7 @@ void mypartition(parallel::shared::Triangulation<dim> &tria)
     }
 }
 
-template<int dim>
+template <int dim>
 void test()
 {
   parallel::shared::Triangulation<dim> shared_tria(MPI_COMM_WORLD,typename Triangulation<dim>::MeshSmoothing
index 681902975cf3e8c54db54a991d3ff2177feb9945..fd31e782fa9a67105be07670f0c9694128392d9e 100644 (file)
@@ -28,7 +28,7 @@
 #include <sstream>
 #include <fstream>
 
-template<int dim>
+template <int dim>
 void test()
 {
   Triangulation<dim> tr1;
index 763269cf236a6728befc5e68c05f6d8701c79cce..cfe09f28434897355318786ef69bb2558d748ca9 100644 (file)
@@ -105,7 +105,7 @@ void compare_meshes (parallel::shared::Triangulation<dim> &shared_tria, parallel
 }
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   parallel::shared::Triangulation<dim> shared_tria(MPI_COMM_WORLD,typename Triangulation<dim>::MeshSmoothing
index de3a0ae24296dd90f24f7e1979df8ac4ea33d05d..c60968dc1ea4663844182e4513168d0100f79e50 100644 (file)
@@ -33,7 +33,7 @@
 
 #include <fstream>
 
-template<int dim>
+template <int dim>
 void test()
 {
   parallel::shared::Triangulation<dim> shared_tria(MPI_COMM_WORLD,typename Triangulation<dim>::MeshSmoothing
index 4b240e232733d413821bd3152abf294b1715fd05..085d6e4c28b597e8f19cf26cc79c84dcde7f2d2b 100644 (file)
@@ -70,7 +70,7 @@ void compare_meshes (parallel::shared::Triangulation<dim> &shared_tria, parallel
 }
 
 
-template<int dim>
+template <int dim>
 void test()
 {
   parallel::shared::Triangulation<dim> shared_tria(MPI_COMM_WORLD,typename Triangulation<dim>::MeshSmoothing
index 919d6645bbaf205de11cc20541738debc1c2f192..97108f242bacdaa60201399f9fba8c4686950945 100644 (file)
@@ -33,7 +33,7 @@
 
 #include <fstream>
 
-template<int dim>
+template <int dim>
 void test()
 {
   parallel::shared::Triangulation<dim> shared_tria(MPI_COMM_WORLD,typename Triangulation<dim>::MeshSmoothing
index 4168712627f609d6af35fef1d5bf4877253c8200..6a0a628c5cb4e3a5afed76dfdac6b226a34d3d3f 100644 (file)
@@ -36,7 +36,7 @@
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<typename SolverType, typename MatrixType, typename VectorType>
+template <typename SolverType, typename MatrixType, typename VectorType>
 void
 check_solve( SolverType &solver,
              const SolverControl &solver_control,
index 5d2964b1f5085ffe05561dfdaf30114f3fb38827..f079a5e70a80008400081e3d86c34a598f0d4e6f 100644 (file)
@@ -36,7 +36,7 @@
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<typename SolverType, typename MatrixType, typename VectorType>
+template <typename SolverType, typename MatrixType, typename VectorType>
 void
 check_solve( SolverType &solver,
              const unsigned int solver_number,
index 07f00073c67ac6a742ccb29e4476aca71ec90899..e70b853fe90435f88f683ed4fd6dece356ade0f2 100644 (file)
@@ -75,7 +75,7 @@ FDDiagMatrix::diag_structure(SP &structure) const
 }
 
 
-template<typename MatrixType>
+template <typename MatrixType>
 inline
 void
 FDDiagMatrix::diag(MatrixType &A) const
@@ -91,7 +91,7 @@ FDDiagMatrix::diag(MatrixType &A) const
     }
 }
 
-template<typename number>
+template <typename number>
 inline
 void
 FDDiagMatrix::gnuplot_print(std::ostream &s, const Vector<number> &V) const
@@ -168,7 +168,7 @@ FD1DLaplaceMatrix::three_point_structure(SP &structure) const
 }
 
 
-template<typename MatrixType>
+template <typename MatrixType>
 inline
 void
 FD1DLaplaceMatrix::three_point(MatrixType &A) const
index 358b41235541bec6531a10798dade4029e1a49ef..4e0a43c9200ce3fd9c695bfdcb500ab9ff0950da 100644 (file)
@@ -173,7 +173,7 @@ FDMatrix::nine_point_structure(SP &structure) const
 
 
 
-template<typename MatrixType>
+template <typename MatrixType>
 void
 FDMatrix::nine_point(MatrixType &A, bool) const
 {
@@ -229,7 +229,7 @@ FDMatrix::nine_point(MatrixType &A, bool) const
     }
 }
 
-template<typename MatrixType>
+template <typename MatrixType>
 inline
 void
 FDMatrix::five_point(MatrixType &A, bool nonsymmetric) const
@@ -273,7 +273,7 @@ FDMatrix::five_point(MatrixType &A, bool nonsymmetric) const
 
 
 
-template<typename MatrixType>
+template <typename MatrixType>
 inline
 void
 FDMatrix::upwind(MatrixType &A, bool back) const
@@ -295,7 +295,7 @@ FDMatrix::upwind(MatrixType &A, bool back) const
     }
 }
 
-template<typename number>
+template <typename number>
 inline
 void
 FDMatrix::gnuplot_print(std::ostream &s, const Vector<number> &V) const
index 1ce99af8a613107d1c3dd56df65e64b442a67cd9..32189f1020ffa05f0abc48a923cfed549b740e69 100644 (file)
@@ -79,14 +79,14 @@ PetscReal get_real_assert_zero_imag(const PETScWrappers::internal::VectorReferen
 }
 #endif
 
-template<typename number>
+template <typename number>
 number get_real_assert_zero_imag(const std::complex<number> &a)
 {
   Assert (a.imag() == 0.0, ExcInternalError());
   return a.real();
 }
 
-template<typename number>
+template <typename number>
 number get_real_assert_zero_imag(const number &a)
 {
   return a;
index 4e32ab6fe397d3c0c8bbe23e714d4e6aa0daab8c..676d5a1776092ab5569261b3f01a79398f3b9024 100644 (file)
@@ -30,7 +30,7 @@
 #include <vector>
 
 
-template<typename MatrixType>
+template <typename MatrixType>
 void test (MatrixType &m)
 {
   m.set(0,0,1.);
index 9d4630a8de92e3da631d625ff3e18a8a98a846fe..984d355002708727124a84fc7a5123004ca6403e 100644 (file)
@@ -37,7 +37,7 @@
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
+template <typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
 void
 check_solve (SolverType          &solver,
              const SolverControl &solver_control,
index e71a3a278507ea5f52311000ae4fe014527ba139..42adb4488dfe7b719cdc2c82f63d6befc07e3f12 100644 (file)
@@ -39,7 +39,7 @@
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
+template <typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
 void
 check_solve (SolverType          &solver,
              const SolverControl &solver_control,
index d45ae717e1c4b3386ecc9a9ef438d84ff1105f1d..343486235a45e46af5c32f902801cf8baa68a5b8 100644 (file)
@@ -39,7 +39,7 @@
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
+template <typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
 void
 check_solve (SolverType          &solver,
              const SolverControl &solver_control,
index f2d2de8ce292ea7435685b2c3e63e96b32816766..bab2dee0dc6448240a9abc432ff04a90ccfc55bc 100644 (file)
@@ -38,7 +38,7 @@
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
+template <typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
 void
 check_solve (SolverType          &solver,
              const SolverControl &solver_control,
index fd7665f412a6914e0403a44c7fcc40e704143f74..6a32655016daf5f9b14289f200b35252e965065c 100644 (file)
@@ -37,7 +37,7 @@
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
+template <typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
 void
 check_solve (SolverType          &solver,
              const SolverControl &solver_control,
index 0573c8697b3da81a68ade1852093d1c520dd558e..7a3a7465686f4dd5f651152f5880f4f0db79b01f 100644 (file)
@@ -37,7 +37,7 @@
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
+template <typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
 void
 check_solve (SolverType          &solver,
              const SolverControl &solver_control,
index ba4c09dcdb2ad3cd7568f0a99c555ea0f1f7b1c4..a276e92818b780654cd289c8f9fc2009d340dc69 100644 (file)
@@ -94,7 +94,7 @@ namespace LinearAdvectionTest
 {
   using namespace dealii;
 
-  template<int dim>
+  template <int dim>
   class AdvectionProblem
   {
   public:
@@ -129,7 +129,7 @@ namespace LinearAdvectionTest
 
 
 
-  template<int dim>
+  template <int dim>
   AdvectionProblem<dim>::AdvectionProblem()
     : n_mpi_processes (Utilities::MPI::n_mpi_processes(MPI_COMM_WORLD)),
       this_mpi_process (Utilities::MPI::this_mpi_process(MPI_COMM_WORLD)),
@@ -147,7 +147,7 @@ namespace LinearAdvectionTest
                                               p0, p1);
   }
 
-  template<int dim>
+  template <int dim>
   void AdvectionProblem<dim>::setup_system ()
   {
     dof_handler.distribute_dofs(fe);
@@ -175,7 +175,7 @@ namespace LinearAdvectionTest
 
 
 
-  template<int dim>
+  template <int dim>
   void AdvectionProblem<dim>::calculate_flux_terms
   (const TriaActiveIterator<DoFCellAccessor<DoFHandler<dim>, false> > &current_cell,
    FEFaceValues<dim> &current_face_values,
@@ -200,7 +200,7 @@ namespace LinearAdvectionTest
   }
 
 
-  template<int dim>
+  template <int dim>
   void AdvectionProblem<dim>::assemble_system()
   {
     const unsigned int dofs_per_cell = fe.dofs_per_cell;
@@ -294,7 +294,7 @@ namespace LinearAdvectionTest
   }
 
 
-  template<int dim>
+  template <int dim>
   void AdvectionProblem<dim>::run()
   {
     setup_system();
index 56c747f0930dccaa6ea39f1f66106baaa53cd158..3346578f522e760bf97c768bf915f17bffcd35af 100644 (file)
@@ -32,7 +32,7 @@
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
+template <typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
 void
 check_solve (SolverType          &solver,
              const SolverControl &solver_control,
index 54916f3ca5a470c2f4e777f08bc5b3460f0be839..b97da29d194c0bf51211eaf891786484eb37ff69 100644 (file)
@@ -32,7 +32,7 @@
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
+template <typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
 void
 check_solve (SolverType          &solver,
              const SolverControl &solver_control,
index d57a0fb3c4996bd64dd581422bf798995354d45f..12c27e921fe4af79ea5117502af9ed705d59c77e 100644 (file)
@@ -32,7 +32,7 @@
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
+template <typename SolverType, typename MatrixType, typename VectorType, class PRECONDITION>
 void
 check_solve (SolverType          &solver,
              const SolverControl &solver_control,
index 6242b9537bdc616ed6f0883e12abcb42d0608766..c7b337ff34fdb17e906567dd1aedc85381eb01e4 100644 (file)
@@ -33,7 +33,7 @@
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<typename MatrixType, typename VectorType, class PRECONDITION>
+template <typename MatrixType, typename VectorType, class PRECONDITION>
 void
 check_solve (SolverControl       &solver_control,
              const MatrixType    &A,
index 1c832fe0ef89fc64b5c1dc3992ab8bd8de38396f..83ddd3144b9b02ec14210d2186f030ac7230a5b8 100644 (file)
@@ -33,7 +33,7 @@
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<typename MatrixType, typename VectorType, class PRECONDITION>
+template <typename MatrixType, typename VectorType, class PRECONDITION>
 void
 check_solve (SolverControl       &solver_control,
              const MatrixType    &A,
index 7c527fe15a156dbe77c17694e03265f05641e50e..631aedc9efde2598157ed4db904ee58e86632409 100644 (file)
@@ -33,7 +33,7 @@
 #include <deal.II/lac/vector_memory.h>
 #include <typeinfo>
 
-template<typename MatrixType, typename VectorType, class PRECONDITION>
+template <typename MatrixType, typename VectorType, class PRECONDITION>
 void
 check_solve (SolverControl       &solver_control,
              const MatrixType    &A,
index f801d00fa78f79653d712cc73e618a76019f961f..01fcff49e94f0d8deb95fccab2d81f84285b4baf 100644 (file)
@@ -26,7 +26,7 @@
 using namespace dealii;
 
 
-template<typename MATRIX>
+template <typename MATRIX>
 void out_matrix_size(const MATRIX &M,
                      const std::string &name)
 {

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.