]> https://gitweb.dealii.org/ - dealii.git/commit
Move all code of MappingQGeneric to MappingQ 12561/head
authorMartin Kronbichler <kronbichler@lnm.mw.tum.de>
Sat, 10 Jul 2021 19:26:40 +0000 (21:26 +0200)
committerMartin Kronbichler <kronbichler@lnm.mw.tum.de>
Sun, 11 Jul 2021 07:43:04 +0000 (09:43 +0200)
commit4f286e62ea205701a1bbceb24a603ce0b18eebde
treee304716cab83c25ba686b7a9a650b59ea26eef3c
parentdce1df1fd0d0ad650232577cc79f8c2739fe5d96
Move all code of MappingQGeneric to MappingQ
282 files changed:
contrib/python-bindings/source/mapping_wrapper.cc
contrib/python-bindings/source/triangulation_wrapper.cc
examples/step-19/step-19.cc
examples/step-49/doc/results.dox
examples/step-6/doc/results.dox
examples/step-6/step-6.cc
examples/step-64/step-64.cu
examples/step-65/doc/intro.dox
examples/step-65/doc/results.dox
examples/step-65/step-65.cc
examples/step-66/doc/intro.dox
examples/step-66/step-66.cc
examples/step-67/step-67.cc
examples/step-76/step-76.cc
examples/step-79/step-79.cc
include/deal.II/fe/fe_values.h
include/deal.II/fe/mapping.h
include/deal.II/fe/mapping_c1.h
include/deal.II/fe/mapping_fe.h
include/deal.II/fe/mapping_q.h
include/deal.II/fe/mapping_q1.h
include/deal.II/fe/mapping_q1_eulerian.h
include/deal.II/fe/mapping_q_cache.h
include/deal.II/fe/mapping_q_eulerian.h
include/deal.II/fe/mapping_q_generic.h
include/deal.II/fe/mapping_q_internal.h
include/deal.II/grid/grid_generator.h
include/deal.II/grid/grid_out.h
include/deal.II/grid/manifold.h
include/deal.II/grid/manifold_lib.h
include/deal.II/grid/reference_cell.h
include/deal.II/hp/fe_values.h
include/deal.II/hp/mapping_collection.h
include/deal.II/matrix_free/fe_evaluation.h
include/deal.II/matrix_free/fe_point_evaluation.h
include/deal.II/matrix_free/mapping_data_on_the_fly.h
include/deal.II/matrix_free/mapping_info.templates.h
include/deal.II/numerics/derivative_approximation.h
include/deal.II/numerics/error_estimator.h
include/deal.II/numerics/matrix_tools.h
include/deal.II/numerics/vector_tools.h
include/deal.II/numerics/vector_tools_boundary.h
include/deal.II/numerics/vector_tools_constraints.h
include/deal.II/numerics/vector_tools_integrate_difference.h
include/deal.II/numerics/vector_tools_interpolate.h
include/deal.II/numerics/vector_tools_mean_value.h
include/deal.II/numerics/vector_tools_project.h
include/deal.II/numerics/vector_tools_rhs.h
source/fe/CMakeLists.txt
source/fe/mapping_c1.cc
source/fe/mapping_q.cc
source/fe/mapping_q1.cc
source/fe/mapping_q1_eulerian.cc
source/fe/mapping_q_cache.cc
source/fe/mapping_q_eulerian.cc
source/fe/mapping_q_generic.cc [deleted file]
source/fe/mapping_q_generic.inst.in [deleted file]
source/grid/grid_tools.cc
source/grid/grid_tools_dof_handlers.cc
source/grid/reference_cell.cc
source/hp/mapping_collection.cc
tests/aniso/solution_transfer.cc
tests/bits/find_cell_10.cc
tests/bits/find_cell_10a.cc
tests/bits/find_cell_12.cc
tests/bits/find_cell_7.cc
tests/bits/find_cell_alt_4.cc
tests/bits/find_cell_alt_5.cc
tests/bits/find_cell_alt_6.cc
tests/bits/point_difference_02.cc
tests/bits/point_gradient_02.cc
tests/bits/point_gradient_hp_02.cc
tests/bits/point_value_02.cc
tests/bits/point_value_hp_02.cc
tests/bits/solution_transfer.cc
tests/bits/step-12.cc
tests/bits/step-4_dg_periodic.cc
tests/bits/step-4_dg_periodic_coupling.cc
tests/codim_one/mapping_01.cc
tests/codim_one/mapping_q1.cc
tests/cuda/coefficient_eval.cu
tests/cuda/matrix_free_initialize_vector.cu
tests/cuda/matrix_free_matrix_vector_10.cu
tests/cuda/matrix_free_matrix_vector_10a.cu
tests/cuda/matrix_free_matrix_vector_19.cu
tests/cuda/matrix_free_matrix_vector_25.cu
tests/cuda/matrix_free_multiple_objects.cu
tests/cuda/matrix_free_reinit_01.cu
tests/cuda/matrix_vector_common.h
tests/cuda/precondition_03.cu
tests/data_out/data_out_11.cc
tests/data_out/data_out_base_vtk_04.cc
tests/data_out/data_out_base_vtk_05.cc
tests/data_out/data_out_base_vtu_04.cc
tests/data_out/data_out_base_vtu_05.cc
tests/data_out/data_out_curved_cells.cc
tests/data_out/data_out_mapping_collection_01.cc
tests/distributed_grids/solution_transfer_02.cc
tests/distributed_grids/solution_transfer_03.cc
tests/dofs/dof_tools_04a.cc
tests/dofs/interpolate_based_on_material_id_01.cc
tests/fe/abf_01.cc
tests/fe/abf_02.cc
tests/fe/cell_similarity_01.cc
tests/fe/cell_similarity_02.cc
tests/fe/cell_similarity_dgp_monomial_01.cc
tests/fe/cell_similarity_dgp_monomial_02.cc
tests/fe/cell_similarity_dgp_nonparametric_01.cc
tests/fe/cell_similarity_dgp_nonparametric_02.cc
tests/fe/deformed_projection.h
tests/fe/derivatives.cc
tests/fe/derivatives_bernstein.cc
tests/fe/derivatives_face.cc
tests/fe/fe_face_values_1d.cc
tests/fe/fe_project_2d.cc
tests/fe/fe_project_3d.cc
tests/fe/fe_tools_test.cc
tests/fe/fe_values_function_manifold.cc
tests/fe/fe_values_view_30.cc
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/fullydistributed_grids/copy_serial_tria_06.cc
tests/grid/find_all_active_cells_around_point_01.cc
tests/grid/find_all_active_cells_around_point_01_b.cc
tests/grid/find_all_active_cells_around_point_02.cc
tests/grid/find_all_active_cells_around_point_03.cc
tests/grid/grid_generator_marching_cube_algorithm_01.cc
tests/grid/grid_generator_open_torus.cc
tests/grid/grid_out_gnuplot_01.cc
tests/grid/grid_tools_aspect_ratio.cc
tests/grid/project_to_object_01.cc
tests/hp/project_01_curved_boundary.cc
tests/hp/solution_transfer.cc
tests/hp/solution_transfer_12.cc
tests/hp/step-12.cc
tests/integrators/assembler_simple_mgmatrix_04.cc
tests/integrators/cochain_01.cc
tests/integrators/mesh_worker_01.cc
tests/integrators/mesh_worker_02.cc
tests/integrators/mesh_worker_03.cc
tests/integrators/mesh_worker_1d_dg.cc
tests/integrators/mesh_worker_matrix_01.cc
tests/lac/block_linear_operator_01.cc
tests/lac/block_linear_operator_02.cc
tests/lac/block_linear_operator_06.cc
tests/lac/linear_operator_02.cc
tests/lac/linear_operator_02a.cc
tests/lac/linear_operator_03.cc
tests/lac/packaged_operation_02.cc
tests/manifold/polar_manifold_06.cc
tests/manifold/spherical_manifold_10.cc
tests/manifold/spherical_manifold_12.cc
tests/manifold/transfinite_manifold_03.cc
tests/mappings/mapping.cc
tests/mappings/mapping_fe_field_05.cc
tests/mappings/mapping_fe_field_06.cc
tests/mappings/mapping_fe_field_07.cc
tests/mappings/mapping_fe_field_08.cc
tests/mappings/mapping_fe_field_08.output
tests/mappings/mapping_get_bounding_box_01.cc
tests/mappings/mapping_get_bounding_box_01.output
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_points_real_to_unit.cc
tests/mappings/mapping_project_01.cc
tests/mappings/mapping_q1_cartesian_grid.cc
tests/mappings/mapping_q_cache_01.cc
tests/mappings/mapping_q_cache_02.cc
tests/mappings/mapping_q_cache_03.cc
tests/mappings/mapping_q_cache_04.cc
tests/mappings/mapping_q_cache_05.cc
tests/mappings/mapping_q_cache_06.cc
tests/mappings/mapping_q_cache_07.cc
tests/mappings/mapping_q_cache_08.cc
tests/mappings/mapping_q_eulerian.cc
tests/mappings/mapping_q_inverse_quadratic_approximation.cc
tests/mappings/mapping_q_mixed_manifolds_01.cc
tests/mappings/mapping_q_mixed_manifolds_02.cc
tests/mappings/mapping_q_points_real_to_unit.cc
tests/mappings/mapping_q_quadrature_points.cc
tests/mappings/mapping_q_real_to_unit_internal.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_q1_singular_02.cc
tests/mappings/mapping_real_to_unit_q4_sphere_x.cc
tests/mappings/mapping_real_to_unit_q4_sphere_y.cc
tests/matrix_free/boundary_id.cc
tests/matrix_free/compare_faces_by_cells.cc
tests/matrix_free/compress_mapping.cc
tests/matrix_free/mapping_info_01.cc
tests/matrix_free/matrix_vector_common.h
tests/matrix_free/matrix_vector_faces_14.cc
tests/matrix_free/matrix_vector_faces_29.cc
tests/matrix_free/matrix_vector_faces_common.h
tests/matrix_free/matrix_vector_mg.cc
tests/matrix_free/point_evaluation_01.cc
tests/matrix_free/point_evaluation_02.cc
tests/matrix_free/point_evaluation_03.cc
tests/matrix_free/point_evaluation_04.cc
tests/matrix_free/point_evaluation_09.cc
tests/matrix_free/point_evaluation_10.cc
tests/matrix_free/point_evaluation_11.cc
tests/matrix_free/point_evaluation_12.cc
tests/mpi/derivative_approximation_01.cc
tests/mpi/flux_edge_01.cc
tests/mpi/map_dofs_to_support_points.cc
tests/mpi/mesh_worker_matrix_01.cc
tests/mpi/periodicity_04.cc
tests/mpi/solution_transfer_09.cc
tests/mpi/solution_transfer_10.cc
tests/mpi/step-39-block.cc
tests/mpi/step-39.cc
tests/multigrid/mg_renumbered_02.cc
tests/multigrid/mg_renumbered_03.cc
tests/multigrid/step-16-02.cc
tests/multigrid/step-16-03.cc
tests/multigrid/step-16-04.cc
tests/multigrid/step-16-05.cc
tests/multigrid/step-16-06.cc
tests/multigrid/step-16-07.cc
tests/multigrid/step-16-08.cc
tests/multigrid/step-16-50-serial.cc
tests/multigrid/step-16-bdry1.cc
tests/multigrid/step-16.cc
tests/multigrid/step-39-02.cc
tests/multigrid/step-39-02a.cc
tests/multigrid/step-39-03.cc
tests/multigrid/step-39.cc
tests/numerics/derivative_approximation_02.cc
tests/numerics/derivatives.cc
tests/numerics/interpolate_to_different_mesh_01.cc
tests/numerics/interpolate_to_different_mesh_02.cc
tests/numerics/interpolate_to_different_mesh_03.cc
tests/numerics/interpolate_to_different_mesh_04.cc
tests/numerics/project_01_curved_boundary.cc
tests/numerics/project_boundary_rt_01.cc
tests/numerics/project_parallel_qp_common.h
tests/opencascade/normal_to_mesh_projection_03.cc
tests/opencascade/normal_to_mesh_projection_04.cc
tests/particles/generators_03.cc
tests/particles/local_particle_index.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/simplex/data_out_write_vtk_02.cc
tests/simplex/matrix_free_range_iteration_01.cc
tests/simplex/step-12b.cc
tests/simplex/step-12c.cc
tests/simplex/step-17.cc
tests/simplex/step-18.cc
tests/simplex/step-23.cc
tests/simplex/step-40.cc
tests/simplex/step-67.cc
tests/trilinos/precondition_amg_dgp_01.cc
tests/trilinos/precondition_amg_dgp_03.cc
tests/trilinos/precondition_muelu_dgp.cc
tests/vector_tools/get_position_vector_01.cc
tests/vector_tools/interpolate_with_material_id_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.