]> https://gitweb.dealii.org/ - dealii.git/commit
Use p[index] instead of p(index) for class Point in tests/. 16504/head
authorWolfgang Bangerth <bangerth@colostate.edu>
Fri, 19 Jan 2024 17:24:48 +0000 (10:24 -0700)
committerWolfgang Bangerth <bangerth@colostate.edu>
Fri, 19 Jan 2024 17:31:14 +0000 (10:31 -0700)
commit4a6fe02c7763a4bc27553e601a15506caf6d37a5
tree7d8f64bb07248c7b6231d4a38763a3fce75c555d
parent54eac45e660d1cf306146559de711be0cb1240de
Use p[index] instead of p(index) for class Point in tests/.
251 files changed:
tests/aniso/up_and_down.cc
tests/base/auto_derivative_function.cc
tests/base/function_derivative.cc
tests/base/functions_04.cc
tests/base/functions_09.cc
tests/base/kokkos_point.cc
tests/base/point_01.cc
tests/base/point_04.cc
tests/base/point_05.cc
tests/base/point_constexpr.cc
tests/base/polynomial1d.cc
tests/base/polynomial_lagrange.cc
tests/base/polynomial_lagrange_order.cc
tests/base/polynomials_tensor.cc
tests/base/qprojector.cc
tests/base/quadrature_chebyshev.cc
tests/base/quadrature_sorted_test.cc
tests/base/quadrature_test.cc
tests/bits/anna_4.cc
tests/bits/christian_1.cc
tests/bits/cone_04.cc
tests/bits/denis_1.cc
tests/bits/error_estimator_01.cc
tests/bits/error_estimator_02.cc
tests/bits/fe_q_constraints.cc
tests/bits/find_cell_10.cc
tests/bits/find_cell_10a.cc
tests/bits/find_cell_11.cc
tests/bits/find_cell_12.cc
tests/bits/periodicity_06.cc
tests/bits/periodicity_07.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_inside_1.cc
tests/bits/point_inside_2.cc
tests/bits/static_condensation.cc
tests/bits/step-12.cc
tests/bits/step-13.cc
tests/bits/step-4.cc
tests/bits/step-4_dg_periodic.cc
tests/bits/step-4_dg_periodic_coupling.cc
tests/bits/step-51.cc
tests/bits/step-51p.cc
tests/bits/step-7.cc
tests/bits/step-8.cc
tests/bits/subdomain_ids_01.cc
tests/bits/subdomain_ids_02.cc
tests/bits/subdomain_ids_03.cc
tests/bits/subdomain_ids_04.cc
tests/bits/subdomain_ids_05.cc
tests/bits/subdomain_ids_06.cc
tests/bits/subdomain_ids_07.cc
tests/codim_one/data_out_03.cc
tests/codim_one/error_estimator_01.cc
tests/codim_one/error_estimator_02.cc
tests/codim_one/extract_boundary_mesh_09.cc
tests/codim_one/mesh_bug.cc
tests/data_out/data_out_base.cc
tests/data_out/data_out_curved_cells.cc
tests/data_out/data_out_postprocessor_tensor_01.cc
tests/data_out/data_out_postprocessor_tensor_02.cc
tests/data_out/patches.h
tests/distributed_grids/3d_coarse_grid_05.cc
tests/distributed_grids/get_boundary_ids_01.cc
tests/dofs/dof_test.cc
tests/dofs/dof_tools_04a.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_22a.cc
tests/dofs/dof_tools_common_parallel.h
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/fe/2d_grid_projection_hermite.cc
tests/fe/bdm_2.cc
tests/fe/br_approximation_01.cc
tests/fe/curl_curl_01.cc
tests/fe/fe_abf_gradient_divergence_theorem.cc
tests/fe/fe_br.cc
tests/fe/fe_nedelec_sz_non_rect_face.cc
tests/fe/fe_project_2d.cc
tests/fe/fe_project_3d.cc
tests/fe/fe_q_bubbles.cc
tests/fe/fe_rt_gradient_divergence_theorem.cc
tests/fe/fe_rt_hessian_divergence_theorem.cc
tests/fe/fe_tools_test.cc
tests/fe/fe_values_no_mapping.cc
tests/fe/fe_values_view_30.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_non_rect_face.cc
tests/fe/p1nc_02.cc
tests/fe/p1nc_03.cc
tests/fe/p1nc_04.cc
tests/fe/p1nc_06.cc
tests/fe/p1nc_07.cc
tests/fe/p1nc_08.cc
tests/fe/rt_2.cc
tests/fe/rt_approximation_01.cc
tests/fe/rt_bubbles_2.cc
tests/fe/up_and_down.cc
tests/feinterface/step-12.cc
tests/feinterface/stokes.cc
tests/fullydistributed_grids/copy_serial_tria_04.cc
tests/grid/enclosing_sphere_01.cc
tests/grid/extent_in_direction.cc
tests/grid/filtered_iterator.cc
tests/grid/filtered_iterator_02.cc
tests/grid/filtered_iterator_03.cc
tests/grid/grid_generator_09.cc
tests/grid/grid_generator_10.cc
tests/grid/grid_generator_general_cell_01.cc
tests/grid/grid_generator_general_cell_02.cc
tests/grid/grid_generator_simplex.cc
tests/grid/grid_invert.cc
tests/grid/grid_invert_02.cc
tests/grid/grid_test.cc
tests/grid/grid_tools_05.cc
tests/grid/grid_tools_06.cc
tests/grid/grid_tools_transform_01.cc
tests/grid/measure_et_al.cc
tests/grid/measure_et_al_02.cc
tests/grid/measure_of_3d_face_01.cc
tests/grid/subcelldata.cc
tests/grid/subdomain_ids.cc
tests/hp/compare_hp_vs_nonhp_01.cc
tests/hp/crash_19.cc
tests/hp/crash_22.cc
tests/hp/hp_hanging_nodes_01.cc
tests/hp/step-12.cc
tests/hp/step-13.cc
tests/hp/step-4.cc
tests/hp/step-7.cc
tests/hp/step-8.cc
tests/lac/constraints_block_01.cc
tests/lac/linear_operator_11.cc
tests/lac/linear_operator_12.cc
tests/lac/linear_operator_12a.cc
tests/manifold/flat_manifold_09.cc
tests/mappings/mapping.cc
tests/mappings/mapping_q1_eulerian.cc
tests/mappings/mapping_q_eulerian.cc
tests/mappings/mapping_q_manifold_01.cc
tests/mappings/mapping_real_to_unit_02.cc
tests/matrix_free/interpolate_rt_deformed.cc
tests/matrix_free/matrix_vector_rt_04.cc
tests/matrix_free/matrix_vector_rt_face_04.cc
tests/matrix_free/stokes_computation.cc
tests/matrix_free_kokkos/coefficient_eval_device.cc
tests/mpi/communicate_moved_vertices_03.cc
tests/mpi/distort_random_02.cc
tests/mpi/fe_tools_extrapolate_common.h
tests/mpi/hp_hanging_node_constraints_02.cc
tests/mpi/interpolate_to_different_mesh_01.cc
tests/mpi/mg_ghost_layer_periodic.cc
tests/mpi/p4est_2d_constraintmatrix_04.cc
tests/mpi/p4est_3d_constraintmatrix_03.cc
tests/mpi/periodicity_01.cc
tests/mpi/periodicity_02.cc
tests/mpi/periodicity_03.cc
tests/mpi/periodicity_04.cc
tests/multigrid-global-coarsening/stokes_computation.cc
tests/multigrid/renumbering_02.cc
tests/multigrid/transfer_02.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/non_matching/face_quadrature_generator.cc
tests/non_matching/fe_interface_values_non_standard_meshes.cc
tests/non_matching/quadrature_generator.cc
tests/non_matching/root_finder.cc
tests/non_matching/tensor_point_with_1D_quadrature.cc
tests/numerics/create_point_source.cc
tests/numerics/create_point_source_hp.cc
tests/numerics/interpolate_to_different_mesh_01.cc
tests/numerics/interpolate_to_different_mesh_02.cc
tests/numerics/no_flux_10.cc
tests/numerics/no_flux_11.cc
tests/numerics/no_flux_18.cc
tests/numerics/point_value_history_01.cc
tests/numerics/point_value_history_02.cc
tests/numerics/point_value_history_03.cc
tests/numerics/project_boundary_rt_01.cc
tests/numerics/project_complex.cc
tests/numerics/project_to_surface_01.cc
tests/numerics/project_to_surface_02.cc
tests/particles/data_out_01.cc
tests/particles/data_out_05.cc
tests/particles/exchange_ghosts_01.cc
tests/particles/generators_02.cc
tests/particles/particle_01.cc
tests/particles/particle_02.cc
tests/particles/particle_03.cc
tests/particles/particle_04.cc
tests/particles/particle_05.cc
tests/particles/particle_06.cc
tests/particles/particle_07.cc
tests/particles/particle_08.cc
tests/particles/particle_handler_01.cc
tests/particles/particle_handler_02.cc
tests/particles/particle_handler_03.cc
tests/particles/particle_handler_04.cc
tests/particles/particle_handler_06.cc
tests/particles/particle_handler_19.cc
tests/particles/particle_handler_20.cc
tests/particles/particle_handler_fully_distributed_01.cc
tests/particles/particle_handler_serial_01.cc
tests/particles/particle_handler_serial_02.cc
tests/particles/particle_handler_serial_03.cc
tests/particles/particle_handler_shared_01.cc
tests/particles/particle_iterator_01.cc
tests/particles/particle_iterator_02.cc
tests/particles/remove_particle_01.cc
tests/particles/step-68.cc
tests/simplex/poisson_02.cc
tests/simplex/simplex_grids.h
tests/simplex/simplex_project_cg.cc
tests/simplex/step-04-data_out_faces.cc
tests/simplex/step-04.cc
tests/simplex/step-07.cc
tests/simplex/step-08.cc
tests/simplex/step-12.cc
tests/simplex/step-12a.cc
tests/simplex/step-12b.cc
tests/simplex/step-12c.cc
tests/simplex/step-17.cc
tests/simplex/step-38.cc
tests/simplex/step-68.cc
tests/sparsity/flux_sparsity_pattern_visiting_once.cc
tests/test_grids.h
tests/trilinos/direct_solver.cc
tests/trilinos/direct_solver_2.cc
tests/trilinos/precondition.cc
tests/trilinos/precondition_amg_smoother.cc
tests/trilinos/precondition_q_iso_q1.cc

In the beginning the Universe was created. This has made a lot of people very angry and has been widely regarded as a bad move.

Douglas Adams


Typeset in Trocchi and Trocchi Bold Sans Serif.