]> https://gitweb.dealii.org/ - dealii.git/commit
Deprecate get_communicator() in favor of get_mpi_communicator(). 17551/head
authorDavid Wells <drwells@email.unc.edu>
Fri, 16 Aug 2024 16:09:24 +0000 (10:09 -0600)
committerDavid Wells <drwells@email.unc.edu>
Fri, 16 Aug 2024 17:10:02 +0000 (11:10 -0600)
commitc1e9bad7a75a9d3daadfe17e6f8abff4a7da75af
tree77896a1dbc9b4c5788349c2148da6a6f525670e2
parent71cca2f2b43408d65c29d24acbdf5c902b3b5d09
Deprecate get_communicator() in favor of get_mpi_communicator().

We use the later name more often than the former.
121 files changed:
examples/step-37/doc/results.dox
examples/step-75/step-75.cc
examples/step-87/step-87.cc
examples/step-89/step-89.cc
include/deal.II/base/mpi_remote_point_evaluation.h
include/deal.II/distributed/tria_base.h
include/deal.II/dofs/dof_handler.h
include/deal.II/fe/fe_tools_extrapolate.templates.h
include/deal.II/grid/grid_tools.h
include/deal.II/grid/tria.h
include/deal.II/matrix_free/face_setup_internal.h
include/deal.II/matrix_free/matrix_free.templates.h
include/deal.II/matrix_free/portable_matrix_free.templates.h
include/deal.II/multigrid/mg_transfer.h
include/deal.II/multigrid/mg_transfer.templates.h
include/deal.II/multigrid/mg_transfer_global_coarsening.templates.h
include/deal.II/multigrid/multigrid.h
include/deal.II/numerics/data_out_dof_data.templates.h
include/deal.II/numerics/vector_tools_integrate_difference.templates.h
include/deal.II/numerics/vector_tools_interpolate.templates.h
include/deal.II/numerics/vector_tools_mean_value.templates.h
include/deal.II/sundials/n_vector.templates.h
source/base/mpi_remote_point_evaluation.cc
source/distributed/grid_refinement.cc
source/distributed/repartitioning_policy_tools.cc
source/distributed/shared_tria.cc
source/distributed/tria.cc
source/distributed/tria_base.cc
source/dofs/dof_handler.cc
source/dofs/dof_handler_policy.cc
source/dofs/dof_renumbering.cc
source/dofs/dof_tools.cc
source/dofs/dof_tools_constraints.cc
source/fe/mapping_q_cache.cc
source/grid/grid_out.cc
source/grid/grid_tools.cc
source/grid/grid_tools_cache.cc
source/grid/grid_tools_geometry.cc
source/grid/tria.cc
source/grid/tria_description.cc
source/hp/refinement.cc
source/multigrid/mg_level_global_transfer.cc
source/multigrid/mg_tools.cc
source/multigrid/mg_transfer_internal.cc
source/multigrid/mg_transfer_prebuilt.cc
source/particles/generators.cc
source/particles/particle_handler.cc
tests/belos/solver_belos_01.cc
tests/dofs/nodal_renumbering_01.cc
tests/fullydistributed_grids/repartitioning_03.cc
tests/fullydistributed_grids/repartitioning_05.cc
tests/grid/grid_generator_marching_cube_algorithm_01.cc
tests/grid/grid_generator_marching_cube_algorithm_02.cc
tests/lac/constraints_make_consistent_in_parallel_01.cc
tests/lac/sparse_matrix_tools_01.cc
tests/lac/step-40-linear_operator_01.cc
tests/lac/step-40-linear_operator_02.cc
tests/lac/step-40-linear_operator_03.cc
tests/lac/step-40-linear_operator_04.cc
tests/lac/step-40-linear_operator_05.cc
tests/lac/step-40-linear_operator_06.cc
tests/mappings/mapping_fe_field_06.cc
tests/mappings/mapping_q_cache_06.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/compute_mean_value_02.cc
tests/mpi/hp_constraints_consistent_01.cc
tests/mpi/hp_constraints_consistent_02.cc
tests/mpi/hp_constraints_consistent_03.cc
tests/mpi/hp_step-40.cc
tests/mpi/hp_step-40_variable_01.cc
tests/mpi/limit_p_level_difference_01.cc
tests/mpi/limit_p_level_difference_02.cc
tests/mpi/periodicity_04.cc
tests/mpi/petsc_step-27.cc
tests/mpi/solution_transfer_11.cc
tests/mpi/step-40.cc
tests/mpi/step-40_cuthill_mckee.cc
tests/mpi/step-40_cuthill_mckee_MPI-subset.cc
tests/mpi/step-40_direct_solver.cc
tests/mpi/trilinos_step-27.cc
tests/multigrid-global-coarsening/fe_nothing_01.cc
tests/multigrid-global-coarsening/interpolate_01.cc
tests/multigrid-global-coarsening/mg_transfer_util.h
tests/numerics/matrix_creator_01.cc
tests/numerics/project_parallel_common.h
tests/particles/data_out_05.cc
tests/particles/exchange_ghosts_01.cc
tests/particles/exchange_ghosts_periodic_01.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_shared_01.cc
tests/particles/particle_handler_sort_02.cc
tests/particles/particle_weights_01.cc
tests/remote_point_evaluation/data_out_resample_01.cc
tests/remote_point_evaluation/data_out_resample_02.cc
tests/remote_point_evaluation/mapping_02.cc
tests/remote_point_evaluation/remote_point_evaluation_01.cc
tests/remote_point_evaluation/remote_point_evaluation_02.cc
tests/remote_point_evaluation/remote_point_evaluation_03.cc
tests/remote_point_evaluation/vector_tools_evaluate_at_points_01.cc
tests/remote_point_evaluation/vector_tools_evaluate_at_points_02.cc
tests/remote_point_evaluation/vector_tools_evaluate_at_points_03.cc
tests/remote_point_evaluation/vector_tools_evaluate_at_points_04.cc
tests/remote_point_evaluation/vector_tools_evaluate_at_points_05.cc
tests/remote_point_evaluation/vector_tools_evaluate_at_points_06.cc
tests/remote_point_evaluation/vector_tools_evaluate_at_points_07.cc
tests/sharedtria/limit_p_level_difference_01.cc
tests/sharedtria/limit_p_level_difference_02.cc
tests/simplex/poisson_01.cc
tests/sundials/n_vector.cc
tests/trilinos/mg_transfer_prebuilt_01.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.