]> https://gitweb.dealii.org/ - dealii-svn.git/commit
Convert matrices.h and vectors.h into matrix_tools.h/vector_tools.h.
authorbangerth <bangerth@0785d39b-7218-0410-832d-ea1e28bc413d>
Fri, 10 Aug 2012 09:18:34 +0000 (09:18 +0000)
committerbangerth <bangerth@0785d39b-7218-0410-832d-ea1e28bc413d>
Fri, 10 Aug 2012 09:18:34 +0000 (09:18 +0000)
commit8943336a32625cd7b70b2d7076e92eadf99dd3e2
treebc81baa017224912fb4abd7f586b48107e7cc725
parentbe9823735a928ba1577296cc54644ebd652a219f
Convert matrices.h and vectors.h into matrix_tools.h/vector_tools.h.

git-svn-id: https://svn.dealii.org/trunk@25861 0785d39b-7218-0410-832d-ea1e28bc413d
301 files changed:
tests/aniso/solution_transfer.cc
tests/benchmarks/spec2006-447.dealII.cc
tests/bits/anna_4.cc
tests/bits/anna_6.cc
tests/bits/apply_boundary_values_01.cc
tests/bits/apply_boundary_values_02.cc
tests/bits/block_sparse_matrix_1.cc
tests/bits/christian_1.cc
tests/bits/data_out_curved_cells.cc
tests/bits/denis_1.cc
tests/bits/dof_tools_19.cc
tests/bits/dof_tools_21.cc
tests/bits/error_estimator_01.cc
tests/bits/error_estimator_02.cc
tests/bits/face_orientation_and_fe_nedelec_01.cc
tests/bits/face_orientation_and_fe_q_01.cc
tests/bits/face_orientation_and_fe_q_02.cc
tests/bits/face_orientation_crash.cc
tests/bits/fe_field_function_01.cc
tests/bits/fe_field_function_01_vector.cc
tests/bits/fe_field_function_02.cc
tests/bits/fe_field_function_02_vector.cc
tests/bits/fe_field_function_03.cc
tests/bits/fe_field_function_03_vector.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_q_constraints.cc
tests/bits/gerold_1.cc
tests/bits/joa_1.cc
tests/bits/make_boundary_constraints_01.cc
tests/bits/mapping_q1_eulerian_01.cc
tests/bits/mapping_q_eulerian_01.cc
tests/bits/mapping_q_eulerian_02.cc
tests/bits/mapping_q_eulerian_03.cc
tests/bits/mesh_3d_12.cc
tests/bits/mesh_3d_22.cc
tests/bits/mesh_3d_23.cc
tests/bits/mesh_3d_24.cc
tests/bits/mesh_3d_25.cc
tests/bits/mesh_3d_26.cc
tests/bits/point_difference_01.cc
tests/bits/point_difference_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/rt_2.cc
tests/bits/solution_transfer.cc
tests/bits/step-11.cc
tests/bits/step-13.cc
tests/bits/step-14.cc
tests/bits/step-15.cc
tests/bits/step-16.cc
tests/bits/step-3.cc
tests/bits/step-4.cc
tests/bits/step-5.cc
tests/bits/step-6.cc
tests/bits/step-7.cc
tests/bits/step-8.cc
tests/codim_one/data_out.cc
tests/codim_one/data_out_03.cc
tests/codim_one/error_estimator_01.cc
tests/codim_one/gradients.cc
tests/codim_one/gradients_1.cc
tests/codim_one/interpolate_boundary_values_01.cc
tests/codim_one/interpolate_boundary_values_01_vector_valued.cc
tests/codim_one/interpolate_boundary_values_02.cc
tests/codim_one/interpolate_boundary_values_02_vector_valued.cc
tests/codim_one/interpolate_boundary_values_03.cc
tests/codim_one/interpolate_boundary_values_1d_closed_ring.cc
tests/codim_one/interpolation.cc
tests/codim_one/interpolation_2.cc
tests/codim_one/interpolation_3.cc
tests/codim_one/mean_value.cc
tests/codim_one/projection.cc
tests/codim_one/projection_dgp.cc
tests/codim_one/solution_transfer_01.cc
tests/deal.II/block_matrices.cc
tests/deal.II/boundaries.cc
tests/deal.II/constraints_hanging_nodes_bc.cc
tests/deal.II/constraints_local_to_global.cc
tests/deal.II/create_laplace_matrix_01.cc
tests/deal.II/create_laplace_matrix_01b.cc
tests/deal.II/create_laplace_matrix_02.cc
tests/deal.II/create_laplace_matrix_02b.cc
tests/deal.II/create_laplace_matrix_03.cc
tests/deal.II/create_laplace_matrix_03b.cc
tests/deal.II/create_laplace_matrix_04.cc
tests/deal.II/create_laplace_matrix_04b.cc
tests/deal.II/create_mass_matrix_01.cc
tests/deal.II/create_mass_matrix_01b.cc
tests/deal.II/create_mass_matrix_02.cc
tests/deal.II/create_mass_matrix_02b.cc
tests/deal.II/create_mass_matrix_03.cc
tests/deal.II/create_mass_matrix_03b.cc
tests/deal.II/create_mass_matrix_04.cc
tests/deal.II/create_mass_matrix_04b.cc
tests/deal.II/create_mass_matrix_05.cc
tests/deal.II/create_point_source.cc
tests/deal.II/create_point_source_hp.cc
tests/deal.II/data_out.cc
tests/deal.II/data_out_postprocessor_01.cc
tests/deal.II/data_out_postprocessor_scalar_01.cc
tests/deal.II/data_out_postprocessor_vector_01.cc
tests/deal.II/derivative_approximation.cc
tests/deal.II/derivative_approximation_2.cc
tests/deal.II/error_estimator.cc
tests/deal.II/error_estimator_01.cc
tests/deal.II/fe_values_view_21.cc
tests/deal.II/fe_values_view_22.cc
tests/deal.II/filtered_matrix.cc
tests/deal.II/inhomogeneous_constraints.cc
tests/deal.II/inhomogeneous_constraints_02.cc
tests/deal.II/inhomogeneous_constraints_03.cc
tests/deal.II/inhomogeneous_constraints_04.cc
tests/deal.II/inhomogeneous_constraints_block.cc
tests/deal.II/inhomogeneous_constraints_nonsymmetric.cc
tests/deal.II/inhomogeneous_constraints_vector.cc
tests/deal.II/interpolate_boundary_values_01.cc
tests/deal.II/interpolate_dgq_01.cc
tests/deal.II/interpolate_dgq_02.cc
tests/deal.II/interpolate_q_01.cc
tests/deal.II/interpolate_q_02.cc
tests/deal.II/interpolate_q_system_01.cc
tests/deal.II/interpolate_q_system_02.cc
tests/deal.II/matrices.cc
tests/deal.II/memory_consumption_01.cc
tests/deal.II/newton_01.cc
tests/deal.II/no_flux_01.cc
tests/deal.II/no_flux_02.cc
tests/deal.II/no_flux_03.cc
tests/deal.II/no_flux_04.cc
tests/deal.II/no_flux_05.cc
tests/deal.II/no_flux_06.cc
tests/deal.II/no_flux_07.cc
tests/deal.II/no_flux_08.cc
tests/deal.II/no_flux_09.cc
tests/deal.II/no_flux_10.cc
tests/deal.II/no_flux_hp_01.cc
tests/deal.II/no_flux_hp_02.cc
tests/deal.II/no_flux_hp_03.cc
tests/deal.II/no_flux_hp_04.cc
tests/deal.II/no_flux_hp_05.cc
tests/deal.II/project_01.cc
tests/deal.II/project_02.cc
tests/deal.II/project_boundary_rt_01.cc
tests/deal.II/project_bv_curl_conf.cc
tests/deal.II/project_bv_div_conf.cc
tests/deal.II/project_common.h
tests/deal.II/vectors_boundary_rhs_01.cc
tests/deal.II/vectors_boundary_rhs_02.cc
tests/deal.II/vectors_boundary_rhs_03.cc
tests/deal.II/vectors_point_source_01.cc
tests/deal.II/vectors_rhs_01.cc
tests/deal.II/vectors_rhs_03.cc
tests/distributed_grids/solution_transfer_02.cc
tests/distributed_grids/solution_transfer_03.cc
tests/fail/abf_approximation_01.cc
tests/fail/circular_01.cc
tests/fail/hp-step-14.cc
tests/fail/hp-step-15.cc
tests/fail/rt_crash_01.cc
tests/fail/rt_distorted_01.cc
tests/fail/rt_distorted_02.cc
tests/fail/vectors_boundary_rhs_hp_02.cc
tests/fail/vectors_rhs_hp_02.cc
tests/fe/abf_01.cc
tests/fe/deformed_projection.h
tests/fe/fe_tools_test.cc
tests/fe/mapping_q_eulerian.cc
tests/fe/mass_matrix_arbitrary_nodes.cc
tests/fe/rt_9.cc
tests/fe/rt_approximation_01.cc
tests/fe/rt_normal_02.cc
tests/hp/compare_hp_vs_nonhp_01.cc
tests/hp/crash_06.cc
tests/hp/crash_07.cc
tests/hp/crash_08.cc
tests/hp/crash_09.cc
tests/hp/crash_11.cc
tests/hp/crash_12.cc
tests/hp/crash_16.cc
tests/hp/crash_17.cc
tests/hp/crash_17_compressed_set_sparsity.cc
tests/hp/crash_18.cc
tests/hp/crash_18_compressed_set_sparsity.cc
tests/hp/crash_19.cc
tests/hp/create_laplace_matrix_01.cc
tests/hp/create_laplace_matrix_01b.cc
tests/hp/create_laplace_matrix_02.cc
tests/hp/create_laplace_matrix_02b.cc
tests/hp/create_laplace_matrix_03.cc
tests/hp/create_laplace_matrix_03b.cc
tests/hp/create_laplace_matrix_04.cc
tests/hp/create_laplace_matrix_04b.cc
tests/hp/create_mass_matrix_01.cc
tests/hp/create_mass_matrix_01b.cc
tests/hp/create_mass_matrix_02.cc
tests/hp/create_mass_matrix_02b.cc
tests/hp/create_mass_matrix_03.cc
tests/hp/create_mass_matrix_03b.cc
tests/hp/create_mass_matrix_04.cc
tests/hp/create_mass_matrix_04b.cc
tests/hp/create_mass_matrix_05.cc
tests/hp/create_rhs_01.cc
tests/hp/fe_nothing_08.cc
tests/hp/fe_nothing_09.cc
tests/hp/fe_nothing_11.cc
tests/hp/fe_nothing_12.cc
tests/hp/fe_nothing_13.cc
tests/hp/fe_nothing_14.cc
tests/hp/hp_constraints_common.h
tests/hp/hp_hanging_nodes_01.cc
tests/hp/hp_hanging_nodes_02.cc
tests/hp/integrate_difference.cc
tests/hp/integrate_difference_02.cc
tests/hp/interpolate_dgq_01.cc
tests/hp/interpolate_dgq_02.cc
tests/hp/interpolate_q_01.cc
tests/hp/interpolate_q_02.cc
tests/hp/interpolate_q_system_01.cc
tests/hp/interpolate_q_system_02.cc
tests/hp/matrices.cc
tests/hp/matrices_hp.cc
tests/hp/solution_transfer.cc
tests/hp/step-11.cc
tests/hp/step-11_compressed_set_sparsity.cc
tests/hp/step-13.cc
tests/hp/step-3.cc
tests/hp/step-3a.cc
tests/hp/step-3b.cc
tests/hp/step-3c.cc
tests/hp/step-4.cc
tests/hp/step-5.cc
tests/hp/step-6.cc
tests/hp/step-7.cc
tests/hp/step-8.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_point_source_01.cc
tests/hp/vectors_point_source_hp_01.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/hsl/hsl_ma27_01.cc
tests/hsl/hsl_ma27_02.cc
tests/hsl/hsl_ma47_01.cc
tests/hsl/hsl_ma47_02.cc
tests/matrix_free/get_functions_common.h
tests/matrix_free/get_functions_multife.cc
tests/matrix_free/get_functions_multife2.cc
tests/matrix_free/get_functions_q_hierarchical.cc
tests/matrix_free/get_values_plain.cc
tests/matrix_free/integrate_functions.cc
tests/matrix_free/integrate_functions_multife.cc
tests/matrix_free/integrate_functions_multife2.cc
tests/matrix_free/matrix_vector_common.h
tests/matrix_free/matrix_vector_curl.cc
tests/matrix_free/matrix_vector_div.cc
tests/matrix_free/matrix_vector_stokes.cc
tests/matrix_free/matrix_vector_stokes_noflux.cc
tests/matrix_free/quadrature_points.cc
tests/mpi/compute_mean_value.cc
tests/mpi/constraint_matrix_trilinos_bug.cc
tests/mpi/integrate_difference.cc
tests/mpi/interpolate_01.cc
tests/mpi/interpolate_02.cc
tests/mpi/interpolate_03.cc
tests/mpi/matrix_free_01.cc
tests/mpi/matrix_free_02.cc
tests/mpi/matrix_free_03.cc
tests/mpi/no_flux_constraints.cc
tests/mpi/no_flux_constraints_02.cc
tests/mpi/no_flux_constraints_03.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_3d_constraintmatrix_03.cc
tests/mpi/solution_transfer_01.cc
tests/multigrid/mg_renumbered_01.cc
tests/multigrid/mg_renumbered_02.cc
tests/multigrid/mg_renumbered_03.cc
tests/multigrid/step-16.cc
tests/umfpack/umfpack_01.cc
tests/umfpack/umfpack_02.cc
tests/umfpack/umfpack_03.cc
tests/umfpack/umfpack_04.cc
tests/umfpack/umfpack_07.cc
tests/umfpack/umfpack_08.cc
tests/umfpack/umfpack_09.cc
tests/umfpack/umfpack_10.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.