]> https://gitweb.dealii.org/ - dealii.git/commit
Rename petsc_parallel_* headers to petsc_* 6986/head
authorDaniel Arndt <daniel.arndt@iwr.uni-heidelberg.de>
Thu, 26 Jul 2018 12:18:24 +0000 (14:18 +0200)
committerDaniel Arndt <daniel.arndt@iwr.uni-heidelberg.de>
Thu, 26 Jul 2018 12:22:08 +0000 (14:22 +0200)
commit6a1d83c2e1ab7b959ccaf0b138b348dcd3086228
treea49003d71955839ebf6ea5fe3b2c1c7c88db1abd
parent43ded1e79bf097b506e35c09ad19fff29708e97e
Rename petsc_parallel_* headers to petsc_*
256 files changed:
include/deal.II/fe/fe_tools_extrapolate.templates.h
include/deal.II/fe/fe_tools_interpolate.templates.h
include/deal.II/lac/affine_constraints.templates.h
include/deal.II/lac/generic_linear_algebra.h
include/deal.II/lac/la_parallel_block_vector.templates.h
include/deal.II/lac/la_parallel_vector.templates.h
include/deal.II/lac/petsc_block_sparse_matrix.h [new file with mode: 0644]
include/deal.II/lac/petsc_block_vector.h [new file with mode: 0644]
include/deal.II/lac/petsc_matrix_free.h
include/deal.II/lac/petsc_parallel_block_sparse_matrix.h
include/deal.II/lac/petsc_parallel_block_vector.h
include/deal.II/lac/petsc_parallel_sparse_matrix.h
include/deal.II/lac/petsc_parallel_vector.h
include/deal.II/lac/petsc_sparse_matrix.h
include/deal.II/lac/petsc_vector.h [new file with mode: 0644]
include/deal.II/lac/read_write_vector.templates.h
include/deal.II/multigrid/mg_transfer.h
include/deal.II/multigrid/mg_transfer.templates.h
include/deal.II/numerics/error_estimator.templates.h
include/deal.II/numerics/matrix_creator.templates.h
include/deal.II/numerics/vector_tools.templates.h
include/deal.II/sundials/arkode.h
include/deal.II/sundials/copy.h
include/deal.II/sundials/ida.h
source/algorithms/operator.cc
source/base/mpi.cc
source/base/time_stepping.cc
source/distributed/solution_transfer.cc
source/dofs/dof_accessor_get.cc
source/dofs/dof_accessor_set.cc
source/fe/fe_values.cc
source/fe/mapping_fe_field.cc
source/fe/mapping_q1_eulerian.cc
source/fe/mapping_q_eulerian.cc
source/lac/block_matrix_array.cc
source/lac/petsc_matrix_base.cc
source/lac/petsc_parallel_block_sparse_matrix.cc
source/lac/petsc_parallel_block_vector.cc
source/lac/petsc_parallel_sparse_matrix.cc
source/lac/petsc_parallel_vector.cc
source/lac/petsc_vector_base.cc
source/lac/solver.cc
source/lac/vector_memory.cc
source/meshworker/mesh_worker_vector_selector.cc
source/multigrid/mg_base.cc
source/multigrid/multigrid.cc
source/non_matching/coupling.cc
source/numerics/data_out_dof_data.cc
source/numerics/data_out_dof_data_codim.cc
source/numerics/data_out_dof_data_inst2.cc
source/numerics/derivative_approximation.cc
source/numerics/dof_output_operator.cc
source/numerics/error_estimator_1d.cc
source/numerics/fe_field_function.cc
source/numerics/matrix_tools.cc
source/numerics/matrix_tools_once.cc
source/numerics/point_value_history.cc
source/numerics/solution_transfer.cc
source/sundials/arkode.cc
source/sundials/ida.cc
source/sundials/kinsol.cc
tests/arpack/parpack_advection_diffusion_petsc.cc
tests/arpack/step-36_parpack.cc
tests/fe/fe_enriched_step-36.cc
tests/fe/fe_enriched_step-36b.cc
tests/gla/extract_subvector_to.cc
tests/hp/hp_constraints_neither_dominate_01.cc
tests/hp/hp_constraints_neither_dominate_02.cc
tests/lac/linear_operator_09.cc
tests/lac/utilities_01.cc
tests/lac/vector_reinit_03.cc
tests/lac/vector_type_traits_is_serial_03.cc
tests/mappings/mapping_q_eulerian_07.cc
tests/mappings/mapping_q_eulerian_08.cc
tests/matrix_free/interpolate_to_mg.cc
tests/mpi/blockvec_01.cc
tests/mpi/blockvec_02.cc
tests/mpi/condense_01.cc
tests/mpi/constraint_matrix_condense_01.cc
tests/mpi/constraint_matrix_set_zero_01.cc
tests/mpi/data_out_faces_01.cc
tests/mpi/fe_tools_extrapolate_02.cc
tests/mpi/fe_tools_extrapolate_05.cc
tests/mpi/ghost_01.cc
tests/mpi/ghost_02.cc
tests/mpi/ghost_03.cc
tests/mpi/has_hanging_nodes.cc
tests/mpi/hp_step-40.cc
tests/mpi/interpolate_02.cc
tests/mpi/interpolate_04.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/periodicity_01.cc
tests/mpi/petsc_01.cc
tests/mpi/petsc_02.cc
tests/mpi/petsc_03.cc
tests/mpi/petsc_bug_ghost_vector_01.cc
tests/mpi/petsc_distribute_01.cc
tests/mpi/petsc_distribute_01_block.cc
tests/mpi/petsc_distribute_01_inhomogenous.cc
tests/mpi/petsc_locally_owned_elements.cc
tests/mpi/solution_transfer_01.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/multigrid/transfer_04b.cc
tests/petsc/11.cc
tests/petsc/12.cc
tests/petsc/13.cc
tests/petsc/17.cc
tests/petsc/18.cc
tests/petsc/19.cc
tests/petsc/20.cc
tests/petsc/21.cc
tests/petsc/22.cc
tests/petsc/23.cc
tests/petsc/24.cc
tests/petsc/26.cc
tests/petsc/27.cc
tests/petsc/28.cc
tests/petsc/29.cc
tests/petsc/30.cc
tests/petsc/31.cc
tests/petsc/32.cc
tests/petsc/33.cc
tests/petsc/34.cc
tests/petsc/35.cc
tests/petsc/36.cc
tests/petsc/37.cc
tests/petsc/39.cc
tests/petsc/40.cc
tests/petsc/41.cc
tests/petsc/42.cc
tests/petsc/45.cc
tests/petsc/46.cc
tests/petsc/48.cc
tests/petsc/49.cc
tests/petsc/50.cc
tests/petsc/51.cc
tests/petsc/55.cc
tests/petsc/56.cc
tests/petsc/57.cc
tests/petsc/58.cc
tests/petsc/59.cc
tests/petsc/60.cc
tests/petsc/61.cc
tests/petsc/64.cc
tests/petsc/65.cc
tests/petsc/70.cc
tests/petsc/block_vector_iterator_01.cc
tests/petsc/block_vector_iterator_02.cc
tests/petsc/block_vector_iterator_03.cc
tests/petsc/copy_parallel_vector.cc
tests/petsc/copy_to_dealvec.cc
tests/petsc/copy_to_dealvec_block.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/different_matrix_preconditioner.cc
tests/petsc/full_matrix_vector_01.cc
tests/petsc/full_matrix_vector_02.cc
tests/petsc/full_matrix_vector_03.cc
tests/petsc/full_matrix_vector_04.cc
tests/petsc/full_matrix_vector_05.cc
tests/petsc/full_matrix_vector_06.cc
tests/petsc/full_matrix_vector_07.cc
tests/petsc/iterate_parallel_01.cc
tests/petsc/parallel_sparse_matrix_01.cc
tests/petsc/reinit_preconditioner_01.cc
tests/petsc/reinit_preconditioner_02.cc
tests/petsc/slowness_02.cc
tests/petsc/slowness_03.cc
tests/petsc/slowness_04.cc
tests/petsc/solver_01.cc
tests/petsc/solver_02.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_11.cc
tests/petsc/solver_12.cc
tests/petsc/solver_13.cc
tests/petsc/sparse_direct_mumps.cc
tests/petsc/sparse_matrix_matrix_01.cc
tests/petsc/sparse_matrix_matrix_02.cc
tests/petsc/sparse_matrix_matrix_03.cc
tests/petsc/sparse_matrix_matrix_04.cc
tests/petsc/sparse_matrix_vector_01.cc
tests/petsc/sparse_matrix_vector_02.cc
tests/petsc/sparse_matrix_vector_03.cc
tests/petsc/sparse_matrix_vector_04.cc
tests/petsc/sparse_matrix_vector_05.cc
tests/petsc/sparse_matrix_vector_06.cc
tests/petsc/sparse_matrix_vector_07.cc
tests/petsc/subtract_mean_value_03.cc
tests/petsc/update_ghosts.cc
tests/petsc/vector_assign_01.cc
tests/petsc/vector_assign_02.cc
tests/petsc/vector_equality_1.cc
tests/petsc/vector_equality_2.cc
tests/petsc/vector_equality_3.cc
tests/petsc/vector_equality_4.cc
tests/petsc/vector_print.cc
tests/petsc/vector_wrap_01.cc
tests/petsc_complex/11.cc
tests/petsc_complex/12.cc
tests/petsc_complex/13.cc
tests/petsc_complex/17.cc
tests/petsc_complex/18.cc
tests/petsc_complex/19.cc
tests/petsc_complex/20.cc
tests/petsc_complex/assemble_01.cc
tests/petsc_complex/element_access_00.cc
tests/petsc_complex/fe_get_function_values.cc
tests/petsc_complex/parallel_sparse_matrix_01.cc
tests/petsc_complex/solver_real_01.cc
tests/petsc_complex/solver_real_02.cc
tests/petsc_complex/solver_real_03.cc
tests/petsc_complex/solver_real_03_mf.cc
tests/petsc_complex/solver_real_04.cc
tests/petsc_complex/vector_02.cc
tests/petsc_complex/vector_assign_01.cc
tests/petsc_complex/vector_assign_02.cc
tests/petsc_complex/vector_equality_1.cc
tests/petsc_complex/vector_equality_2.cc
tests/petsc_complex/vector_print.cc
tests/petsc_complex/vector_wrap_01.cc
tests/physics/step-18-rotation_matrix.cc
tests/physics/step-18.cc
tests/quick_tests/step-petsc.cc
tests/quick_tests/step-slepc.cc
tests/slepc/solve_01.cc
tests/slepc/solve_04.cc
tests/slepc/step-36_parallel.cc
tests/slepc/step-36_parallel_02.cc
tests/slepc/step-36_parallel_03.cc
tests/sundials/copy_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.