]> https://gitweb.dealii.org/ - dealii.git/commit
Update copyright year of all files touched in 2015. 2114/head
authorWolfgang Bangerth <bangerth@math.tamu.edu>
Sun, 24 Jan 2016 21:03:16 +0000 (15:03 -0600)
committerWolfgang Bangerth <bangerth@math.tamu.edu>
Sun, 24 Jan 2016 21:03:16 +0000 (15:03 -0600)
commit4dcb44c7140480ac165ba17fc2e6c922d1d8cf32
tree26002fed392b9e04701446e0465932d783809098
parent120decdf9b41e0edc32f52da29004b7830ad203d
Update copyright year of all files touched in 2015.
1532 files changed:
bundled/boost-1.56.0/libs/system/src/CMakeLists.txt
cmake/macros/macro_deal_ii_invoke_autopilot.cmake
cmake/macros/macro_enable_if_supported.cmake
cmake/macros/macro_filter_system_libraries.cmake
cmake/macros/macro_register_feature.cmake
cmake/macros/macro_replace_flag.cmake
cmake/macros/macro_strip_flag.cmake
cmake/modules/FindBOOST.cmake
cmake/modules/FindBZIP2.cmake
cmake/modules/FindMPI.cmake
cmake/modules/FindZLIB.cmake
cmake/scripts/expand_instantiations.cc
contrib/CMakeLists.txt
doc/doxygen/code-gallery/CMakeLists.txt
examples/doxygen/theta_timestepping.cc
examples/step-18/step-18.cc
examples/step-4/step-4.cc
examples/step-40/step-40.cc
examples/step-54/step-54.cc
include/deal.II/base/aligned_vector.h
include/deal.II/base/array_view.h
include/deal.II/base/parameter_handler.h
include/deal.II/base/polynomials_bdm.h
include/deal.II/base/table.h
include/deal.II/base/table_handler.h
include/deal.II/base/tensor.h
include/deal.II/distributed/shared_tria.h
include/deal.II/distributed/tria.h
include/deal.II/dofs/dof_handler.h
include/deal.II/dofs/dof_tools.h
include/deal.II/fe/fe_base.h
include/deal.II/fe/fe_dg_vector.templates.h
include/deal.II/fe/fe_system.h
include/deal.II/fe/fe_values.h
include/deal.II/fe/mapping.h
include/deal.II/grid/grid_generator.h
include/deal.II/grid/grid_out.h
include/deal.II/grid/grid_refinement.h
include/deal.II/grid/grid_tools.h
include/deal.II/grid/intergrid_map.h
include/deal.II/grid/tria.h
include/deal.II/hp/dof_handler.h
include/deal.II/hp/fe_collection.h
include/deal.II/lac/arpack_solver.h
include/deal.II/lac/linear_operator.h
include/deal.II/lac/parpack_solver.h
include/deal.II/lac/petsc_solver.h
include/deal.II/lac/schur_complement.h
include/deal.II/lac/slepc_solver.h
include/deal.II/lac/sparsity_tools.h
include/deal.II/matrix_free/fe_evaluation.h
include/deal.II/matrix_free/mapping_info.templates.h
include/deal.II/matrix_free/shape_info.templates.h
include/deal.II/meshworker/integration_info.templates.h
include/deal.II/multigrid/mg_base.h
include/deal.II/multigrid/mg_transfer.h
include/deal.II/multigrid/mg_transfer.templates.h
include/deal.II/numerics/dof_output_operator.templates.h
include/deal.II/numerics/error_estimator.templates.h
include/deal.II/numerics/vector_tools.templates.h
source/algorithms/operator.inst.in
source/base/parallel.cc
source/base/parameter_handler.cc
source/base/polynomial_space.cc
source/base/polynomials_abf.cc
source/base/polynomials_nedelec.cc
source/base/polynomials_p.cc
source/base/polynomials_raviart_thomas.cc
source/base/tensor_product_polynomials.cc
source/base/tensor_product_polynomials_const.cc
source/distributed/CMakeLists.txt
source/distributed/shared_tria.inst.in
source/distributed/solution_transfer.inst.in
source/distributed/tria.cc
source/distributed/tria_base.inst.in
source/dofs/dof_handler_policy.cc
source/dofs/dof_handler_policy.inst.in
source/dofs/dof_tools.inst.in
source/fe/fe_abf.cc
source/fe/fe_bdm.cc
source/fe/fe_data.cc
source/fe/fe_nedelec.cc
source/fe/fe_q_base.inst.in
source/fe/fe_q_bubbles.cc
source/fe/fe_q_bubbles.inst.in
source/fe/fe_raviart_thomas.cc
source/fe/fe_raviart_thomas_nodal.cc
source/fe/fe_system.cc
source/fe/fe_tools.inst.in
source/fe/fe_values_inst2.cc
source/grid/grid_generator.cc
source/grid/grid_in.inst.in
source/grid/grid_out.cc
source/grid/grid_tools.cc
source/grid/intergrid_map.cc
source/grid/tria.cc
source/grid/tria_accessor.inst.in
source/hp/fe_collection.cc
source/hp/fe_values.cc
source/lac/la_vector.inst.in
source/lac/petsc_solver.cc
source/lac/slepc_solver.cc
source/lac/sparse_matrix.cc
source/lac/sparse_matrix_inst2.cc
source/lac/trilinos_sparse_matrix.inst.in
source/lac/vector.inst.in
source/matrix_free/matrix_free.cc
source/matrix_free/matrix_free.inst.in
source/multigrid/CMakeLists.txt
source/multigrid/mg_base.cc
source/multigrid/mg_level_global_transfer.cc
source/multigrid/mg_level_global_transfer.inst.in
source/multigrid/mg_transfer_matrix_free.inst.in
source/multigrid/mg_transfer_prebuilt.cc
source/multigrid/mg_transfer_prebuilt.inst.in
source/numerics/data_out_faces.cc
source/numerics/error_estimator_1d.cc
source/numerics/solution_transfer.inst.in
source/numerics/solution_transfer_inst2.cc
source/numerics/solution_transfer_inst3.cc
source/numerics/solution_transfer_inst4.cc
tests/a-framework/build.cc
tests/a-framework/diff.cc
tests/a-framework/passed.cc
tests/a-framework/run.cc
tests/algorithms/theta_01.cc
tests/aniso/anisotropic_crash.cc
tests/aniso/fe_tools.cc
tests/aniso/solution_transfer.cc
tests/base/aligned_vector_01.cc
tests/base/aligned_vector_02.cc
tests/base/aligned_vector_03.cc
tests/base/aligned_vector_04.cc
tests/base/anisotropic_1.cc
tests/base/anisotropic_2.cc
tests/base/auto_derivative_function.cc
tests/base/boost_fusion.cc
tests/base/boost_iostreams_01.cc
tests/base/conditional_ostream.cc
tests/base/convergence_table_01.cc
tests/base/convergence_table_02.cc
tests/base/convergence_table_03.cc
tests/base/convergence_table_04.cc
tests/base/data_out_base.cc
tests/base/data_out_base_tecplot_bin.cc
tests/base/full_tensor_08.cc
tests/base/full_tensor_09.cc
tests/base/full_tensor_10.cc
tests/base/function_derivative.cc
tests/base/function_parser.cc
tests/base/function_parser_03.cc
tests/base/function_parser_04.cc
tests/base/functions_01.cc
tests/base/functions_02.cc
tests/base/functions_03.cc
tests/base/functions_04.cc
tests/base/functions_09.cc
tests/base/functions_singularity.cc
tests/base/geometry_info_2.cc
tests/base/geometry_info_3.cc
tests/base/geometry_info_8.cc
tests/base/graph_coloring_01.cc
tests/base/graph_coloring_02.cc
tests/base/graph_coloring_03.cc
tests/base/graph_coloring_05.cc
tests/base/graph_coloring_06.cc
tests/base/hierarchical.cc
tests/base/index_set_01.cc
tests/base/index_set_04.cc
tests/base/index_set_05.cc
tests/base/index_set_06.cc
tests/base/index_set_07.cc
tests/base/index_set_08.cc
tests/base/index_set_09.cc
tests/base/index_set_11.cc
tests/base/index_set_12.cc
tests/base/index_set_17.cc
tests/base/index_set_18.cc
tests/base/index_set_19.cc
tests/base/index_set_20.cc
tests/base/index_set_20_offset.cc
tests/base/index_set_21.cc
tests/base/index_set_22.cc
tests/base/index_set_23.cc
tests/base/index_set_readwrite_01.cc
tests/base/index_set_readwrite_02.cc
tests/base/index_set_readwrite_03.cc
tests/base/log_infinity.cc
tests/base/log_precision.cc
tests/base/log_width.cc
tests/base/logstream_end.cc
tests/base/logtest.cc
tests/base/memory_consumption_01.cc
tests/base/number_traits_real.cc
tests/base/parallel_accumulate.cc
tests/base/parallel_transform_02.cc
tests/base/point_01.cc
tests/base/polynomial1d.cc
tests/base/polynomial_hermite_interpolation.cc
tests/base/polynomial_lagrange.cc
tests/base/polynomial_lagrange_order.cc
tests/base/polynomial_lagrange_product.cc
tests/base/polynomial_minus_equals.cc
tests/base/polynomial_test.cc
tests/base/polynomials_bdm_01.cc
tests/base/polynomials_bdm_02.cc
tests/base/polynomials_rt.cc
tests/base/polynomials_tensor.cc
tests/base/qprojector.cc
tests/base/quadrature_selector.cc
tests/base/quadrature_sorted_test.cc
tests/base/quadrature_test.cc
tests/base/reference.cc
tests/base/slice_vector.cc
tests/base/stdcxx1x_vs_stdcxx11.cc
tests/base/symmetric_tensor_08.cc
tests/base/symmetric_tensor_09.cc
tests/base/symmetric_tensor_10.cc
tests/base/symmetric_tensor_20.cc
tests/base/symmetric_tensor_22.cc
tests/base/symmetric_tensor_26.cc
tests/base/table_02.cc
tests/base/table_03.cc
tests/base/table_04.cc
tests/base/table_06.cc
tests/base/table_handler_01.cc
tests/base/table_handler_02.cc
tests/base/table_handler_03.cc
tests/base/table_handler_04.cc
tests/base/table_handler_05.cc
tests/base/table_handler_06.cc
tests/base/table_handler_07.cc
tests/base/table_handler_08.cc
tests/base/table_handler_09.cc
tests/base/table_handler_10.cc
tests/base/table_handler_11.cc
tests/base/table_handler_12.cc
tests/base/task_01.cc
tests/base/task_03.cc
tests/base/task_04.cc
tests/base/task_05.cc
tests/base/task_06.cc
tests/base/task_07.cc
tests/base/task_08.cc
tests/base/tensor_02.cc
tests/base/tensor_03.cc
tests/base/tensor_04.cc
tests/base/tensor_05.cc
tests/base/tensor_06.cc
tests/base/tensor_08.cc
tests/base/tensor_24.cc
tests/base/tensor_26.cc
tests/base/tensor_complex_06.cc
tests/base/thread_local_storage_01.cc
tests/base/thread_local_storage_02.cc
tests/base/thread_local_storage_03.cc
tests/base/thread_local_storage_04.cc
tests/base/thread_validity_07.cc
tests/base/thread_validity_08.cc
tests/base/thread_validity_10.cc
tests/base/thread_validity_12.cc
tests/base/time_stepping_01.cc
tests/base/timer.cc
tests/base/timer_02.cc
tests/base/utilities_02.cc
tests/base/utilities_04.cc
tests/base/utilities_06.cc
tests/base/utilities_07.cc
tests/base/vectorization_02.cc
tests/base/vectorization_03.cc
tests/base/vectorization_04.cc
tests/base/work_stream_01.cc
tests/base/work_stream_02.cc
tests/base/work_stream_04.cc
tests/benchmarks/test_hp/step.cc
tests/benchmarks/test_poisson/poisson.cc
tests/bits/anna_1.cc
tests/bits/anna_2.cc
tests/bits/anna_3.cc
tests/bits/apply_boundary_values_01.cc
tests/bits/apply_boundary_values_02.cc
tests/bits/apply_boundary_values_03.cc
tests/bits/apply_boundary_values_04.cc
tests/bits/block_matrix_array_01.cc
tests/bits/block_sparse_matrix_1.cc
tests/bits/block_sparse_matrix_iterator_01.cc
tests/bits/block_sparse_matrix_iterator_02.cc
tests/bits/block_sparse_matrix_iterator_03.cc
tests/bits/block_sparse_matrix_iterator_05.cc
tests/bits/christian_1.cc
tests/bits/christian_2.cc
tests/bits/chunk_sparse_matrix_01a.cc
tests/bits/chunk_sparse_matrix_06.cc
tests/bits/chunk_sparse_matrix_07.cc
tests/bits/chunk_sparse_matrix_08.cc
tests/bits/chunk_sparse_matrix_11.cc
tests/bits/chunk_sparse_matrix_12.cc
tests/bits/chunk_sparse_matrix_13.cc
tests/bits/chunk_sparse_matrix_14.cc
tests/bits/chunk_sparse_matrix_15.cc
tests/bits/chunk_sparse_matrix_16.cc
tests/bits/chunk_sparse_matrix_iterator_01.cc
tests/bits/chunk_sparse_matrix_iterator_04.cc
tests/bits/chunk_sparse_matrix_iterator_05.cc
tests/bits/chunk_sparse_matrix_iterator_06.cc
tests/bits/chunk_sparse_matrix_iterator_07.cc
tests/bits/chunk_sparse_matrix_iterator_08.cc
tests/bits/chunk_sparse_matrix_iterator_09.cc
tests/bits/chunk_sparse_matrix_iterator_10.cc
tests/bits/chunk_sparse_matrix_vector_01.cc
tests/bits/coarsening_3d.cc
tests/bits/complex_vector_11.cc
tests/bits/complex_vector_24.cc
tests/bits/complex_vector_27.cc
tests/bits/complex_vector_28.cc
tests/bits/complex_vector_29.cc
tests/bits/complex_vector_49.cc
tests/bits/compressed_set_sparsity_pattern_01.cc
tests/bits/compressed_set_sparsity_pattern_02.cc
tests/bits/compressed_set_sparsity_pattern_03.cc
tests/bits/compressed_set_sparsity_pattern_06.cc
tests/bits/compressed_set_sparsity_pattern_07.cc
tests/bits/compressed_set_sparsity_pattern_08.cc
tests/bits/compressed_sparsity_pattern_01.cc
tests/bits/compressed_sparsity_pattern_02.cc
tests/bits/compressed_sparsity_pattern_03.cc
tests/bits/compressed_sparsity_pattern_04.cc
tests/bits/compressed_sparsity_pattern_05.cc
tests/bits/compressed_sparsity_pattern_06.cc
tests/bits/compressed_sparsity_pattern_07.cc
tests/bits/compressed_sparsity_pattern_08.cc
tests/bits/cone_01.cc
tests/bits/cone_02.cc
tests/bits/count_dofs_per_block_01.cc
tests/bits/count_dofs_per_block_02.cc
tests/bits/count_dofs_per_component_hp_01.cc
tests/bits/count_dofs_per_component_hp_02.cc
tests/bits/cylinder_01.cc
tests/bits/cylinder_02.cc
tests/bits/cylinder_03.cc
tests/bits/cylinder_04.cc
tests/bits/cylinder_shell_01.cc
tests/bits/cylinder_shell_02.cc
tests/bits/data_out_07.cc
tests/bits/data_out_08.cc
tests/bits/data_out_09.cc
tests/bits/data_out_common.h
tests/bits/data_out_multi_dh_01.cc
tests/bits/data_out_multi_dh_02.cc
tests/bits/data_out_multi_dh_03.cc
tests/bits/data_out_multi_dh_04.cc
tests/bits/data_out_multi_dh_05.cc
tests/bits/data_out_stack_01.cc
tests/bits/data_out_stack_02.cc
tests/bits/data_out_stack_03.cc
tests/bits/deal_solver_04.cc
tests/bits/deal_solver_05.cc
tests/bits/denis_1.cc
tests/bits/distorted_cells_01.cc
tests/bits/distorted_cells_02.cc
tests/bits/distorted_cells_07.cc
tests/bits/distorted_mapped_cells_01.cc
tests/bits/distorted_mapped_cells_02.cc
tests/bits/dof_constraints_01.cc
tests/bits/dof_constraints_02.cc
tests/bits/dof_constraints_03.cc
tests/bits/dof_constraints_06.cc
tests/bits/dof_constraints_06_x.cc
tests/bits/dof_constraints_09.cc
tests/bits/dof_constraints_10.cc
tests/bits/dof_constraints_10_x.cc
tests/bits/dof_constraints_11.cc
tests/bits/dof_constraints_11_x.cc
tests/bits/dof_tools_06.cc
tests/bits/dof_tools_13.cc
tests/bits/dof_tools_19.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_vector.cc
tests/bits/fe_field_function_05_vector.cc
tests/bits/fe_q_3d_01.cc
tests/bits/fe_q_constraints.cc
tests/bits/fe_system.cc
tests/bits/fe_tools_01a.cc
tests/bits/fe_tools_01b.cc
tests/bits/fe_tools_01c.cc
tests/bits/find_cell_1.cc
tests/bits/find_cell_2.cc
tests/bits/find_cell_3.cc
tests/bits/find_cell_6.cc
tests/bits/find_cell_alt_1.cc
tests/bits/find_cell_alt_2.cc
tests/bits/find_cell_alt_3.cc
tests/bits/find_cell_alt_4.cc
tests/bits/find_cell_alt_5.cc
tests/bits/find_cell_alt_6.cc
tests/bits/find_cell_alt_7.cc
tests/bits/find_cells_adjacent_to_vertex_1.cc
tests/bits/find_cells_adjacent_to_vertex_2.cc
tests/bits/find_cells_adjacent_to_vertex_3.cc
tests/bits/find_cells_adjacent_to_vertex_4.cc
tests/bits/find_cells_adjacent_to_vertex_5.cc
tests/bits/find_cells_adjacent_to_vertex_6.cc
tests/bits/find_closest_vertex_1.cc
tests/bits/full_matrix_56.cc
tests/bits/full_matrix_57.cc
tests/bits/full_matrix_common.h
tests/bits/gerold_1.cc
tests/bits/get_dof_indices_01.cc
tests/bits/get_fe_from_name.cc
tests/bits/joa_1.cc
tests/bits/make_boundary_constraints_01.cc
tests/bits/make_boundary_constraints_02.cc
tests/bits/make_boundary_constraints_03.cc
tests/bits/map_dofs_to_support_points_hp_01.cc
tests/bits/map_dofs_to_support_points_hp_02.cc
tests/bits/mapping_cartesian_1.cc
tests/bits/mapping_q1_eulerian_01.cc
tests/bits/mapping_q4_3d.cc
tests/bits/mapping_q_eulerian_01.cc
tests/bits/mapping_q_eulerian_02.cc
tests/bits/mapping_q_eulerian_03.cc
tests/bits/mapping_q_eulerian_04.cc
tests/bits/mapping_q_eulerian_05.cc
tests/bits/max_n_cells_01.cc
tests/bits/max_n_cells_02.cc
tests/bits/multiple_parameter_loop_01.cc
tests/bits/multiple_parameter_loop_02.cc
tests/bits/nedelec_1.cc
tests/bits/neighboring_cells_at_two_faces.cc
tests/bits/normals_1.cc
tests/bits/normals_2.cc
tests/bits/normals_3.cc
tests/bits/normals_4.cc
tests/bits/oliver_01.cc
tests/bits/parameter_handler_1.cc
tests/bits/parameter_handler_10.cc
tests/bits/parameter_handler_11.cc
tests/bits/parameter_handler_12.cc
tests/bits/parameter_handler_13.cc
tests/bits/parameter_handler_13a.cc
tests/bits/parameter_handler_14.cc
tests/bits/parameter_handler_15.cc
tests/bits/parameter_handler_16.cc
tests/bits/parameter_handler_18.cc
tests/bits/parameter_handler_1_exception.cc
tests/bits/parameter_handler_1_include.cc
tests/bits/parameter_handler_1_include_fail.cc
tests/bits/parameter_handler_1a.cc
tests/bits/parameter_handler_2.cc
tests/bits/parameter_handler_21.cc
tests/bits/parameter_handler_2_read_from_string.cc
tests/bits/parameter_handler_3.cc
tests/bits/parameter_handler_4.cc
tests/bits/parameter_handler_4a.cc
tests/bits/parameter_handler_4b.cc
tests/bits/parameter_handler_5.cc
tests/bits/parameter_handler_6.cc
tests/bits/parameter_handler_6_bool.cc
tests/bits/parameter_handler_7.cc
tests/bits/parameter_handler_8.cc
tests/bits/parameter_handler_9.cc
tests/bits/parameter_handler_read_xml_error_01.cc
tests/bits/parameter_handler_write_json.cc
tests/bits/parameter_handler_write_section_1.cc
tests/bits/parameter_handler_write_section_2.cc
tests/bits/parameter_handler_write_section_xml.cc
tests/bits/parameter_handler_write_xml.cc
tests/bits/parsed_function.cc
tests/bits/periodicity_01.cc
tests/bits/periodicity_02.cc
tests/bits/periodicity_03.cc
tests/bits/periodicity_04.cc
tests/bits/point_difference_01.cc
tests/bits/point_difference_02.cc
tests/bits/point_inside_2.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/q_point_sum_1.cc
tests/bits/q_point_sum_2.cc
tests/bits/q_point_sum_3.cc
tests/bits/q_point_sum_4.cc
tests/bits/roy_1.cc
tests/bits/rt_1.cc
tests/bits/serialize_dof_handler.cc
tests/bits/serialize_hp_dof_handler.cc
tests/bits/solution_transfer.cc
tests/bits/solver_01.cc
tests/bits/sparse_lu_decomposition_1.cc
tests/bits/sparse_matrix_02.cc
tests/bits/sparse_matrix_05.cc
tests/bits/sparse_matrix_05a.cc
tests/bits/sparse_matrix_06.cc
tests/bits/sparse_matrix_07.cc
tests/bits/sparse_matrix_iterator_01.cc
tests/bits/sparse_matrix_iterator_02.cc
tests/bits/sparse_matrix_iterator_03.cc
tests/bits/sparse_matrix_iterator_04.cc
tests/bits/sparse_matrix_iterator_05.cc
tests/bits/sparse_matrix_iterator_06.cc
tests/bits/sparse_matrix_iterator_07.cc
tests/bits/sparse_matrix_iterator_08.cc
tests/bits/sparse_matrix_iterator_09.cc
tests/bits/sparse_matrix_iterator_10.cc
tests/bits/sparsity_pattern_01.cc
tests/bits/sparsity_pattern_01_x.cc
tests/bits/sparsity_pattern_iterator_01.cc
tests/bits/step-10-high-order.cc
tests/bits/step-10.cc
tests/bits/step-11.cc
tests/bits/step-2.cc
tests/bits/step-3.cc
tests/bits/step-4.cc
tests/bits/step-5.cc
tests/bits/step-6-racoptimize-2.cc
tests/bits/step-6-racoptimize.cc
tests/bits/step-6.cc
tests/bits/unit_support_points_02.cc
tests/bits/vector_17.cc
tests/bits/vector_27.cc
tests/bits/vector_28.cc
tests/bits/vector_38.cc
tests/bits/vector_48.cc
tests/bits/vector_49.cc
tests/bits/vector_equality_8.cc
tests/bits/volume_1.cc
tests/bits/volume_2.cc
tests/bits/volume_3.cc
tests/bits/volume_4.cc
tests/codim_one/data_out.cc
tests/codim_one/data_out_02.cc
tests/codim_one/data_out_03.cc
tests/codim_one/direction_flag_01.cc
tests/codim_one/direction_flag_02.cc
tests/codim_one/error_estimator_02.cc
tests/codim_one/extract_boundary_mesh_01.cc
tests/codim_one/extract_boundary_mesh_05.cc
tests/codim_one/extract_boundary_mesh_06.cc
tests/codim_one/extract_boundary_mesh_07.cc
tests/codim_one/fe_dgq_prolongation_01.cc
tests/codim_one/fe_values_extractor_01.cc
tests/codim_one/gradients_1.cc
tests/codim_one/grid_in_out.cc
tests/codim_one/grid_in_out_02.cc
tests/codim_one/grid_in_out_03.cc
tests/codim_one/grid_refinement.cc
tests/codim_one/integrate_log.cc
tests/codim_one/integrate_log_2.cc
tests/codim_one/integrate_one_over_r.cc
tests/codim_one/interpolate_boundary_values_01_vector_valued.cc
tests/codim_one/interpolation.cc
tests/codim_one/interpolation_2.cc
tests/codim_one/interpolation_3.cc
tests/codim_one/mapping_03.cc
tests/codim_one/mapping_q1_eulerian.cc
tests/codim_one/mapping_q_eulerian.cc
tests/codim_one/normal_vectors_01.cc
tests/codim_one/projection.cc
tests/codim_one/projection_dgp.cc
tests/codim_one/renumber_component_wise_01.cc
tests/codim_one/solution_transfer_01.cc
tests/codim_one/tensor_matrix_conversion.cc
tests/codim_one/torus_01.cc
tests/distributed_grids/2d_coarse_grid_01.cc
tests/distributed_grids/2d_coarse_grid_02.cc
tests/distributed_grids/2d_coarse_grid_03.cc
tests/distributed_grids/2d_coarse_grid_04.cc
tests/distributed_grids/2d_coarse_grid_x_01.cc
tests/distributed_grids/2d_coarsening_01.cc
tests/distributed_grids/2d_coarsening_02.cc
tests/distributed_grids/2d_coarsening_03.cc
tests/distributed_grids/2d_coarsening_05.cc
tests/distributed_grids/2d_dofhandler_01.cc
tests/distributed_grids/2d_refinement_01.cc
tests/distributed_grids/2d_refinement_02.cc
tests/distributed_grids/2d_refinement_03.cc
tests/distributed_grids/2d_refinement_04.cc
tests/distributed_grids/2d_refinement_05.cc
tests/distributed_grids/2d_refinement_06.cc
tests/distributed_grids/2d_refinement_07.cc
tests/distributed_grids/3d_coarse_grid_01.cc
tests/distributed_grids/3d_coarse_grid_02.cc
tests/distributed_grids/3d_coarse_grid_03.cc
tests/distributed_grids/3d_coarse_grid_04.cc
tests/distributed_grids/3d_coarse_grid_05.cc
tests/distributed_grids/3d_coarse_grid_06.cc
tests/distributed_grids/3d_coarse_grid_x_01.cc
tests/distributed_grids/3d_coarsening_01.cc
tests/distributed_grids/3d_coarsening_02.cc
tests/distributed_grids/3d_coarsening_03.cc
tests/distributed_grids/3d_coarsening_04.cc
tests/distributed_grids/3d_coarsening_05.cc
tests/distributed_grids/3d_refinement_01.cc
tests/distributed_grids/3d_refinement_02.cc
tests/distributed_grids/3d_refinement_03.cc
tests/distributed_grids/3d_refinement_04.cc
tests/distributed_grids/3d_refinement_05.cc
tests/distributed_grids/3d_refinement_06.cc
tests/distributed_grids/3d_refinement_07.cc
tests/distributed_grids/3d_refinement_09.cc
tests/distributed_grids/anisotropic.cc
tests/distributed_grids/codim_01.cc
tests/distributed_grids/count_dofs_per_component_01.cc
tests/distributed_grids/solution_transfer_01.cc
tests/distributed_grids/solution_transfer_02.cc
tests/distributed_grids/solution_transfer_03.cc
tests/distributed_grids/solution_transfer_04.cc
tests/distributed_grids/subdomain_id_01.cc
tests/distributed_grids/tria_settings_01.cc
tests/distributed_grids/update_number_cache_01.cc
tests/dofs/accessor_01.cc
tests/dofs/accessor_02.cc
tests/dofs/dof_accessor_01.cc
tests/dofs/dof_handler_number_cache_02.cc
tests/dofs/dof_renumbering_07.cc
tests/dofs/dof_renumbering_zorder_01.cc
tests/dofs/dof_renumbering_zorder_02.cc
tests/dofs/extract_dofs_by_component_01.cc
tests/dofs/extract_dofs_by_component_01_hp.cc
tests/dofs/extract_dofs_by_component_01_mg.cc
tests/dofs/extract_dofs_by_component_01x.cc
tests/dofs/extract_dofs_by_component_01y.cc
tests/dofs/extract_dofs_by_component_02.cc
tests/dofs/extract_dofs_by_component_02_hp.cc
tests/dofs/extract_dofs_by_component_03.cc
tests/dofs/extract_dofs_by_component_04.cc
tests/dofs/extract_dofs_by_component_05.cc
tests/dofs/extract_dofs_by_component_05_hp.cc
tests/dofs/extract_dofs_by_component_06.cc
tests/dofs/extract_dofs_by_component_06_hp.cc
tests/dofs/interpolate_dgq_01.cc
tests/dofs/interpolate_dgq_02.cc
tests/dofs/interpolate_q_01.cc
tests/dofs/interpolate_q_02.cc
tests/dofs/interpolate_q_system_01.cc
tests/dofs/interpolate_q_system_02.cc
tests/dofs/locally_relevant_dofs_per_subdomain_01.cc
tests/dofs/range_based_for_step-6.cc
tests/dofs/sparsity_pattern_02.cc
tests/dofs/sparsity_pattern_03.cc
tests/dofs/sparsity_pattern_04.cc
tests/dofs/sparsity_pattern_05.cc
tests/dofs/sparsity_pattern_05_x.cc
tests/fail/fe_nothing_04.cc
tests/fail/rt_4.cc
tests/fail/rt_6.cc
tests/fail/rt_crash_01.cc
tests/fail/vectors_boundary_rhs_hp_02.cc
tests/fail/vectors_rhs_hp_02.cc
tests/fe/bdm_10.cc
tests/fe/bdm_11.cc
tests/fe/bdm_12.cc
tests/fe/bdm_13.cc
tests/fe/bdm_14.cc
tests/fe/bdm_15.cc
tests/fe/bdm_2.cc
tests/fe/bdm_3.cc
tests/fe/bdm_5.cc
tests/fe/bdm_8.cc
tests/fe/bdm_9.cc
tests/fe/block_mask_02.cc
tests/fe/block_mask_06.cc
tests/fe/block_mask_07.cc
tests/fe/cell_similarity_crash_01.cc
tests/fe/cell_similarity_crash_02.cc
tests/fe/component_mask_06.cc
tests/fe/component_mask_07.cc
tests/fe/component_mask_14.cc
tests/fe/copy_01.cc
tests/fe/crash_01.cc
tests/fe/curl_curl_01.cc
tests/fe/derivatives.cc
tests/fe/derivatives_face.cc
tests/fe/dgp_monomial_1.cc
tests/fe/dgp_monomial_2.cc
tests/fe/dgq_1.cc
tests/fe/element_constant_modes.cc
tests/fe/face_to_cell_q1_2d.cc
tests/fe/face_to_cell_q2_2d.cc
tests/fe/face_to_cell_q2xq2_2d.cc
tests/fe/face_to_cell_q3_2d.cc
tests/fe/face_to_cell_q3xq4_2d.cc
tests/fe/face_to_cell_q4_2d.cc
tests/fe/fe_data_test.cc
tests/fe/fe_face_values_1d.cc
tests/fe/fe_face_values_1d_mapping_cartesian.cc
tests/fe/fe_face_values_1d_mapping_q2.cc
tests/fe/fe_prolongation_common.h
tests/fe/fe_prolongation_q_bubbles.cc
tests/fe/fe_q_01.cc
tests/fe/fe_q_bubbles.cc
tests/fe/fe_restriction_common.h
tests/fe/fe_restriction_q_bubbles.cc
tests/fe/fe_support_points_common.h
tests/fe/fe_support_points_q_bubbles.cc
tests/fe/fe_tools.cc
tests/fe/fe_tools_block_renumbering.cc
tests/fe/fe_tools_test.cc
tests/fe/fe_values_extractor_01.cc
tests/fe/fe_values_view_01.cc
tests/fe/fe_values_view_03.cc
tests/fe/fe_values_view_05.cc
tests/fe/fe_values_view_06.cc
tests/fe/fe_values_view_07.cc
tests/fe/fe_values_view_08.cc
tests/fe/fe_values_view_09.cc
tests/fe/fe_values_view_10.cc
tests/fe/fe_values_view_10_single_01.cc
tests/fe/fe_values_view_10_single_02.cc
tests/fe/fe_values_view_10_single_03.cc
tests/fe/fe_values_view_10_single_04.cc
tests/fe/fe_values_view_11.cc
tests/fe/fe_values_view_12.cc
tests/fe/fe_values_view_13.cc
tests/fe/fe_values_view_14.cc
tests/fe/fe_values_view_15.cc
tests/fe/fe_values_view_16.cc
tests/fe/fe_values_view_17.cc
tests/fe/fe_values_view_21.cc
tests/fe/fe_values_view_21_nonsymmetric.cc
tests/fe/fe_values_view_23.cc
tests/fe/fe_values_view_23_nonsymmetric.cc
tests/fe/fe_values_view_24.cc
tests/fe/fe_values_view_24_nonsymmetric.cc
tests/fe/fe_values_view_25.cc
tests/fe/fe_values_view_25_nonsymmetric.cc
tests/fe/fe_values_view_26.cc
tests/fe/fe_values_view_27.cc
tests/fe/fe_values_view_30.cc
tests/fe/fe_values_view_invalid_01.cc
tests/fe/fe_values_view_invalid_02.cc
tests/fe/fe_values_view_invalid_03.cc
tests/fe/fe_values_view_invalid_03_nonsymmetric.cc
tests/fe/get_dof_association.cc
tests/fe/get_fe_from_name_01.cc
tests/fe/get_name_01.cc
tests/fe/get_name_02.cc
tests/fe/interpolate_common.h
tests/fe/interpolate_q1.cc
tests/fe/interpolate_q_bubbles.cc
tests/fe/interpolate_q_dg0.cc
tests/fe/interpolate_q_iso_q1.cc
tests/fe/interpolate_rt.cc
tests/fe/interpolate_rtn.cc
tests/fe/interpolate_system.cc
tests/fe/jacobians.cc
tests/fe/mapping_q1_eulerian.cc
tests/fe/mapping_q_eulerian.cc
tests/fe/mass_matrix_arbitrary_nodes.cc
tests/fe/nedelec.cc
tests/fe/nedelec_2.cc
tests/fe/nedelec_3.cc
tests/fe/nedelec_crash_01.cc
tests/fe/nedelec_crash_hp.cc
tests/fe/nedelec_face_interpolation.cc
tests/fe/q_1.cc
tests/fe/q_2.cc
tests/fe/q_3.cc
tests/fe/q_4.cc
tests/fe/q_bubbles_projection_01.cc
tests/fe/restrict_prolongation_01.cc
tests/fe/rt_1.cc
tests/fe/rt_10.cc
tests/fe/rt_11.cc
tests/fe/rt_12.cc
tests/fe/rt_13.cc
tests/fe/rt_14.cc
tests/fe/rt_15.cc
tests/fe/rt_2.cc
tests/fe/rt_3.cc
tests/fe/rt_5.cc
tests/fe/rt_7.cc
tests/fe/rt_8.cc
tests/fe/rt_9.cc
tests/fe/rt_covariant.cc
tests/fe/rt_hessian.cc
tests/fe/rtdiff.cc
tests/fe/rtn_1.cc
tests/fe/rtn_2.cc
tests/fe/rtn_3.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_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/system_01.cc
tests/fe/system_02.cc
tests/fe/system_index.cc
tests/fe/traits.cc
tests/gla/block_mat_01.cc
tests/gla/block_vec_01.cc
tests/gla/block_vec_02.cc
tests/gla/block_vec_03.cc
tests/gla/block_vec_04.cc
tests/gla/mat_01.cc
tests/gla/mat_02.cc
tests/gla/vec_03.cc
tests/gla/vec_04.cc
tests/gla/vec_05.cc
tests/gla/vec_06.cc
tests/gla/vec_07.cc
tests/grid/distort_random.cc
tests/grid/extent_in_direction.cc
tests/grid/flatten_grid_01.cc
tests/grid/grid_generator_01a.cc
tests/grid/grid_generator_02.cc
tests/grid/grid_generator_03.cc
tests/grid/grid_generator_04.cc
tests/grid/grid_generator_05.cc
tests/grid/grid_generator_09.cc
tests/grid/grid_hyper_shell_02.cc
tests/grid/grid_hyper_shell_03.cc
tests/grid/grid_hyper_shell_04.cc
tests/grid/grid_in.cc
tests/grid/grid_in_3d.cc
tests/grid/grid_in_3d_02.cc
tests/grid/grid_in_abaqus_01.cc
tests/grid/grid_in_gmsh_01.cc
tests/grid/grid_in_gmsh_02.cc
tests/grid/grid_in_msh.cc
tests/grid/grid_in_msh_02.cc
tests/grid/grid_in_msh_03.cc
tests/grid/grid_in_msh_version_1.cc
tests/grid/grid_in_msh_version_2.cc
tests/grid/grid_in_tecplot.cc
tests/grid/grid_in_unv_2d.cc
tests/grid/grid_in_unv_3d.cc
tests/grid/grid_in_vtk_2d.cc
tests/grid/grid_in_vtk_3d.cc
tests/grid/grid_in_vtk_3d_02.cc
tests/grid/grid_in_vtk_3d_03.cc
tests/grid/grid_invert.cc
tests/grid/grid_out.cc
tests/grid/grid_out_02.cc
tests/grid/grid_out_svg_02.cc
tests/grid/grid_output_input.cc
tests/grid/grid_parallelepiped.cc
tests/grid/grid_parallelepiped_01.cc
tests/grid/grid_parallelepiped_02.cc
tests/grid/grid_parallelepiped_03.cc
tests/grid/grid_tools.cc
tests/grid/grid_tools_02.cc
tests/grid/grid_tools_03.cc
tests/grid/grid_tools_04.cc
tests/grid/grid_tools_transform_01.cc
tests/grid/grid_transform_02.cc
tests/grid/intergrid_constraints.cc
tests/grid/intergrid_map.cc
tests/grid/line_coarsening_3d.cc
tests/grid/maximal_cell_diameter.cc
tests/grid/measure_et_al.cc
tests/grid/measure_et_al_02.cc
tests/grid/measure_of_3d_face_01.cc
tests/grid/merge_triangulations_01.cc
tests/grid/mesh_3d_1.cc
tests/grid/mesh_3d_12.cc
tests/grid/mesh_3d_16.cc
tests/grid/mesh_3d_17.cc
tests/grid/mesh_3d_19.cc
tests/grid/mesh_3d_2.cc
tests/grid/mesh_3d_22.cc
tests/grid/mesh_3d_23.cc
tests/grid/mesh_3d_24.cc
tests/grid/mesh_3d_25.cc
tests/grid/mesh_3d_26.cc
tests/grid/mesh_3d_4.cc
tests/grid/mesh_3d_5.cc
tests/grid/mesh_smoothing_03.cc
tests/grid/minimal_cell_diameter.cc
tests/grid/normal_vector_03.cc
tests/grid/normal_vector_03_2d.cc
tests/grid/normals_at_vertices_01.cc
tests/grid/normals_at_vertices_02.cc
tests/grid/number_cache_01.cc
tests/grid/number_cache_02.cc
tests/grid/number_cache_03.cc
tests/grid/refine_and_coarsen_01.cc
tests/grid/refinement_listener_02.cc
tests/grid/refinement_listener_03.cc
tests/grid/subcelldata.cc
tests/grid/tria_iterator_with_one_header.cc
tests/grid/tria_last.cc
tests/grid/union_triangulation.cc
tests/grid/vertex_as_face_01.cc
tests/grid/vertex_as_face_02.cc
tests/grid/vertex_as_face_03.cc
tests/grid/vertex_as_face_05.cc
tests/grid/vertex_as_face_06.cc
tests/grid/vertex_as_face_07.cc
tests/grid/vertex_as_face_12.cc
tests/grid/vertex_as_face_13.cc
tests/hp/compare_hp_vs_nonhp_01.cc
tests/hp/continuous_1d_01.cc
tests/hp/continuous_2d_01.cc
tests/hp/continuous_3d_01.cc
tests/hp/copy_tria_bug.cc
tests/hp/count_dofs_per_block_01.cc
tests/hp/count_dofs_per_block_02.cc
tests/hp/crash_01.cc
tests/hp/crash_02.cc
tests/hp/crash_03.cc
tests/hp/crash_04.cc
tests/hp/crash_05.cc
tests/hp/crash_06.cc
tests/hp/crash_07.cc
tests/hp/crash_08.cc
tests/hp/crash_09.cc
tests/hp/crash_10.cc
tests/hp/crash_11.cc
tests/hp/crash_12.cc
tests/hp/crash_14.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/crash_20.cc
tests/hp/crash_21.cc
tests/hp/create_laplace_matrix_constraints_02.cc
tests/hp/create_laplace_matrix_constraints_02b.cc
tests/hp/create_mass_matrix_constraints_02.cc
tests/hp/create_mass_matrix_constraints_02b.cc
tests/hp/do_function_derivatives_01.cc
tests/hp/do_function_hessians_01.cc
tests/hp/do_function_laplacians_01.cc
tests/hp/fe_collection_01.cc
tests/hp/fe_collection_04.cc
tests/hp/fe_nothing_01.cc
tests/hp/fe_nothing_02.cc
tests/hp/fe_nothing_03.cc
tests/hp/fe_nothing_05.cc
tests/hp/fe_nothing_06.cc
tests/hp/fe_nothing_07.cc
tests/hp/fe_nothing_08.cc
tests/hp/fe_nothing_09.cc
tests/hp/fe_nothing_10.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/fe_nothing_15.cc
tests/hp/fe_nothing_16.cc
tests/hp/fe_nothing_17.cc
tests/hp/fe_nothing_19.cc
tests/hp/fe_nothing_20.cc
tests/hp/fe_nothing_21.cc
tests/hp/get_active_fe_indices.cc
tests/hp/get_interpolated_dof_values_01.cc
tests/hp/get_interpolated_dof_values_03.cc
tests/hp/hp_dof_handler.cc
tests/hp/hp_hanging_nodes_01.cc
tests/hp/hp_hanging_nodes_02.cc
tests/hp/hp_line_dof_identities_dgp.cc
tests/hp/hp_line_dof_identities_dgp_monomial.cc
tests/hp/hp_line_dof_identities_dgp_monomial_system_01.cc
tests/hp/hp_line_dof_identities_dgp_monomial_system_02.cc
tests/hp/hp_line_dof_identities_dgp_nonparametric.cc
tests/hp/hp_line_dof_identities_dgp_nonparametric_system_01.cc
tests/hp/hp_line_dof_identities_dgp_system_01.cc
tests/hp/hp_line_dof_identities_dgp_system_02.cc
tests/hp/hp_line_dof_identities_dgq.cc
tests/hp/hp_line_dof_identities_dgq_system_01.cc
tests/hp/hp_line_dof_identities_dgq_system_02.cc
tests/hp/hp_line_dof_identities_q.cc
tests/hp/hp_line_dof_identities_q_gl.cc
tests/hp/hp_line_dof_identities_q_system_01.cc
tests/hp/hp_line_dof_identities_q_system_02.cc
tests/hp/hp_line_dof_identities_q_system_03.cc
tests/hp/hp_line_dof_identities_rt_nodal.cc
tests/hp/hp_quad_dof_identities_dgp.cc
tests/hp/hp_quad_dof_identities_dgp_monomial.cc
tests/hp/hp_quad_dof_identities_dgp_monomial_system_01.cc
tests/hp/hp_quad_dof_identities_dgp_monomial_system_02.cc
tests/hp/hp_quad_dof_identities_dgp_nonparametric.cc
tests/hp/hp_quad_dof_identities_dgp_nonparametric_system_01.cc
tests/hp/hp_quad_dof_identities_dgp_nonparametric_system_02.cc
tests/hp/hp_quad_dof_identities_dgp_system_01.cc
tests/hp/hp_quad_dof_identities_dgp_system_02.cc
tests/hp/hp_quad_dof_identities_dgq.cc
tests/hp/hp_quad_dof_identities_dgq_system_01.cc
tests/hp/hp_quad_dof_identities_dgq_system_02.cc
tests/hp/hp_quad_dof_identities_q.cc
tests/hp/hp_quad_dof_identities_q_gl.cc
tests/hp/hp_quad_dof_identities_q_system_01.cc
tests/hp/hp_quad_dof_identities_q_system_02.cc
tests/hp/hp_quad_dof_identities_rt_nodal.cc
tests/hp/hp_vertex_dof_identities_dgp.cc
tests/hp/hp_vertex_dof_identities_dgp_monomial.cc
tests/hp/hp_vertex_dof_identities_dgp_monomial_system_01.cc
tests/hp/hp_vertex_dof_identities_dgp_monomial_system_02.cc
tests/hp/hp_vertex_dof_identities_dgp_nonparametric.cc
tests/hp/hp_vertex_dof_identities_dgp_nonparametric_system_01.cc
tests/hp/hp_vertex_dof_identities_dgp_nonparametric_system_02.cc
tests/hp/hp_vertex_dof_identities_dgp_system_01.cc
tests/hp/hp_vertex_dof_identities_dgp_system_02.cc
tests/hp/hp_vertex_dof_identities_dgq.cc
tests/hp/hp_vertex_dof_identities_dgq_system_01.cc
tests/hp/hp_vertex_dof_identities_dgq_system_02.cc
tests/hp/hp_vertex_dof_identities_q.cc
tests/hp/hp_vertex_dof_identities_q_system_01.cc
tests/hp/hp_vertex_dof_identities_q_system_02.cc
tests/hp/hp_vertex_dof_identities_rt_nodal.cc
tests/hp/integrate_difference.cc
tests/hp/interpolate_nothing_01.cc
tests/hp/interpolate_nothing_02.cc
tests/hp/interpolate_q_system_01.cc
tests/hp/interpolate_q_system_02.cc
tests/hp/mapping_collection_01.cc
tests/hp/mapping_collection_02.cc
tests/hp/mapping_collection_03.cc
tests/hp/mapping_collection_04.cc
tests/hp/n_active_fe_indices.cc
tests/hp/n_boundary_dofs.cc
tests/hp/n_dofs.cc
tests/hp/project_01.cc
tests/hp/project_02.cc
tests/hp/q_collection_01.cc
tests/hp/q_vs_dgq.cc
tests/hp/random.cc
tests/hp/set_dof_values_by_interpolation_01.cc
tests/hp/set_dof_values_by_interpolation_03.cc
tests/hp/solution_transfer.cc
tests/hp/solution_transfer_02.cc
tests/hp/solution_transfer_03.cc
tests/hp/solution_transfer_04.cc
tests/hp/solution_transfer_05.cc
tests/hp/solution_transfer_10.cc
tests/hp/solution_transfer_11.cc
tests/hp/step-10.cc
tests/hp/step-11.cc
tests/hp/step-11_compressed_set_sparsity.cc
tests/hp/step-2.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/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/integrators/assembler_simple_mgmatrix_01.cc
tests/lac/bicgstab_large.cc
tests/lac/block_compressed_01.cc
tests/lac/block_compressed_simple_sparsity_pattern_indexset_01.cc
tests/lac/block_matrices.cc
tests/lac/block_matrices_02.cc
tests/lac/block_matrices_03.cc
tests/lac/block_matrices_04.cc
tests/lac/block_sparsity_pattern_01.cc
tests/lac/block_sparsity_pattern_02.cc
tests/lac/block_vector.cc
tests/lac/chunk_sparsity_pattern_01.cc
tests/lac/chunk_sparsity_pattern_02.cc
tests/lac/chunk_sparsity_pattern_03.cc
tests/lac/chunk_sparsity_pattern_04.cc
tests/lac/chunk_sparsity_pattern_05.cc
tests/lac/chunk_sparsity_pattern_06.cc
tests/lac/chunk_sparsity_pattern_07.cc
tests/lac/chunk_sparsity_pattern_08.cc
tests/lac/chunk_sparsity_pattern_09.cc
tests/lac/chunk_sparsity_pattern_10.cc
tests/lac/chunk_sparsity_pattern_11.cc
tests/lac/complex_block_vector.cc
tests/lac/compressed_set_sparsity_pattern_01.cc
tests/lac/compressed_set_sparsity_pattern_02.cc
tests/lac/compressed_set_sparsity_pattern_03.cc
tests/lac/compressed_set_sparsity_pattern_04.cc
tests/lac/compressed_set_sparsity_pattern_05.cc
tests/lac/compressed_set_sparsity_pattern_10.cc
tests/lac/compressed_set_sparsity_pattern_11.cc
tests/lac/compressed_simple_sparsity_pattern_01.cc
tests/lac/compressed_simple_sparsity_pattern_02.cc
tests/lac/compressed_simple_sparsity_pattern_03.cc
tests/lac/compressed_simple_sparsity_pattern_04.cc
tests/lac/compressed_simple_sparsity_pattern_05.cc
tests/lac/compressed_simple_sparsity_pattern_10.cc
tests/lac/compressed_simple_sparsity_pattern_11.cc
tests/lac/compressed_simple_sparsity_pattern_index_set_01.cc
tests/lac/compressed_simple_sparsity_pattern_index_set_02.cc
tests/lac/compressed_sparsity_pattern_01.cc
tests/lac/compressed_sparsity_pattern_02.cc
tests/lac/compressed_sparsity_pattern_03.cc
tests/lac/compressed_sparsity_pattern_04.cc
tests/lac/compressed_sparsity_pattern_05.cc
tests/lac/compressed_sparsity_pattern_10.cc
tests/lac/compressed_sparsity_pattern_11.cc
tests/lac/constraint_graph.cc
tests/lac/constraint_graph_zero.cc
tests/lac/constraints.cc
tests/lac/constraints_01.cc
tests/lac/constraints_02.cc
tests/lac/constraints_c1.cc
tests/lac/constraints_c1_02.cc
tests/lac/constraints_inhomogeneous.cc
tests/lac/constraints_merge.cc
tests/lac/constraints_merge_02.cc
tests/lac/constraints_merge_03.cc
tests/lac/constraints_merge_04.cc
tests/lac/constraints_merge_05.cc
tests/lac/constraints_merge_06.cc
tests/lac/constraints_merge_07.cc
tests/lac/constraints_merge_08.cc
tests/lac/constraints_merge_09.cc
tests/lac/constraints_zero.cc
tests/lac/constraints_zero_condense.cc
tests/lac/constraints_zero_merge.cc
tests/lac/copy_transposed.cc
tests/lac/eigen.cc
tests/lac/full_matrix.cc
tests/lac/full_matrix_04.cc
tests/lac/full_matrix_07.cc
tests/lac/full_matrix_08.cc
tests/lac/full_matrix_print.cc
tests/lac/gmres_eigenvalues.cc
tests/lac/gmres_reorthogonalize_01.cc
tests/lac/gmres_reorthogonalize_02.cc
tests/lac/gmres_reorthogonalize_03.cc
tests/lac/gmres_reorthogonalize_04.cc
tests/lac/gmres_reorthogonalize_05.cc
tests/lac/householder.cc
tests/lac/identity_matrix_01.cc
tests/lac/identity_matrix_02.cc
tests/lac/identity_matrix_03.cc
tests/lac/identity_matrix_04.cc
tests/lac/identity_matrix_05.cc
tests/lac/identity_matrix_06.cc
tests/lac/inhomogeneous_constraints_02.cc
tests/lac/inhomogeneous_constraints_03.cc
tests/lac/inhomogeneous_constraints_04.cc
tests/lac/inhomogeneous_constraints_block.cc
tests/lac/inhomogeneous_constraints_nonsymmetric.cc
tests/lac/is_block_vector.cc
tests/lac/la_vector_add_and_dot.cc
tests/lac/lapack_fill.cc
tests/lac/linear_operator_01b.cc
tests/lac/linear_operator_01c.cc
tests/lac/linear_operator_08.cc
tests/lac/matrices.cc
tests/lac/matrices_ez.cc
tests/lac/matrices_ez_add.cc
tests/lac/matrices_lapack.cc
tests/lac/matrices_lapack_fill.cc
tests/lac/matrix_lib.cc
tests/lac/matrix_out.cc
tests/lac/pointer_matrix.cc
tests/lac/pointer_matrix_01.cc
tests/lac/pointer_matrix_02.cc
tests/lac/pointer_matrix_03.cc
tests/lac/pointer_matrix_04.cc
tests/lac/pointer_matrix_05.cc
tests/lac/pointer_matrix_06.cc
tests/lac/pointer_matrix_07.cc
tests/lac/pointer_matrix_08.cc
tests/lac/pointer_matrix_09.cc
tests/lac/pointer_matrix_10.cc
tests/lac/pointer_matrix_vector.cc
tests/lac/precondition_chebyshev_01.cc
tests/lac/print_formatted_ez_01.cc
tests/lac/product_matrix_01.cc
tests/lac/product_matrix_02.cc
tests/lac/product_matrix_03.cc
tests/lac/product_matrix_04.cc
tests/lac/product_matrix_05.cc
tests/lac/product_matrix_06.cc
tests/lac/product_matrix_07.cc
tests/lac/product_matrix_08.cc
tests/lac/schur_complement_01.cc
tests/lac/schur_complement_02.cc
tests/lac/schur_complement_03.cc
tests/lac/schur_matrix_01.cc
tests/lac/schur_matrix_02.cc
tests/lac/schur_matrix_03.cc
tests/lac/schur_matrix_04.cc
tests/lac/shifted_matrix_01.cc
tests/lac/shifted_matrix_02.cc
tests/lac/shifted_matrix_03.cc
tests/lac/shifted_matrix_04.cc
tests/lac/shifted_matrix_05.cc
tests/lac/solver.cc
tests/lac/solver_02.cc
tests/lac/solver_monitor.cc
tests/lac/solver_monitor_disconnect.cc
tests/lac/solver_relaxation_01.cc
tests/lac/solver_relaxation_02.cc
tests/lac/solver_relaxation_03.cc
tests/lac/solver_selector_00.cc
tests/lac/solver_selector_01.cc
tests/lac/sparse_ilu_inverse.cc
tests/lac/sparse_matrix_iterator.cc
tests/lac/sparsity_pattern_01.cc
tests/lac/sparsity_pattern_02.cc
tests/lac/sparsity_pattern_03.cc
tests/lac/sparsity_pattern_04.cc
tests/lac/sparsity_pattern_05.cc
tests/lac/sparsity_pattern_06.cc
tests/lac/sparsity_pattern_07.cc
tests/lac/sparsity_pattern_08.cc
tests/lac/sparsity_pattern_09.cc
tests/lac/sparsity_pattern_10.cc
tests/lac/sparsity_pattern_11.cc
tests/lac/sparsity_pattern_12.cc
tests/lac/sparsity_pattern_copy_from.cc
tests/lac/trace.cc
tests/lac/tridiagonal_matrix.cc
tests/lac/tridiagonal_matrix_sym.cc
tests/lac/vector_accumulation_02.cc
tests/lac/vector_add_and_dot.cc
tests/lac/vector_memory.cc
tests/lac/vector_view.cc
tests/lac/vector_view_01.cc
tests/lac/vector_view_02.cc
tests/lac/vector_view_03.cc
tests/lac/vector_view_04.cc
tests/lac/vector_view_05.cc
tests/lapack/full_matrix_01.cc
tests/lapack/full_matrix_02.cc
tests/lapack/full_matrix_03.cc
tests/lapack/full_matrix_04.cc
tests/lapack/full_matrix_05.cc
tests/lapack/full_matrix_06.cc
tests/lapack/full_matrix_07.cc
tests/lapack/full_matrix_08.cc
tests/lapack/full_matrix_09.cc
tests/lapack/full_matrix_10.cc
tests/lapack/full_matrix_11.cc
tests/lapack/full_matrix_12.cc
tests/lapack/solver_cg.cc
tests/lapack/tridiagonal_ev1.cc
tests/matrix_free/assemble_matrix_01.cc
tests/matrix_free/assemble_matrix_02.cc
tests/matrix_free/compress_constraints.cc
tests/matrix_free/compress_mapping.cc
tests/matrix_free/copy.cc
tests/matrix_free/copy_feevaluation.cc
tests/matrix_free/estimate_condition_number_mass.cc
tests/matrix_free/evaluate_1d_shape.cc
tests/matrix_free/evaluate_1d_shape_evenodd.cc
tests/matrix_free/fe_evaluation_access_1d.cc
tests/matrix_free/get_functions_gl.cc
tests/matrix_free/get_functions_mappingq.cc
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_functions_rect.cc
tests/matrix_free/get_functions_variants.cc
tests/matrix_free/get_values_plain.cc
tests/matrix_free/inverse_mass_01.cc
tests/matrix_free/inverse_mass_02.cc
tests/matrix_free/inverse_mass_03.cc
tests/matrix_free/matrix_vector_15.cc
tests/matrix_free/matrix_vector_16.cc
tests/matrix_free/matrix_vector_18.cc
tests/matrix_free/matrix_vector_curl.cc
tests/matrix_free/matrix_vector_div.cc
tests/matrix_free/matrix_vector_hp.cc
tests/matrix_free/matrix_vector_mg.cc
tests/matrix_free/matrix_vector_stokes.cc
tests/matrix_free/matrix_vector_stokes_noflux.cc
tests/matrix_free/matrix_vector_stokes_qdg0.cc
tests/matrix_free/no_index_initialize.cc
tests/matrix_free/parallel_multigrid.cc
tests/matrix_free/parallel_multigrid_adaptive.cc
tests/matrix_free/parallel_multigrid_adaptive_mf.cc
tests/matrix_free/parallel_multigrid_mf.cc
tests/matrix_free/quadrature_points.cc
tests/matrix_free/step-48b.cc
tests/matrix_free/thread_correctness.cc
tests/matrix_free/thread_correctness_hp.cc
tests/matrix_free/update_mapping_only.cc
tests/metis/metis_01.cc
tests/metis/metis_01a.cc
tests/metis/metis_02.cc
tests/metis/metis_03.cc
tests/mpi/codim_01.cc
tests/mpi/communicate_moved_vertices_01.cc
tests/mpi/compute_mean_value.cc
tests/mpi/condense_01.cc
tests/mpi/constraint_matrix_crash_01.cc
tests/mpi/constraint_matrix_set_zero_01.cc
tests/mpi/constraint_matrix_set_zero_02.cc
tests/mpi/constraint_matrix_trilinos_bug.cc
tests/mpi/count_dofs_per_block_01.cc
tests/mpi/crash_01.cc
tests/mpi/crash_02.cc
tests/mpi/crash_04.cc
tests/mpi/crash_05.cc
tests/mpi/crash_06.cc
tests/mpi/cuthill_mckee_01.cc
tests/mpi/derivative_approximation_01.cc
tests/mpi/derivative_approximation_02.cc
tests/mpi/extract_constant_modes_01.cc
tests/mpi/extract_constant_modes_02.cc
tests/mpi/extract_locally_active_dofs.cc
tests/mpi/find_active_cell_around_point_01.cc
tests/mpi/ghost_02.cc
tests/mpi/has_active_dofs_01.cc
tests/mpi/has_active_dofs_02.cc
tests/mpi/integrate_difference.cc
tests/mpi/interpolate_02.cc
tests/mpi/interpolate_03.cc
tests/mpi/is_locally_owned.cc
tests/mpi/mg_01.cc
tests/mpi/mg_02.cc
tests/mpi/mg_03.cc
tests/mpi/mg_04.cc
tests/mpi/mg_05.cc
tests/mpi/mg_06.cc
tests/mpi/p4est_2d_coarse_01.cc
tests/mpi/p4est_2d_constraintmatrix_01.cc
tests/mpi/p4est_2d_constraintmatrix_02.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_2d_dofhandler_01.cc
tests/mpi/p4est_2d_dofhandler_02.cc
tests/mpi/p4est_2d_dofhandler_03.cc
tests/mpi/p4est_2d_dofhandler_04.cc
tests/mpi/p4est_2d_dofhandler_05.cc
tests/mpi/p4est_2d_refine_01.cc
tests/mpi/p4est_2d_refine_02.cc
tests/mpi/p4est_2d_refine_03.cc
tests/mpi/p4est_2d_renumber_01.cc
tests/mpi/p4est_2d_renumber_02.cc
tests/mpi/p4est_2d_simple.cc
tests/mpi/p4est_3d_constraintmatrix_01.cc
tests/mpi/p4est_3d_constraintmatrix_02.cc
tests/mpi/p4est_3d_constraintmatrix_03.cc
tests/mpi/p4est_3d_refine_01.cc
tests/mpi/p4est_3d_refine_02.cc
tests/mpi/p4est_3d_refine_03.cc
tests/mpi/p4est_3d_refine_04.cc
tests/mpi/p4est_data_out_01.cc
tests/mpi/p4est_get_subdomain_association.cc
tests/mpi/p4est_max_refine.cc
tests/mpi/p4est_save_01.cc
tests/mpi/p4est_save_02.cc
tests/mpi/p4est_save_04.cc
tests/mpi/parallel_vtu_01.cc
tests/mpi/periodicity_03.cc
tests/mpi/petsc_02.cc
tests/mpi/point_value_01.cc
tests/mpi/refine_and_coarsen_fixed_fraction_02.cc
tests/mpi/refine_and_coarsen_fixed_fraction_04.cc
tests/mpi/refine_and_coarsen_fixed_fraction_05.cc
tests/mpi/refine_and_coarsen_fixed_fraction_06.cc
tests/mpi/refine_and_coarsen_fixed_number_01.cc
tests/mpi/refine_and_coarsen_fixed_number_02.cc
tests/mpi/refine_and_coarsen_fixed_number_03.cc
tests/mpi/refine_and_coarsen_fixed_number_04.cc
tests/mpi/refine_and_coarsen_fixed_number_05.cc
tests/mpi/refine_and_coarsen_fixed_number_06.cc
tests/mpi/refinement_listener_01.cc
tests/mpi/refinement_listener_02.cc
tests/mpi/renumber_cuthill_mckee.cc
tests/mpi/renumber_z_order_01.cc
tests/mpi/solution_transfer_01.cc
tests/mpi/tria_01.cc
tests/mpi/tria_copy_triangulation.cc
tests/mpi/trilinos_distribute_03.cc
tests/mpi/trilinos_distribute_04.cc
tests/multigrid/smoother_block.cc
tests/multigrid/transfer_prebuilt_04.cc
tests/numerics/boundaries.cc
tests/numerics/create_laplace_matrix_constraints_01.cc
tests/numerics/create_laplace_matrix_constraints_02.cc
tests/numerics/create_laplace_matrix_constraints_02b.cc
tests/numerics/create_laplace_matrix_constraints_03.cc
tests/numerics/create_laplace_matrix_constraints_04.cc
tests/numerics/create_mass_matrix_constraints_01.cc
tests/numerics/create_mass_matrix_constraints_02.cc
tests/numerics/create_mass_matrix_constraints_02b.cc
tests/numerics/create_mass_matrix_constraints_03.cc
tests/numerics/create_mass_matrix_constraints_04.cc
tests/numerics/create_point_source.cc
tests/numerics/create_point_source_hp.cc
tests/numerics/data_out.cc
tests/numerics/derivative_approximation.cc
tests/numerics/derivative_approximation_2.cc
tests/numerics/error_estimator.cc
tests/numerics/error_estimator_01.cc
tests/numerics/fe_field.cc
tests/numerics/no_flux_03.cc
tests/numerics/no_flux_04.cc
tests/numerics/no_flux_05.cc
tests/numerics/no_flux_06.cc
tests/numerics/no_flux_07.cc
tests/numerics/no_flux_08.cc
tests/numerics/no_flux_09.cc
tests/numerics/no_flux_hp_03.cc
tests/numerics/no_flux_hp_04.cc
tests/numerics/no_flux_hp_05.cc
tests/numerics/normal_flux_03.cc
tests/numerics/point_value_history_02.cc
tests/numerics/point_value_history_03.cc
tests/numerics/project_01.cc
tests/numerics/project_02.cc
tests/numerics/project_boundary_01.cc
tests/numerics/project_bv_curl_conf.cc
tests/numerics/project_bv_curl_conf_02.cc
tests/numerics/project_bv_div_conf.cc
tests/numerics/project_common.h
tests/numerics/project_dgp_01.cc
tests/numerics/project_dgp_02.cc
tests/numerics/project_dgp_03.cc
tests/numerics/project_dgp_04.cc
tests/numerics/project_dgp_05.cc
tests/numerics/project_dgp_monomial_01.cc
tests/numerics/project_dgp_monomial_02.cc
tests/numerics/project_dgp_monomial_03.cc
tests/numerics/project_dgp_monomial_04.cc
tests/numerics/project_dgp_monomial_05.cc
tests/numerics/project_dgq_01.cc
tests/numerics/project_dgq_02.cc
tests/numerics/project_dgq_03.cc
tests/numerics/project_dgq_04.cc
tests/numerics/project_dgq_05.cc
tests/numerics/project_nedelec_01.cc
tests/numerics/project_nedelec_02.cc
tests/numerics/project_nedelec_03.cc
tests/numerics/project_nedelec_04.cc
tests/numerics/project_nedelec_05.cc
tests/numerics/project_q_01.cc
tests/numerics/project_q_02.cc
tests/numerics/project_q_03.cc
tests/numerics/project_q_04.cc
tests/numerics/project_q_05.cc
tests/numerics/project_q_hierarchical_01.cc
tests/numerics/project_q_hierarchical_02.cc
tests/numerics/project_q_hierarchical_03.cc
tests/numerics/project_q_hierarchical_04.cc
tests/numerics/project_q_hierarchical_05.cc
tests/numerics/project_q_system_01.cc
tests/numerics/project_q_system_02.cc
tests/numerics/project_q_system_03.cc
tests/numerics/project_q_system_04.cc
tests/numerics/project_q_system_05.cc
tests/numerics/project_rt_01.cc
tests/numerics/project_rt_02.cc
tests/numerics/project_rt_04.cc
tests/numerics/project_rt_05.cc
tests/numerics/project_to_surface_01.cc
tests/numerics/vectors_boundary_rhs_01.cc
tests/numerics/vectors_boundary_rhs_02.cc
tests/numerics/vectors_boundary_rhs_03.cc
tests/numerics/vectors_point_source_01.cc
tests/numerics/vectors_rhs_01.cc
tests/numerics/vectors_rhs_03.cc
tests/petsc/65.cc
tests/petsc/66.cc
tests/petsc/67.cc
tests/petsc/70.cc
tests/petsc/different_matrix_preconditioner.cc
tests/petsc/full_matrix_07.cc
tests/petsc/parallel_sparse_matrix_01.cc
tests/petsc/slowness_01.cc
tests/petsc/slowness_02.cc
tests/petsc/slowness_03.cc
tests/petsc/slowness_04.cc
tests/petsc/solver_03_precondition_ilu.cc
tests/petsc/vector_equality_3.cc
tests/petsc/vector_print.cc
tests/petsc/vector_wrap_01.cc
tests/quick_tests/mpi.cc
tests/quick_tests/p4est.cc
tests/quick_tests/step-petsc.cc
tests/quick_tests/step-slepc.cc
tests/quick_tests/step.cc
tests/quick_tests/tbb.cc
tests/serialization/parameter_handler.cc
tests/serialization/point.cc
tests/serialization/polynomial.cc
tests/serialization/polynomial_hierarchical.cc
tests/serialization/polynomial_lagrange_equidistant.cc
tests/serialization/polynomial_lagrange_gl.cc
tests/serialization/polynomial_legendre.cc
tests/serialization/polynomial_lobatto.cc
tests/serialization/polynomial_monomial.cc
tests/serialization/quadrature.cc
tests/serialization/quadrature_qanisotropic.cc
tests/serialization/quadrature_qiterated.cc
tests/serialization/sparsity_pattern.cc
tests/serialization/symmetric_tensor.cc
tests/serialization/table_1.cc
tests/serialization/table_2.cc
tests/serialization/table_3.cc
tests/serialization/table_4.cc
tests/serialization/table_5.cc
tests/serialization/table_6.cc
tests/serialization/table_7.cc
tests/serialization/table_handler.cc
tests/serialization/tensor.cc
tests/serialization/tensor_base.cc
tests/serialization/tensor_base_scalar.cc
tests/serialization/test_01.cc
tests/serialization/vector.cc
tests/sharedtria/dof_01.cc
tests/sharedtria/dof_02.cc
tests/sharedtria/dof_03.cc
tests/sharedtria/dof_04.cc
tests/sharedtria/tria_01.cc
tests/sharedtria/tria_02.cc
tests/slepc/00.cc
tests/slepc/solve_01.cc
tests/slepc/solve_04.cc
tests/umfpack/umfpack_01.cc
tests/umfpack/umfpack_02.cc
tests/umfpack/umfpack_04.cc
tests/vector_tools/integrate_difference_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.