]> https://gitweb.dealii.org/ - dealii.git/commit
update copyright years 10097/head
authorTimo Heister <timo.heister@gmail.com>
Fri, 8 May 2020 18:05:28 +0000 (14:05 -0400)
committerTimo Heister <timo.heister@gmail.com>
Fri, 8 May 2020 18:05:28 +0000 (14:05 -0400)
commit159f21c4d12201ffa9ac190202b0ba0997a003b5
treecd0d2429659c577e2204692dc3d83b2c7787cdb8
parent6502e13d9292690b409e450f2296606c1666644b
update copyright years
3390 files changed:
CMakeLists.txt
bundled/boost-1.70.0/libs/iostreams/src/CMakeLists.txt
bundled/boost-1.70.0/libs/serialization/src/CMakeLists.txt
bundled/boost-1.70.0/libs/system/src/CMakeLists.txt
bundled/boost-1.70.0/libs/thread/src/CMakeLists.txt
bundled/tbb-2018_U2/src/CMakeLists.txt
bundled/umfpack/UMFPACK/Source/CMakeLists.txt
cmake/checks/check_01_cpu_features.cmake
cmake/checks/check_01_cxx_features.cmake
cmake/checks/check_02_compiler_features.cmake
cmake/config/CMakeLists.txt
cmake/configure/configure_1_threads.cmake
cmake/configure/configure_2_trilinos.cmake
cmake/configure/configure_adolc.cmake
cmake/configure/configure_symengine.cmake
cmake/configure/configure_vectorization.cmake
cmake/macros/macro_deal_ii_add_test.cmake
cmake/macros/macro_deal_ii_pickup_tests.cmake
cmake/macros/macro_deal_ii_setup_target.cmake
cmake/modules/FindGINKGO.cmake
cmake/modules/FindTBB.cmake
cmake/setup_compiler_flags_gnu.cmake
cmake/setup_compiler_flags_intel.cmake
cmake/setup_write_config.cmake
contrib/python-bindings/CMakeLists.txt
contrib/python-bindings/include/cell_accessor_wrapper.h
contrib/python-bindings/include/manifold_wrapper.h
contrib/python-bindings/include/mapping_wrapper.h
contrib/python-bindings/include/point_wrapper.h
contrib/python-bindings/include/quadrature_wrapper.h
contrib/python-bindings/include/tria_accessor_wrapper.h
contrib/python-bindings/include/triangulation_wrapper.h
contrib/python-bindings/source/CMakeLists.txt
contrib/python-bindings/source/cell_accessor_wrapper.cc
contrib/python-bindings/source/export_cell_accessor.cc
contrib/python-bindings/source/export_manifold.cc
contrib/python-bindings/source/export_mapping.cc
contrib/python-bindings/source/export_point.cc
contrib/python-bindings/source/export_quadrature.cc
contrib/python-bindings/source/export_tria_accessor.cc
contrib/python-bindings/source/export_triangulation.cc
contrib/python-bindings/source/manifold_wrapper.cc
contrib/python-bindings/source/mapping_wrapper.cc
contrib/python-bindings/source/point_wrapper.cc
contrib/python-bindings/source/quadrature_wrapper.cc
contrib/python-bindings/source/tria_accessor_wrapper.cc
contrib/python-bindings/source/triangulation_wrapper.cc
contrib/python-bindings/source/wrappers.cc
contrib/python-bindings/tests/cell_accessor_wrapper.py
contrib/python-bindings/tests/manifold_wrapper.py
contrib/python-bindings/tests/mapping_wrapper.py
contrib/python-bindings/tests/quadrature_wrapper.py
contrib/python-bindings/tests/triangulation_wrapper.py
contrib/utilities/check_indentation.sh
contrib/utilities/count_lines.sh
contrib/utilities/indent
contrib/utilities/indent_common.sh
contrib/utilities/run_clang_tidy.sh
contrib/utilities/update-copyright
contrib/utilities/wrapcomments.py
doc/developers/cmake-internals.html
doc/developers/porting.html
doc/developers/testsuite.html
doc/doxygen/CMakeLists.txt
doc/doxygen/code-gallery/CMakeLists.txt
doc/doxygen/headers/automatic_and_symbolic_differentiation.h
doc/doxygen/headers/c++.h
doc/doxygen/headers/coding_conventions.h
doc/doxygen/headers/concepts.h
doc/doxygen/headers/constraints.h
doc/doxygen/headers/distributed.h
doc/doxygen/headers/dofs.h
doc/doxygen/headers/fe.h
doc/doxygen/headers/fe_vs_mapping_vs_fevalues.h
doc/doxygen/headers/functions.h
doc/doxygen/headers/geodynamics.h
doc/doxygen/headers/glossary.h
doc/doxygen/headers/grid.h
doc/doxygen/headers/hp.h
doc/doxygen/headers/instantiations.h
doc/doxygen/headers/io.h
doc/doxygen/headers/iterators.h
doc/doxygen/headers/laoperators.h
doc/doxygen/headers/main.h
doc/doxygen/headers/manifold.h
doc/doxygen/headers/matrixfree.h
doc/doxygen/headers/mg.h
doc/doxygen/headers/multithreading.h
doc/doxygen/headers/petsc.h
doc/doxygen/headers/physics.h
doc/doxygen/headers/quadrature.h
doc/doxygen/headers/slepc.h
doc/doxygen/headers/trilinos.h
doc/doxygen/headers/update_flags.h
doc/doxygen/headers/vector_valued.h
doc/doxygen/scripts/filter
doc/doxygen/scripts/make_step.pl
doc/doxygen/scripts/program2doxygen
doc/doxygen/scripts/steps.pl
doc/doxygen/tutorial/CMakeLists.txt
doc/doxygen/tutorial/tutorial.h.in
doc/external-libs/opencascade.html
doc/external-libs/trilinos.html
doc/index.html
doc/news/CMakeLists.txt
doc/readme.html
doc/users/cmake_dealii.html
doc/users/cmake_user.html
doc/users/doxygen.html
doc/users/testsuite.html
examples/CMakeLists.txt
examples/step-10/step-10.cc
examples/step-11/step-11.cc
examples/step-12/step-12.cc
examples/step-12b/step-12b.cc
examples/step-13/step-13.cc
examples/step-14/step-14.cc
examples/step-15/step-15.cc
examples/step-16/step-16.cc
examples/step-16b/step-16b.cc
examples/step-18/step-18.cc
examples/step-2/step-2.cc
examples/step-20/step-20.cc
examples/step-21/step-21.cc
examples/step-22/step-22.cc
examples/step-23/step-23.cc
examples/step-24/step-24.cc
examples/step-25/step-25.cc
examples/step-26/step-26.cc
examples/step-27/step-27.cc
examples/step-28/step-28.cc
examples/step-29/step-29.cc
examples/step-3/step-3.cc
examples/step-30/step-30.cc
examples/step-31/step-31.cc
examples/step-32/step-32.cc
examples/step-33/step-33.cc
examples/step-34/step-34.cc
examples/step-35/step-35.cc
examples/step-37/step-37.cc
examples/step-38/step-38.cc
examples/step-39/step-39.cc
examples/step-4/step-4.cc
examples/step-40/step-40.cc
examples/step-42/step-42.cc
examples/step-43/step-43.cc
examples/step-45/step-45.cc
examples/step-46/step-46.cc
examples/step-47/step-47.cc
examples/step-48/step-48.cc
examples/step-49/step-49.cc
examples/step-5/step-5.cc
examples/step-50/step-50.cc
examples/step-51/step-51.cc
examples/step-52/step-52.cc
examples/step-54/step-54.cc
examples/step-55/step-55.cc
examples/step-56/step-56.cc
examples/step-57/step-57.cc
examples/step-58/step-58.cc
examples/step-59/step-59.cc
examples/step-6/step-6.cc
examples/step-60/step-60.cc
examples/step-61/step-61.cc
examples/step-62/step-62.cc
examples/step-63/step-63.cc
examples/step-65/step-65.cc
examples/step-7/step-7.cc
examples/step-8/step-8.cc
examples/step-9/step-9.cc
include/deal.II/algorithms/newton.h
include/deal.II/algorithms/newton.templates.h
include/deal.II/algorithms/operator.templates.h
include/deal.II/algorithms/theta_timestepping.h
include/deal.II/algorithms/theta_timestepping.templates.h
include/deal.II/algorithms/timestep_control.h
include/deal.II/base/aligned_vector.h
include/deal.II/base/array_view.h
include/deal.II/base/auto_derivative_function.h
include/deal.II/base/bounding_box.h
include/deal.II/base/complex_overloads.h
include/deal.II/base/data_out_base.h
include/deal.II/base/derivative_form.h
include/deal.II/base/discrete_time.h
include/deal.II/base/exceptions.h
include/deal.II/base/function.h
include/deal.II/base/function.templates.h
include/deal.II/base/function_parser.h
include/deal.II/base/function_time.h
include/deal.II/base/function_time.templates.h
include/deal.II/base/geometry_info.h
include/deal.II/base/graph_coloring.h
include/deal.II/base/hdf5.h
include/deal.II/base/incremental_function.h
include/deal.II/base/index_set.h
include/deal.II/base/job_identifier.h
include/deal.II/base/memory_consumption.h
include/deal.II/base/memory_space.h
include/deal.II/base/mg_level_object.h
include/deal.II/base/mpi.h
include/deal.II/base/mpi.templates.h
include/deal.II/base/mpi_compute_index_owner_internal.h
include/deal.II/base/mpi_consensus_algorithms.templates.h
include/deal.II/base/mpi_tags.h
include/deal.II/base/mutable_bind.h
include/deal.II/base/numbers.h
include/deal.II/base/parallel.h
include/deal.II/base/parameter_acceptor.h
include/deal.II/base/parameter_handler.h
include/deal.II/base/parsed_convergence_table.h
include/deal.II/base/parsed_function.h
include/deal.II/base/partitioner.h
include/deal.II/base/partitioner.templates.h
include/deal.II/base/patterns.h
include/deal.II/base/point.h
include/deal.II/base/polynomial.h
include/deal.II/base/polynomial_space.h
include/deal.II/base/polynomials_abf.h
include/deal.II/base/polynomials_adini.h
include/deal.II/base/polynomials_bdm.h
include/deal.II/base/polynomials_bernardi_raugel.h
include/deal.II/base/polynomials_bernstein.h
include/deal.II/base/polynomials_integrated_legendre_sz.h
include/deal.II/base/polynomials_nedelec.h
include/deal.II/base/polynomials_piecewise.h
include/deal.II/base/polynomials_rannacher_turek.h
include/deal.II/base/polynomials_raviart_thomas.h
include/deal.II/base/polynomials_rt_bubbles.h
include/deal.II/base/process_grid.h
include/deal.II/base/qprojector.h
include/deal.II/base/quadrature_lib.h
include/deal.II/base/quadrature_selector.h
include/deal.II/base/scalar_polynomials_base.h
include/deal.II/base/symbolic_function.h
include/deal.II/base/symbolic_function.templates.h
include/deal.II/base/symmetric_tensor.h
include/deal.II/base/symmetric_tensor.templates.h
include/deal.II/base/table.h
include/deal.II/base/table_handler.h
include/deal.II/base/table_indices.h
include/deal.II/base/template_constraints.h
include/deal.II/base/tensor.h
include/deal.II/base/tensor_accessors.h
include/deal.II/base/tensor_function_parser.h
include/deal.II/base/tensor_product_polynomials.h
include/deal.II/base/tensor_product_polynomials_bubbles.h
include/deal.II/base/tensor_product_polynomials_const.h
include/deal.II/base/thread_local_storage.h
include/deal.II/base/thread_management.h
include/deal.II/base/time_stepping.templates.h
include/deal.II/base/timer.h
include/deal.II/base/types.h
include/deal.II/base/undefine_macros.h
include/deal.II/base/utilities.h
include/deal.II/base/vector_slice.h
include/deal.II/base/vectorization.h
include/deal.II/base/work_stream.h
include/deal.II/boost_adaptors/bounding_box.h
include/deal.II/boost_adaptors/point.h
include/deal.II/boost_adaptors/segment.h
include/deal.II/differentiation/sd.h
include/deal.II/distributed/cell_data_transfer.h
include/deal.II/distributed/cell_data_transfer.templates.h
include/deal.II/distributed/cell_weights.h
include/deal.II/distributed/fully_distributed_tria.h
include/deal.II/distributed/grid_refinement.h
include/deal.II/distributed/p4est_wrappers.h
include/deal.II/distributed/shared_tria.h
include/deal.II/distributed/tria.h
include/deal.II/distributed/tria_base.h
include/deal.II/dofs/block_info.h
include/deal.II/dofs/deprecated_function_map.h
include/deal.II/dofs/dof_accessor.templates.h
include/deal.II/dofs/dof_handler.h
include/deal.II/dofs/dof_handler_policy.h
include/deal.II/dofs/dof_iterator_selector.h
include/deal.II/dofs/dof_tools.h
include/deal.II/dofs/number_cache.h
include/deal.II/fe/block_mask.h
include/deal.II/fe/component_mask.h
include/deal.II/fe/fe.h
include/deal.II/fe/fe_abf.h
include/deal.II/fe/fe_bdm.h
include/deal.II/fe/fe_dg_vector.h
include/deal.II/fe/fe_dg_vector.templates.h
include/deal.II/fe/fe_dgp_nonparametric.h
include/deal.II/fe/fe_dgq.h
include/deal.II/fe/fe_enriched.h
include/deal.II/fe/fe_interface_values.h
include/deal.II/fe/fe_nedelec.h
include/deal.II/fe/fe_nedelec_sz.h
include/deal.II/fe/fe_nothing.h
include/deal.II/fe/fe_p1nc.h
include/deal.II/fe/fe_poly.h
include/deal.II/fe/fe_poly.templates.h
include/deal.II/fe/fe_poly_face.templates.h
include/deal.II/fe/fe_poly_tensor.h
include/deal.II/fe/fe_q_base.h
include/deal.II/fe/fe_q_hierarchical.h
include/deal.II/fe/fe_raviart_thomas.h
include/deal.II/fe/fe_rt_bubbles.h
include/deal.II/fe/fe_series.h
include/deal.II/fe/fe_system.h
include/deal.II/fe/fe_tools.h
include/deal.II/fe/fe_tools.templates.h
include/deal.II/fe/fe_tools_extrapolate.templates.h
include/deal.II/fe/fe_tools_interpolate.templates.h
include/deal.II/fe/fe_update_flags.h
include/deal.II/fe/fe_values.h
include/deal.II/fe/mapping_cartesian.h
include/deal.II/fe/mapping_fe_field.h
include/deal.II/fe/mapping_manifold.h
include/deal.II/fe/mapping_q.h
include/deal.II/fe/mapping_q_cache.h
include/deal.II/fe/mapping_q_generic.h
include/deal.II/gmsh/utilities.h
include/deal.II/grid/cell_id.h
include/deal.II/grid/composition_manifold.h
include/deal.II/grid/filtered_iterator.h
include/deal.II/grid/grid_generator.h
include/deal.II/grid/grid_in.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/manifold.h
include/deal.II/grid/manifold_lib.h
include/deal.II/grid/persistent_tria.h
include/deal.II/grid/tria.h
include/deal.II/grid/tria_accessor.h
include/deal.II/grid/tria_accessor.templates.h
include/deal.II/grid/tria_description.h
include/deal.II/grid/tria_iterator.h
include/deal.II/grid/tria_iterator_selector.h
include/deal.II/grid/tria_levels.h
include/deal.II/grid/tria_object.h
include/deal.II/grid/tria_objects.h
include/deal.II/hp/dof_faces.h
include/deal.II/hp/dof_handler.h
include/deal.II/hp/dof_level.h
include/deal.II/hp/fe_collection.h
include/deal.II/hp/mapping_collection.h
include/deal.II/hp/q_collection.h
include/deal.II/hp/refinement.h
include/deal.II/integrators/grad_div.h
include/deal.II/integrators/l2.h
include/deal.II/integrators/maxwell.h
include/deal.II/lac/affine_constraints.templates.h
include/deal.II/lac/block_indices.h
include/deal.II/lac/block_linear_operator.h
include/deal.II/lac/block_matrix_base.h
include/deal.II/lac/block_sparse_matrix_ez.h
include/deal.II/lac/block_sparsity_pattern.h
include/deal.II/lac/block_vector.h
include/deal.II/lac/block_vector_base.h
include/deal.II/lac/chunk_sparse_matrix.h
include/deal.II/lac/chunk_sparsity_pattern.h
include/deal.II/lac/communication_pattern_base.h
include/deal.II/lac/constrained_linear_operator.h
include/deal.II/lac/cuda_precondition.h
include/deal.II/lac/cuda_vector.h
include/deal.II/lac/diagonal_matrix.h
include/deal.II/lac/dynamic_sparsity_pattern.h
include/deal.II/lac/eigen.h
include/deal.II/lac/exceptions.h
include/deal.II/lac/full_matrix.h
include/deal.II/lac/generic_linear_algebra.h
include/deal.II/lac/householder.h
include/deal.II/lac/la_parallel_block_vector.h
include/deal.II/lac/la_parallel_block_vector.templates.h
include/deal.II/lac/la_parallel_vector.h
include/deal.II/lac/la_parallel_vector.templates.h
include/deal.II/lac/la_vector.h
include/deal.II/lac/la_vector.templates.h
include/deal.II/lac/lapack_full_matrix.h
include/deal.II/lac/linear_operator.h
include/deal.II/lac/linear_operator_tools.h
include/deal.II/lac/matrix_block.h
include/deal.II/lac/matrix_iterator.h
include/deal.II/lac/parallel_block_vector.h
include/deal.II/lac/parpack_solver.h
include/deal.II/lac/petsc_block_sparse_matrix.h
include/deal.II/lac/petsc_matrix_base.h
include/deal.II/lac/petsc_precondition.h
include/deal.II/lac/petsc_solver.h
include/deal.II/lac/petsc_vector.h
include/deal.II/lac/petsc_vector_base.h
include/deal.II/lac/precondition.h
include/deal.II/lac/precondition_block.h
include/deal.II/lac/precondition_block_base.h
include/deal.II/lac/precondition_selector.h
include/deal.II/lac/qr.h
include/deal.II/lac/read_write_vector.templates.h
include/deal.II/lac/relaxation_block.h
include/deal.II/lac/relaxation_block.templates.h
include/deal.II/lac/slepc_solver.h
include/deal.II/lac/slepc_spectral_transformation.h
include/deal.II/lac/solver_control.h
include/deal.II/lac/solver_fire.h
include/deal.II/lac/solver_gmres.h
include/deal.II/lac/solver_idr.h
include/deal.II/lac/solver_relaxation.h
include/deal.II/lac/solver_selector.h
include/deal.II/lac/sparse_decomposition.templates.h
include/deal.II/lac/sparse_direct.h
include/deal.II/lac/sparse_matrix.h
include/deal.II/lac/sparse_matrix.templates.h
include/deal.II/lac/sparse_matrix_ez.h
include/deal.II/lac/sparse_matrix_ez.templates.h
include/deal.II/lac/sparse_mic.h
include/deal.II/lac/sparse_mic.templates.h
include/deal.II/lac/sparse_vanka.h
include/deal.II/lac/sparse_vanka.templates.h
include/deal.II/lac/sparsity_pattern.h
include/deal.II/lac/sparsity_tools.h
include/deal.II/lac/tensor_product_matrix.h
include/deal.II/lac/tridiagonal_matrix.h
include/deal.II/lac/trilinos_block_sparse_matrix.h
include/deal.II/lac/trilinos_epetra_vector.h
include/deal.II/lac/trilinos_parallel_block_vector.h
include/deal.II/lac/trilinos_precondition.h
include/deal.II/lac/trilinos_solver.h
include/deal.II/lac/trilinos_sparse_matrix.h
include/deal.II/lac/trilinos_sparsity_pattern.h
include/deal.II/lac/trilinos_tpetra_vector.h
include/deal.II/lac/trilinos_vector.h
include/deal.II/lac/utilities.h
include/deal.II/lac/vector.h
include/deal.II/lac/vector.templates.h
include/deal.II/lac/vector_memory.h
include/deal.II/lac/vector_memory.templates.h
include/deal.II/lac/vector_operations_internal.h
include/deal.II/lac/vector_space_vector.h
include/deal.II/matrix_free/cuda_fe_evaluation.h
include/deal.II/matrix_free/cuda_hanging_nodes_internal.h
include/deal.II/matrix_free/cuda_matrix_free.h
include/deal.II/matrix_free/cuda_matrix_free.templates.h
include/deal.II/matrix_free/dof_info.h
include/deal.II/matrix_free/dof_info.templates.h
include/deal.II/matrix_free/evaluation_kernels.h
include/deal.II/matrix_free/evaluation_selector.h
include/deal.II/matrix_free/face_info.h
include/deal.II/matrix_free/face_setup_internal.h
include/deal.II/matrix_free/fe_evaluation.h
include/deal.II/matrix_free/helper_functions.h
include/deal.II/matrix_free/mapping_data_on_the_fly.h
include/deal.II/matrix_free/mapping_info.h
include/deal.II/matrix_free/mapping_info.templates.h
include/deal.II/matrix_free/matrix_free.h
include/deal.II/matrix_free/matrix_free.templates.h
include/deal.II/matrix_free/operators.h
include/deal.II/matrix_free/shape_info.h
include/deal.II/matrix_free/shape_info.templates.h
include/deal.II/matrix_free/task_info.h
include/deal.II/matrix_free/tensor_product_kernels.h
include/deal.II/matrix_free/type_traits.h
include/deal.II/matrix_free/vector_access_internal.h
include/deal.II/meshworker/assembler.h
include/deal.II/meshworker/copy_data.h
include/deal.II/meshworker/dof_info.h
include/deal.II/meshworker/dof_info.templates.h
include/deal.II/meshworker/functional.h
include/deal.II/meshworker/integration_info.h
include/deal.II/meshworker/integration_info.templates.h
include/deal.II/meshworker/local_integrator.h
include/deal.II/meshworker/local_results.h
include/deal.II/meshworker/loop.h
include/deal.II/meshworker/mesh_loop.h
include/deal.II/meshworker/output.h
include/deal.II/meshworker/vector_selector.h
include/deal.II/multigrid/mg_block_smoother.h
include/deal.II/multigrid/mg_coarse.h
include/deal.II/multigrid/mg_constrained_dofs.h
include/deal.II/multigrid/mg_tools.h
include/deal.II/multigrid/mg_transfer.h
include/deal.II/multigrid/mg_transfer.templates.h
include/deal.II/multigrid/mg_transfer_block.h
include/deal.II/multigrid/mg_transfer_block.templates.h
include/deal.II/multigrid/mg_transfer_component.h
include/deal.II/multigrid/mg_transfer_component.templates.h
include/deal.II/multigrid/mg_transfer_internal.h
include/deal.II/multigrid/mg_transfer_matrix_free.h
include/deal.II/multigrid/multigrid.h
include/deal.II/multigrid/multigrid.templates.h
include/deal.II/multigrid/sparse_matrix_collection.h
include/deal.II/non_matching/coupling.h
include/deal.II/numerics/cell_data_transfer.templates.h
include/deal.II/numerics/data_out.h
include/deal.II/numerics/data_out_dof_data.h
include/deal.II/numerics/data_out_dof_data.templates.h
include/deal.II/numerics/data_out_faces.h
include/deal.II/numerics/data_out_stack.h
include/deal.II/numerics/data_postprocessor.h
include/deal.II/numerics/derivative_approximation.h
include/deal.II/numerics/dof_output_operator.templates.h
include/deal.II/numerics/error_estimator.h
include/deal.II/numerics/error_estimator.templates.h
include/deal.II/numerics/fe_field_function.h
include/deal.II/numerics/fe_field_function.templates.h
include/deal.II/numerics/history.h
include/deal.II/numerics/matrix_creator.templates.h
include/deal.II/numerics/matrix_tools.h
include/deal.II/numerics/point_value_history.h
include/deal.II/numerics/rtree.h
include/deal.II/numerics/solution_transfer.h
include/deal.II/numerics/vector_tools.h
include/deal.II/numerics/vector_tools.templates.h
include/deal.II/numerics/vector_tools_boundary.h
include/deal.II/numerics/vector_tools_boundary.templates.h
include/deal.II/numerics/vector_tools_common.h
include/deal.II/numerics/vector_tools_constraints.h
include/deal.II/numerics/vector_tools_constraints.templates.h
include/deal.II/numerics/vector_tools_integrate_difference.h
include/deal.II/numerics/vector_tools_integrate_difference.templates.h
include/deal.II/numerics/vector_tools_interpolate.h
include/deal.II/numerics/vector_tools_interpolate.templates.h
include/deal.II/numerics/vector_tools_mean_value.h
include/deal.II/numerics/vector_tools_mean_value.templates.h
include/deal.II/numerics/vector_tools_point_gradient.h
include/deal.II/numerics/vector_tools_point_gradient.templates.h
include/deal.II/numerics/vector_tools_point_value.h
include/deal.II/numerics/vector_tools_point_value.templates.h
include/deal.II/numerics/vector_tools_project.h
include/deal.II/numerics/vector_tools_project.templates.h
include/deal.II/numerics/vector_tools_rhs.h
include/deal.II/numerics/vector_tools_rhs.templates.h
include/deal.II/opencascade/manifold_lib.h
include/deal.II/opencascade/utilities.h
include/deal.II/optimization/line_minimization.h
include/deal.II/optimization/solver_bfgs.h
include/deal.II/particles/data_out.h
include/deal.II/particles/generators.h
include/deal.II/particles/particle.h
include/deal.II/particles/particle_handler.h
include/deal.II/particles/property_pool.h
include/deal.II/physics/notation.h
include/deal.II/sundials/arkode.h
include/deal.II/sundials/ida.h
include/deal.II/sundials/kinsol.h
source/base/CMakeLists.txt
source/base/bounding_box.cc
source/base/bounding_box.inst.in
source/base/data_out_base.cc
source/base/data_out_base.inst.in
source/base/discrete_time.cc
source/base/flow_function.cc
source/base/function_lib.cc
source/base/function_lib_cutoff.cc
source/base/function_parser.cc
source/base/geometry_info.cc
source/base/index_set.cc
source/base/logstream.cc
source/base/mpi.cc
source/base/mpi.inst.in
source/base/mpi_consensus_algorithms.cc
source/base/multithread_info.cc
source/base/parameter_acceptor.cc
source/base/parameter_handler.cc
source/base/parsed_convergence_table.cc
source/base/partitioner.cc
source/base/patterns.cc
source/base/polynomial.cc
source/base/polynomial_space.cc
source/base/polynomials_abf.cc
source/base/polynomials_adini.cc
source/base/polynomials_bdm.cc
source/base/polynomials_bernardi_raugel.cc
source/base/polynomials_nedelec.cc
source/base/polynomials_rannacher_turek.cc
source/base/polynomials_raviart_thomas.cc
source/base/polynomials_rt_bubbles.cc
source/base/process_grid.cc
source/base/quadrature.cc
source/base/quadrature_lib.cc
source/base/quadrature_selector.cc
source/base/symbolic_function.cc
source/base/symbolic_function.inst.in
source/base/symmetric_tensor.cc
source/base/symmetric_tensor.inst.in
source/base/table_handler.cc
source/base/tensor_function_parser.cc
source/base/tensor_function_parser.inst.in
source/base/tensor_product_polynomials_bubbles.cc
source/base/tensor_product_polynomials_const.cc
source/base/timer.cc
source/base/utilities.cc
source/base/vectorization.cc
source/differentiation/sd/CMakeLists.txt
source/distributed/CMakeLists.txt
source/distributed/cell_weights.cc
source/distributed/fully_distributed_tria.cc
source/distributed/fully_distributed_tria.inst.in
source/distributed/grid_refinement.cc
source/distributed/grid_refinement.inst.in
source/distributed/p4est_wrappers.cc
source/distributed/p4est_wrappers.inst.in
source/distributed/shared_tria.cc
source/distributed/solution_transfer.cc
source/distributed/tria.cc
source/distributed/tria_base.cc
source/distributed/tria_base.inst.in
source/dofs/block_info.cc
source/dofs/block_info.inst.in
source/dofs/dof_accessor_get.cc
source/dofs/dof_accessor_set.cc
source/dofs/dof_handler.cc
source/dofs/dof_handler.inst.in
source/dofs/dof_handler_policy.cc
source/dofs/dof_renumbering.cc
source/dofs/dof_tools.cc
source/dofs/dof_tools.inst.in
source/dofs/dof_tools_constraints.cc
source/dofs/dof_tools_constraints.inst.in
source/dofs/dof_tools_sparsity.cc
source/dofs/dof_tools_sparsity.inst.in
source/dofs/number_cache.cc
source/fe/CMakeLists.txt
source/fe/fe.cc
source/fe/fe_abf.cc
source/fe/fe_bdm.cc
source/fe/fe_bernardi_raugel.cc
source/fe/fe_bernstein.cc
source/fe/fe_dg_vector.cc
source/fe/fe_dgp_nonparametric.cc
source/fe/fe_dgq.cc
source/fe/fe_enriched.cc
source/fe/fe_face.cc
source/fe/fe_nedelec.cc
source/fe/fe_nedelec_sz.cc
source/fe/fe_poly.cc
source/fe/fe_poly_tensor.cc
source/fe/fe_poly_tensor.inst.in
source/fe/fe_q_base.cc
source/fe/fe_q_bubbles.cc
source/fe/fe_q_hierarchical.cc
source/fe/fe_rannacher_turek.cc
source/fe/fe_raviart_thomas.cc
source/fe/fe_raviart_thomas_nodal.cc
source/fe/fe_rt_bubbles.cc
source/fe/fe_series_fourier.cc
source/fe/fe_series_legendre.cc
source/fe/fe_system.cc
source/fe/fe_tools.cc
source/fe/fe_tools.inst.in
source/fe/fe_trace.cc
source/fe/fe_values.cc
source/fe/mapping.cc
source/fe/mapping_fe_field.cc
source/fe/mapping_manifold.cc
source/fe/mapping_q1_eulerian.cc
source/fe/mapping_q_eulerian.cc
source/fe/mapping_q_generic.cc
source/grid/CMakeLists.txt
source/grid/grid_generator.cc
source/grid/grid_generator.inst.in
source/grid/grid_generator_from_name.cc
source/grid/grid_in.cc
source/grid/grid_out.cc
source/grid/grid_out.inst.in
source/grid/grid_refinement.cc
source/grid/grid_refinement.inst.in
source/grid/grid_reordering.cc
source/grid/grid_tools.cc
source/grid/grid_tools.inst.in
source/grid/grid_tools_cache.cc
source/grid/grid_tools_dof_handlers.cc
source/grid/manifold.cc
source/grid/manifold_lib.cc
source/grid/persistent_tria.cc
source/grid/tria.cc
source/grid/tria_accessor.cc
source/grid/tria_description.cc
source/grid/tria_description.inst.in
source/grid/tria_objects.cc
source/hp/CMakeLists.txt
source/hp/dof_faces.cc
source/hp/dof_handler.cc
source/hp/dof_handler.inst.in
source/hp/fe_collection.cc
source/hp/fe_values.inst.in
source/hp/refinement.cc
source/lac/CMakeLists.txt
source/lac/affine_constraints.inst.in
source/lac/block_sparsity_pattern.cc
source/lac/block_vector.cc
source/lac/chunk_sparsity_pattern.cc
source/lac/dynamic_sparsity_pattern.cc
source/lac/full_matrix.cc
source/lac/la_parallel_vector.inst.in
source/lac/lapack_full_matrix.cc
source/lac/petsc_matrix_base.cc
source/lac/petsc_parallel_sparse_matrix.cc
source/lac/petsc_parallel_vector.cc
source/lac/petsc_precondition.cc
source/lac/petsc_solver.cc
source/lac/petsc_sparse_matrix.cc
source/lac/petsc_vector_base.cc
source/lac/read_write_vector.cc
source/lac/slepc_solver.cc
source/lac/slepc_spectral_transformation.cc
source/lac/sparse_direct.cc
source/lac/sparsity_pattern.cc
source/lac/sparsity_tools.cc
source/lac/tridiagonal_matrix.cc
source/lac/trilinos_block_sparse_matrix.cc
source/lac/trilinos_precondition.cc
source/lac/trilinos_precondition_ml.cc
source/lac/trilinos_precondition_muelu.cc
source/lac/trilinos_solver.cc
source/lac/trilinos_sparse_matrix.cc
source/lac/trilinos_sparse_matrix.inst.in
source/lac/trilinos_sparsity_pattern.cc
source/lac/trilinos_vector.cc
source/lac/vector.cc
source/matrix_free/CMakeLists.txt
source/matrix_free/mapping_info.cc
source/matrix_free/mapping_info.inst.in
source/matrix_free/matrix_free.cc
source/matrix_free/matrix_free.inst.in
source/matrix_free/task_info.cc
source/meshworker/scratch_data.cc
source/multigrid/mg_level_global_transfer.cc
source/multigrid/mg_tools.cc
source/multigrid/mg_tools.inst.in
source/multigrid/mg_transfer_block.cc
source/multigrid/mg_transfer_block.inst.in
source/multigrid/mg_transfer_component.cc
source/multigrid/mg_transfer_component.inst.in
source/multigrid/mg_transfer_internal.cc
source/multigrid/mg_transfer_internal.inst.in
source/multigrid/mg_transfer_matrix_free.cc
source/multigrid/mg_transfer_prebuilt.cc
source/multigrid/mg_transfer_prebuilt.inst.in
source/multigrid/multigrid.cc
source/non_matching/CMakeLists.txt
source/non_matching/coupling.cc
source/non_matching/coupling.inst.in
source/numerics/CMakeLists.txt
source/numerics/data_out.cc
source/numerics/data_out_dof_data.inst.in
source/numerics/data_out_faces.cc
source/numerics/data_out_rotation.cc
source/numerics/derivative_approximation.cc
source/numerics/error_estimator_1d.cc
source/numerics/histogram.cc
source/numerics/point_value_history.cc
source/numerics/solution_transfer.cc
source/numerics/time_dependent.cc
source/numerics/vector_tools_boundary.cc
source/numerics/vector_tools_boundary.inst.in
source/numerics/vector_tools_constraints.cc
source/numerics/vector_tools_integrate_difference.cc
source/numerics/vector_tools_integrate_difference.inst.in
source/numerics/vector_tools_interpolate.cc
source/numerics/vector_tools_mean_value.cc
source/numerics/vector_tools_point_gradient.cc
source/numerics/vector_tools_point_value.cc
source/numerics/vector_tools_project.cc
source/numerics/vector_tools_project_codim.cc
source/numerics/vector_tools_project_hp.cc
source/numerics/vector_tools_project_qp.cc
source/numerics/vector_tools_project_qpmf.cc
source/numerics/vector_tools_project_qpmf.inst.in
source/numerics/vector_tools_rhs.cc
source/opencascade/utilities.cc
source/particles/CMakeLists.txt
source/particles/data_out.cc
source/particles/generators.cc
source/particles/generators.inst.in
source/particles/particle.cc
source/particles/particle_handler.cc
source/sundials/arkode.cc
source/sundials/ida.cc
source/sundials/kinsol.cc
tests/CMakeLists.txt
tests/ad_common_tests/helper_scalar_coupled_2_components_01.h
tests/ad_common_tests/helper_scalar_coupled_2_components_02.h
tests/ad_common_tests/helper_scalar_coupled_2_components_03.h
tests/ad_common_tests/helper_scalar_coupled_2_components_04.h
tests/ad_common_tests/helper_scalar_coupled_2_components_05.h
tests/ad_common_tests/helper_scalar_coupled_2_components_06.h
tests/ad_common_tests/helper_scalar_coupled_2_components_07.h
tests/ad_common_tests/helper_scalar_coupled_2_components_08.h
tests/ad_common_tests/helper_scalar_coupled_3_components_01.h
tests/ad_common_tests/helper_scalar_coupled_3_components_01_tapeless_only.h
tests/ad_common_tests/helper_scalar_coupled_4_components_01.h
tests/ad_common_tests/helper_scalar_single_component_01.h
tests/ad_common_tests/helper_scalar_single_component_02.h
tests/ad_common_tests/helper_scalar_single_component_03.h
tests/ad_common_tests/helper_scalar_single_component_04.h
tests/ad_common_tests/helper_vector_1_indep_1_dep_vars_01.h
tests/ad_common_tests/helper_vector_1_indep_2_dep_vars_01.h
tests/ad_common_tests/helper_vector_2_indep_1_dep_vars_01.h
tests/ad_common_tests/helper_vector_2_indep_2_dep_vars_01.h
tests/ad_common_tests/physics_functions_01.h
tests/ad_common_tests/physics_functions_02.h
tests/ad_common_tests/physics_functions_03.h
tests/ad_common_tests/step-44-helper_res_lin_01.h
tests/ad_common_tests/step-44-helper_scalar_01.h
tests/ad_common_tests/step-44-helper_var_form_01.h
tests/ad_common_tests/step-44-helper_vector_01.h
tests/ad_common_tests/symmetric_tensor_functions_01.h
tests/ad_common_tests/symmetric_tensor_functions_02.h
tests/ad_common_tests/symmetric_tensor_functions_03.h
tests/ad_common_tests/symmetric_tensor_functions_04.h
tests/ad_common_tests/tensor_functions_01.h
tests/ad_common_tests/tensor_functions_02.h
tests/adolc/ad_number_traits_01.cc
tests/adolc/ad_number_traits_02a.cc
tests/adolc/ad_number_traits_02b.cc
tests/adolc/ad_number_traits_03.cc
tests/adolc/helper_retaping_01.cc
tests/adolc/helper_retaping_02.cc
tests/adolc/helper_retaping_03.cc
tests/adolc/helper_scalar_coupled_2_components_01_1.cc
tests/adolc/helper_scalar_coupled_2_components_01_2.cc
tests/adolc/helper_scalar_coupled_2_components_02_1.cc
tests/adolc/helper_scalar_coupled_2_components_02_2.cc
tests/adolc/helper_scalar_coupled_2_components_03_1.cc
tests/adolc/helper_scalar_coupled_2_components_03_2.cc
tests/adolc/helper_scalar_coupled_2_components_04_1.cc
tests/adolc/helper_scalar_coupled_2_components_04_2.cc
tests/adolc/helper_scalar_coupled_2_components_05_1.cc
tests/adolc/helper_scalar_coupled_2_components_05_2.cc
tests/adolc/helper_scalar_coupled_2_components_06_1.cc
tests/adolc/helper_scalar_coupled_2_components_06_2.cc
tests/adolc/helper_scalar_coupled_2_components_07_1.cc
tests/adolc/helper_scalar_coupled_2_components_07_2.cc
tests/adolc/helper_scalar_coupled_2_components_08_1.cc
tests/adolc/helper_scalar_coupled_2_components_08_2.cc
tests/adolc/helper_scalar_coupled_3_components_01_1.cc
tests/adolc/helper_scalar_coupled_3_components_01_2.cc
tests/adolc/helper_scalar_coupled_3_components_01_tapeless_only_2.cc
tests/adolc/helper_scalar_coupled_4_components_01_1.cc
tests/adolc/helper_scalar_coupled_4_components_01_2.cc
tests/adolc/helper_scalar_failure_01.cc
tests/adolc/helper_scalar_failure_02.cc
tests/adolc/helper_scalar_failure_03.cc
tests/adolc/helper_scalar_failure_04.cc
tests/adolc/helper_scalar_failure_05.cc
tests/adolc/helper_scalar_single_component_01_1.cc
tests/adolc/helper_scalar_single_component_01_2.cc
tests/adolc/helper_scalar_single_component_02_1.cc
tests/adolc/helper_scalar_single_component_02_2.cc
tests/adolc/helper_scalar_single_component_03_1.cc
tests/adolc/helper_scalar_single_component_03_2.cc
tests/adolc/helper_scalar_single_component_04_1.cc
tests/adolc/helper_scalar_single_component_04_2.cc
tests/adolc/helper_tape_index_01.cc
tests/adolc/helper_vector_1_indep_1_dep_vars_01_1.cc
tests/adolc/helper_vector_1_indep_1_dep_vars_01_2.cc
tests/adolc/helper_vector_1_indep_2_dep_vars_01_1.cc
tests/adolc/helper_vector_1_indep_2_dep_vars_01_2.cc
tests/adolc/helper_vector_2_indep_1_dep_vars_01_1.cc
tests/adolc/helper_vector_2_indep_1_dep_vars_01_2.cc
tests/adolc/helper_vector_2_indep_2_dep_vars_01_1.cc
tests/adolc/helper_vector_2_indep_2_dep_vars_01_2.cc
tests/adolc/physics_functions_01_1.cc
tests/adolc/physics_functions_01_2.cc
tests/adolc/physics_functions_02_1.cc
tests/adolc/physics_functions_02_2.cc
tests/adolc/physics_functions_03_1.cc
tests/adolc/physics_functions_03_2.cc
tests/adolc/step-44-helper_res_lin_01_1.cc
tests/adolc/step-44-helper_res_lin_01_2.cc
tests/adolc/step-44-helper_scalar_01_1.cc
tests/adolc/step-44-helper_var_form_01_1.cc
tests/adolc/step-44-helper_vector_01_1.cc
tests/adolc/step-44-helper_vector_01_2.cc
tests/adolc/step-44.cc
tests/adolc/symmetric_tensor_functions_01_1.cc
tests/adolc/symmetric_tensor_functions_01_2.cc
tests/adolc/symmetric_tensor_functions_02_1.cc
tests/adolc/symmetric_tensor_functions_02_2.cc
tests/adolc/symmetric_tensor_functions_03_1.cc
tests/adolc/symmetric_tensor_functions_03_2.cc
tests/adolc/symmetric_tensor_functions_04_1.cc
tests/adolc/symmetric_tensor_functions_04_2.cc
tests/adolc/tensor_functions_01_1.cc
tests/adolc/tensor_functions_01_2.cc
tests/adolc/tensor_functions_02_1.cc
tests/adolc/tensor_functions_02_2.cc
tests/adolc/tensor_ops_01.cc
tests/adolc/tensor_ops_02.cc
tests/algorithms/newton_01.cc
tests/algorithms/newton_02.cc
tests/algorithms/theta_01.cc
tests/aniso/anisotropic_crash.cc
tests/aniso/mesh_3d_21.cc
tests/aniso/up_and_down.cc
tests/arpack/arpack_advection_diffusion.cc
tests/arpack/parpack_advection_diffusion_trilinos.cc
tests/arpack/step-36_ar.cc
tests/arpack/step-36_ar_shift.cc
tests/arpack/step-36_ar_with_iterations.cc
tests/arpack/step-36_parpack_mf.cc
tests/arpack/step-36_parpack_mf_02.cc
tests/arpack/step-36_parpack_mf_03.cc
tests/arpack/step-36_parpack_trilinos.cc
tests/base/anisotropic_1.cc
tests/base/bounding_box_5.cc
tests/base/bounding_box_6.cc
tests/base/cell_data_storage_01.cc
tests/base/cell_data_storage_02.cc
tests/base/convergence_table_05.cc
tests/base/coordinate_to_one_dim_higher.cc
tests/base/derivative_forms_01.cc
tests/base/discrete_time_1.cc
tests/base/full_tensor_06.cc
tests/base/function_cutoff_01.cc
tests/base/function_cutoff_02.cc
tests/base/function_parser_05.cc
tests/base/function_parser_09.cc
tests/base/function_parser_10.cc
tests/base/functions_01.cc
tests/base/functions_04.cc
tests/base/functions_11_gradient.cc
tests/base/functions_constant_function_00.cc
tests/base/functions_incremental_01.cc
tests/base/functions_incremental_02.cc
tests/base/functions_singularity.cc
tests/base/geometric_utilities_01.cc
tests/base/geometry_info_1.cc
tests/base/geometry_info_2.cc
tests/base/geometry_info_3.cc
tests/base/geometry_info_4.cc
tests/base/geometry_info_5.cc
tests/base/geometry_info_6.cc
tests/base/geometry_info_7.cc
tests/base/geometry_info_8.cc
tests/base/geometry_info_9.cc
tests/base/mpi_noncontiguous_partitioner_01.cc
tests/base/mpi_noncontiguous_partitioner_02.cc
tests/base/mpi_noncontiguous_partitioner_03.cc
tests/base/parsed_convergence_table_01.cc
tests/base/parsed_convergence_table_03.cc
tests/base/parsed_convergence_table_04.cc
tests/base/parsed_convergence_table_05.cc
tests/base/parsed_convergence_table_06.cc
tests/base/point_03.cc
tests/base/point_04.cc
tests/base/polynomial_minus_equals.cc
tests/base/polynomial_test.cc
tests/base/polynomials_adini_01.cc
tests/base/polynomials_bdm_01.cc
tests/base/polynomials_bdm_02.cc
tests/base/polynomials_br.cc
tests/base/polynomials_rt.cc
tests/base/polynomials_rt_bubbles.cc
tests/base/polynomials_tensor.cc
tests/base/qprojector.cc
tests/base/quadrature_chebyshev.cc
tests/base/quadrature_point_data.cc
tests/base/quadrature_point_data_02.cc
tests/base/quadrature_point_data_03.cc
tests/base/quadrature_point_data_04.cc
tests/base/quadrature_selector.cc
tests/base/quadrature_simplex_01.cc
tests/base/quadrature_simplex_02.cc
tests/base/quadrature_simplex_03.cc
tests/base/quadrature_simplex_04.cc
tests/base/quadrature_simplex_05.cc
tests/base/simplex.h
tests/base/stdcxx17_apply.cc
tests/base/symbolic_function_01.cc
tests/base/symbolic_function_02.cc
tests/base/symbolic_function_03.cc
tests/base/symbolic_function_04.cc
tests/base/task_group_size.cc
tests/base/tensor_function_parser_01.cc
tests/base/tensor_function_parser_02.cc
tests/base/tensor_function_parser_03.cc
tests/base/tensor_function_parser_04.cc
tests/base/timer.cc
tests/base/timer_03.cc
tests/base/timer_05.cc
tests/base/timer_07.cc
tests/base/transpose_table_iterators_1.cc
tests/base/utilities_01.cc
tests/base/utilities_02b.cc
tests/base/utilities_04.cc
tests/base/utilities_05.cc
tests/base/utilities_06.cc
tests/base/utilities_07.cc
tests/base/utilities_21.cc
tests/base/utilities_22.cc
tests/base/utilities_pack_unpack_05.cc
tests/base/utilities_pack_unpack_06.cc
tests/base/utilities_pack_unpack_07.cc
tests/base/utilities_trim.cc
tests/base/vectorization_01.cc
tests/base/vectorization_02.cc
tests/base/vectorization_03.cc
tests/base/vectorization_04.cc
tests/base/vectorization_05.cc
tests/base/vectorization_06.cc
tests/base/vectorization_09.cc
tests/base/vectorization_10.cc
tests/base/vectorization_11.cc
tests/base/vectorization_12.cc
tests/base/vectorization_13.cc
tests/base/vectorization_14.cc
tests/base/vectorization_15.cc
tests/base/vectorization_iterator_02.cc
tests/bits/anna_3.cc
tests/bits/anna_6.cc
tests/bits/block_sparse_matrix_1.cc
tests/bits/christian_1.cc
tests/bits/christian_2.cc
tests/bits/coarsening_3d.cc
tests/bits/cone_03.cc
tests/bits/cone_04.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/deal_solver_04.cc
tests/bits/deal_solver_05.cc
tests/bits/distorted_cells_01.cc
tests/bits/distorted_cells_06.cc
tests/bits/distorted_cells_07.cc
tests/bits/distorted_mapped_cells_01.cc
tests/bits/error_estimator_01.cc
tests/bits/error_estimator_02.cc
tests/bits/face_interpolation.cc
tests/bits/face_orientation_crash.cc
tests/bits/faceq_face_interpolation.cc
tests/bits/faceq_subface_interpolation.cc
tests/bits/fe_field_function_04_vector.cc
tests/bits/fe_tools_01a.cc
tests/bits/fe_tools_01b.cc
tests/bits/fe_tools_01c.cc
tests/bits/fe_tools_02.cc
tests/bits/fe_tools_03.cc
tests/bits/fe_tools_04.cc
tests/bits/fe_tools_04_overwrite.cc
tests/bits/fe_tools_05.cc
tests/bits/fe_tools_06.cc
tests/bits/fe_tools_06b.cc
tests/bits/fe_tools_06c.cc
tests/bits/fe_tools_06d.cc
tests/bits/fe_tools_07.cc
tests/bits/fe_tools_08.cc
tests/bits/fe_tools_09.cc
tests/bits/fe_tools_10.cc
tests/bits/fe_tools_11.cc
tests/bits/fe_tools_12.cc
tests/bits/fe_tools_14.cc
tests/bits/fe_tools_cpfqpm_01.cc
tests/bits/fe_tools_cpfqpm_02.cc
tests/bits/fe_tools_cpfqpm_03.cc
tests/bits/fe_tools_cpfqpm_04.cc
tests/bits/fe_tools_cpfqpm_05.cc
tests/bits/find_cell_1.cc
tests/bits/find_cell_10.cc
tests/bits/find_cell_10a.cc
tests/bits/find_cell_11.cc
tests/bits/find_cell_12.cc
tests/bits/find_cell_2.cc
tests/bits/find_cell_3.cc
tests/bits/find_cell_4.cc
tests/bits/find_cell_5.cc
tests/bits/find_cell_6.cc
tests/bits/find_cell_8.cc
tests/bits/find_cell_9.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/joa_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/periodicity_01.cc
tests/bits/periodicity_05.cc
tests/bits/periodicity_06.cc
tests/bits/periodicity_07.cc
tests/bits/periodicity_09.cc
tests/bits/point_difference_01.cc
tests/bits/point_difference_02.cc
tests/bits/point_gradient_01.cc
tests/bits/point_gradient_02.cc
tests/bits/point_gradient_hp_01.cc
tests/bits/point_gradient_hp_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/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/q_points.cc
tests/bits/roy_1.cc
tests/bits/rt_2.cc
tests/bits/solution_transfer.cc
tests/bits/static_condensation.cc
tests/bits/step-10-high-order.cc
tests/bits/step-10.cc
tests/bits/step-11.cc
tests/bits/step-12.cc
tests/bits/step-13.cc
tests/bits/step-14.cc
tests/bits/step-16.cc
tests/bits/step-2.cc
tests/bits/step-4.cc
tests/bits/step-4_dg_periodic.cc
tests/bits/step-4_dg_periodic_coupling.cc
tests/bits/step-51.cc
tests/bits/step-51p.cc
tests/bits/step-6-racoptimize-2.cc
tests/bits/step-6-racoptimize.cc
tests/bits/step-7.cc
tests/bits/step-8.cc
tests/bits/subface_interpolation.cc
tests/bits/volume_1.cc
tests/bits/volume_2.cc
tests/bits/volume_3.cc
tests/bits/volume_4.cc
tests/boost/bounding_box_adaptor_01.cc
tests/boost/point_adaptor_01.cc
tests/boost/rtree_01.cc
tests/codim_one/bem.cc
tests/codim_one/bem_integration.cc
tests/codim_one/boundary_indicator_01.cc
tests/codim_one/direction_flag_01.cc
tests/codim_one/direction_flag_02.cc
tests/codim_one/direction_flag_03.cc
tests/codim_one/extract_boundary_mesh_00.cc
tests/codim_one/extract_boundary_mesh_01.cc
tests/codim_one/extract_boundary_mesh_02.cc
tests/codim_one/extract_boundary_mesh_03.cc
tests/codim_one/extract_boundary_mesh_04.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/extract_boundary_mesh_11.cc
tests/codim_one/extract_boundary_mesh_13.cc
tests/codim_one/extract_boundary_mesh_15.cc
tests/codim_one/fe_dgq_prolongation_01.cc
tests/codim_one/gradients.cc
tests/codim_one/grid_refinement.cc
tests/codim_one/hanging_nodes_02.cc
tests/codim_one/hanging_nodes_03.cc
tests/codim_one/integrate_one_over_r_telles.cc
tests/codim_one/integrate_one_over_r_telles_middle.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/solution_transfer_01.cc
tests/codim_one/surface.cc
tests/cuda/matrix_vector_common.h
tests/data_out/data_out_01.cc
tests/data_out/data_out_02.cc
tests/data_out/data_out_03.cc
tests/data_out/data_out_04.cc
tests/data_out/data_out_05.cc
tests/data_out/data_out_06.cc
tests/data_out/data_out_07.cc
tests/data_out/data_out_08.cc
tests/data_out/data_out_08_set_cell_selection_01.cc
tests/data_out/data_out_08_set_cell_selection_02.cc
tests/data_out/data_out_08_set_cell_selection_03.cc
tests/data_out/data_out_12.cc
tests/data_out/data_out_13.cc
tests/data_out/data_out_base.cc
tests/data_out/data_out_base_dx.cc
tests/data_out/data_out_base_eps.cc
tests/data_out/data_out_base_gmv.cc
tests/data_out/data_out_base_gnuplot.cc
tests/data_out/data_out_base_gnuplot_02.cc
tests/data_out/data_out_base_gnuplot_labels.cc
tests/data_out/data_out_base_gnuplot_labels_02.cc
tests/data_out/data_out_base_povray.cc
tests/data_out/data_out_base_pvd.cc
tests/data_out/data_out_base_pvtu.cc
tests/data_out/data_out_base_tecplot.cc
tests/data_out/data_out_base_tecplot_bin.cc
tests/data_out/data_out_base_vtk.cc
tests/data_out/data_out_base_vtk_02.cc
tests/data_out/data_out_base_vtk_cycle.cc
tests/data_out/data_out_base_vtk_time.cc
tests/data_out/data_out_base_vtk_time_and_cycle.cc
tests/data_out/data_out_base_vtu.cc
tests/data_out/data_out_base_vtu_02.cc
tests/data_out/data_out_base_vtu_04.cc
tests/data_out/data_out_base_vtu_compression_levels.cc
tests/data_out/data_out_base_vtu_cycle.cc
tests/data_out/data_out_base_vtu_time.cc
tests/data_out/data_out_base_vtu_time_and_cycle.cc
tests/data_out/data_out_complex_05.cc
tests/data_out/data_out_complex_05_tensor.cc
tests/data_out/data_out_complex_06.cc
tests/data_out/data_out_complex_postprocessor_01.cc
tests/data_out/data_out_complex_postprocessor_03.cc
tests/data_out/data_out_curved_cells.cc
tests/data_out/data_out_faces_01.cc
tests/data_out/data_out_faces_02.cc
tests/data_out/data_out_faces_03.cc
tests/data_out/data_out_faces_04.cc
tests/data_out/data_out_faces_05.cc
tests/data_out/data_out_hdf5_02.cc
tests/data_out/data_out_multi_dh_01.cc
tests/data_out/data_out_multi_dh_02.cc
tests/data_out/data_out_multi_dh_03.cc
tests/data_out/data_out_multi_dh_04.cc
tests/data_out/data_out_multi_dh_05.cc
tests/data_out/data_out_postprocessor_tensor_01.cc
tests/data_out/data_out_postprocessor_vector_03.cc
tests/data_out/data_out_postprocessor_vector_complex_01.cc
tests/data_out/data_out_reader_01.cc
tests/data_out/data_out_rotation_01.cc
tests/data_out/data_out_rotation_02.cc
tests/data_out/data_out_rotation_03.cc
tests/data_out/data_out_rotation_04.cc
tests/data_out/data_out_rotation_05.cc
tests/data_out/data_out_stack_01.cc
tests/data_out/data_out_stack_02.cc
tests/data_out/patches.h
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_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/2d_refinement_10.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_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_08.cc
tests/distributed_grids/3d_refinement_09.cc
tests/distributed_grids/3d_refinement_12.cc
tests/distributed_grids/anisotropic.cc
tests/distributed_grids/codim_01.cc
tests/distributed_grids/count_dofs_per_block_01.cc
tests/distributed_grids/count_dofs_per_component_01.cc
tests/distributed_grids/dof_handler_number_cache.cc
tests/distributed_grids/grid_tools_exchange_cell_data_04.cc
tests/distributed_grids/hp_2d_dofhandler_01.cc
tests/distributed_grids/hp_count_dofs_per_block_01.cc
tests/distributed_grids/hp_count_dofs_per_component_01.cc
tests/distributed_grids/hp_dof_handler_number_cache.cc
tests/distributed_grids/intergrid_transfer_representation_parallel.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/tria_settings_01.cc
tests/distributed_grids/update_number_cache_01.cc
tests/dofs/block_info.cc
tests/dofs/block_info_02.cc
tests/dofs/block_list.h
tests/dofs/block_list_01.cc
tests/dofs/block_list_02.cc
tests/dofs/block_list_03.cc
tests/dofs/block_list_04.cc
tests/dofs/block_list_05.cc
tests/dofs/block_list_parallel_01.cc
tests/dofs/dof_handler_number_cache.cc
tests/dofs/dof_handler_number_cache_02.cc
tests/dofs/dof_renumbering.cc
tests/dofs/dof_renumbering_02.cc
tests/dofs/dof_renumbering_03.cc
tests/dofs/dof_renumbering_04.cc
tests/dofs/dof_renumbering_04a.cc
tests/dofs/dof_renumbering_05.cc
tests/dofs/dof_renumbering_06.cc
tests/dofs/dof_renumbering_07.cc
tests/dofs/dof_renumbering_08.cc
tests/dofs/dof_renumbering_zorder_01.cc
tests/dofs/dof_renumbering_zorder_02.cc
tests/dofs/dof_tools_00a.cc
tests/dofs/dof_tools_01a.cc
tests/dofs/dof_tools_01a_constraints_false.cc
tests/dofs/dof_tools_01a_constraints_true.cc
tests/dofs/dof_tools_01a_subdomain.cc
tests/dofs/dof_tools_01b.cc
tests/dofs/dof_tools_01c.cc
tests/dofs/dof_tools_01d.cc
tests/dofs/dof_tools_02a.cc
tests/dofs/dof_tools_02a_constraints_false.cc
tests/dofs/dof_tools_02a_constraints_true.cc
tests/dofs/dof_tools_02a_subdomain.cc
tests/dofs/dof_tools_02b.cc
tests/dofs/dof_tools_02c.cc
tests/dofs/dof_tools_02d.cc
tests/dofs/dof_tools_03.cc
tests/dofs/dof_tools_04.cc
tests/dofs/dof_tools_04a.cc
tests/dofs/dof_tools_05.cc
tests/dofs/dof_tools_06.cc
tests/dofs/dof_tools_07.cc
tests/dofs/dof_tools_08.cc
tests/dofs/dof_tools_09.cc
tests/dofs/dof_tools_10.cc
tests/dofs/dof_tools_12.cc
tests/dofs/dof_tools_12a.cc
tests/dofs/dof_tools_13.cc
tests/dofs/dof_tools_13a.cc
tests/dofs/dof_tools_14.cc
tests/dofs/dof_tools_15a.cc
tests/dofs/dof_tools_15b.cc
tests/dofs/dof_tools_15c.cc
tests/dofs/dof_tools_15d.cc
tests/dofs/dof_tools_16a.cc
tests/dofs/dof_tools_16b.cc
tests/dofs/dof_tools_16c.cc
tests/dofs/dof_tools_16d.cc
tests/dofs/dof_tools_17a.cc
tests/dofs/dof_tools_17b.cc
tests/dofs/dof_tools_17c.cc
tests/dofs/dof_tools_17d.cc
tests/dofs/dof_tools_18a.cc
tests/dofs/dof_tools_18a_1d.cc
tests/dofs/dof_tools_18b.cc
tests/dofs/dof_tools_18c.cc
tests/dofs/dof_tools_18d.cc
tests/dofs/dof_tools_19.cc
tests/dofs/dof_tools_20.cc
tests/dofs/dof_tools_21.cc
tests/dofs/dof_tools_21_b.cc
tests/dofs/dof_tools_21_b_x.cc
tests/dofs/dof_tools_21_b_x_q3.cc
tests/dofs/dof_tools_21_b_y.cc
tests/dofs/dof_tools_21_c.cc
tests/dofs/dof_tools_22a.cc
tests/dofs/dof_tools_23.cc
tests/dofs/dof_tools_24.cc
tests/dofs/dof_tools_25.cc
tests/dofs/dof_tools_common.h
tests/dofs/dof_tools_periodic.h
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_02_mg.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/extract_dofs_per_component_01.cc
tests/dofs/extract_dofs_per_component_02.cc
tests/dofs/hp_constraints_are_implemented.cc
tests/dofs/interpolate_based_on_material_id_01.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/interpolate_q_system_mask_01.cc
tests/dofs/interpolate_q_system_mask_02.cc
tests/dofs/locally_owned_dofs_per_subdomain_01.cc
tests/dofs/map_dofs_to_support_points_01.cc
tests/dofs/mg_dof_handler.cc
tests/dofs/n_boundary_dofs_01.cc
tests/dofs/n_dofs_per_object.cc
tests/dofs/range_based_for_dof_face.cc
tests/dofs/range_based_for_step-6.cc
tests/dofs/range_based_for_tria_face.cc
tests/dofs/sparsity_pattern.cc
tests/dofs/sparsity_pattern_01.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_06.cc
tests/dofs/sparsity_pattern_07.cc
tests/epetraext/sparse_matrix_mmult_01.cc
tests/epetraext/sparse_matrix_mmult_02.cc
tests/examples/step-56.cc
tests/fail/circular_01.cc
tests/fail/fe_nothing_04.cc
tests/fail/hp-step-14.cc
tests/fail/rt_6.cc
tests/fail/rt_crash_01.cc
tests/fail/scalapack_15_b.cc
tests/fail/step-15.cc
tests/fe/abf_01.cc
tests/fe/abf_02.cc
tests/fe/abf_degree.cc
tests/fe/block_mask_01.cc
tests/fe/block_mask_02.cc
tests/fe/block_mask_03.cc
tests/fe/block_mask_04.cc
tests/fe/block_mask_05.cc
tests/fe/block_mask_06.cc
tests/fe/block_mask_07.cc
tests/fe/block_mask_08.cc
tests/fe/block_mask_09.cc
tests/fe/block_mask_10.cc
tests/fe/block_mask_11.cc
tests/fe/br_approximation_01.cc
tests/fe/cell_similarity_01.cc
tests/fe/cell_similarity_02.cc
tests/fe/cell_similarity_03.cc
tests/fe/cell_similarity_04.cc
tests/fe/cell_similarity_05.cc
tests/fe/cell_similarity_06.cc
tests/fe/cell_similarity_07.cc
tests/fe/cell_similarity_08.cc
tests/fe/cell_similarity_09.cc
tests/fe/cell_similarity_10.cc
tests/fe/cell_similarity_11.cc
tests/fe/cell_similarity_dgp_monomial_01.cc
tests/fe/cell_similarity_dgp_monomial_02.cc
tests/fe/cell_similarity_dgp_monomial_03.cc
tests/fe/cell_similarity_dgp_monomial_04.cc
tests/fe/cell_similarity_dgp_monomial_05.cc
tests/fe/cell_similarity_dgp_monomial_06.cc
tests/fe/cell_similarity_dgp_monomial_07.cc
tests/fe/cell_similarity_dgp_monomial_08.cc
tests/fe/cell_similarity_dgp_monomial_09.cc
tests/fe/cell_similarity_dgp_monomial_10.cc
tests/fe/cell_similarity_dgp_nonparametric_01.cc
tests/fe/cell_similarity_dgp_nonparametric_02.cc
tests/fe/cell_similarity_dgp_nonparametric_03.cc
tests/fe/cell_similarity_dgp_nonparametric_04.cc
tests/fe/cell_similarity_dgp_nonparametric_05.cc
tests/fe/cell_similarity_dgp_nonparametric_06.cc
tests/fe/cell_similarity_dgp_nonparametric_07.cc
tests/fe/cell_similarity_dgp_nonparametric_08.cc
tests/fe/cell_similarity_dgp_nonparametric_09.cc
tests/fe/cell_similarity_dgp_nonparametric_10.cc
tests/fe/check_derivatives.cc
tests/fe/component_mask_01.cc
tests/fe/component_mask_02.cc
tests/fe/component_mask_03.cc
tests/fe/component_mask_04.cc
tests/fe/component_mask_05.cc
tests/fe/component_mask_06.cc
tests/fe/component_mask_07.cc
tests/fe/component_mask_08.cc
tests/fe/component_mask_09.cc
tests/fe/component_mask_10.cc
tests/fe/component_mask_11.cc
tests/fe/component_mask_12.cc
tests/fe/component_mask_13.cc
tests/fe/component_mask_14.cc
tests/fe/curl_curl_01.cc
tests/fe/deformed_projection.h
tests/fe/derivatives.cc
tests/fe/derivatives_bernstein.cc
tests/fe/derivatives_face.cc
tests/fe/dgp_01.cc
tests/fe/element_constant_modes.cc
tests/fe/fe_abf_gradient_divergence_theorem.cc
tests/fe/fe_br.cc
tests/fe/fe_compute_point_locations_01.cc
tests/fe/fe_data_test.cc
tests/fe/fe_dgp_3rd_derivative_divergence_theorem.cc
tests/fe/fe_dgq_3rd_derivative_divergence_theorem.cc
tests/fe/fe_dgq_gradient_divergence_theorem.cc
tests/fe/fe_dgq_hessian_divergence_theorem.cc
tests/fe/fe_enriched_01.cc
tests/fe/fe_enriched_02.cc
tests/fe/fe_enriched_03.cc
tests/fe/fe_enriched_04.cc
tests/fe/fe_enriched_05.cc
tests/fe/fe_enriched_06.cc
tests/fe/fe_enriched_07.cc
tests/fe/fe_enriched_08.cc
tests/fe/fe_enriched_08a.cc
tests/fe/fe_enriched_color_01.cc
tests/fe/fe_enriched_color_07.cc
tests/fe/fe_enriched_compare_to_fe_system.cc
tests/fe/fe_enriched_compare_to_fe_system_2.cc
tests/fe/fe_enriched_step-36.cc
tests/fe/fe_enriched_step-36b.cc
tests/fe/fe_face_orientation_nedelec.h
tests/fe/fe_face_orientation_nedelec_0.cc
tests/fe/fe_face_values_1d.cc
tests/fe/fe_faceq_interpolate.cc
tests/fe/fe_nedelec_gradient_divergence_theorem.cc
tests/fe/fe_nedelec_hessian_divergence_theorem.cc
tests/fe/fe_nedelec_singularity_01.cc
tests/fe/fe_nedelec_singularity_02.cc
tests/fe/fe_nedelec_sz_face_values.cc
tests/fe/fe_nedelec_sz_gradient_divergence_theorem.cc
tests/fe/fe_nedelec_sz_non_rect_2d.cc
tests/fe/fe_nedelec_sz_non_rect_face.cc
tests/fe/fe_nothing.cc
tests/fe/fe_project_2d.cc
tests/fe/fe_project_3d.cc
tests/fe/fe_prolongation_bdm.cc
tests/fe/fe_prolongation_dgp.cc
tests/fe/fe_prolongation_dgq.cc
tests/fe/fe_prolongation_nedelec.cc
tests/fe/fe_prolongation_q.cc
tests/fe/fe_prolongation_q_bubbles.cc
tests/fe/fe_prolongation_q_dg0.cc
tests/fe/fe_prolongation_q_hierarchical.cc
tests/fe/fe_prolongation_q_iso_q1.cc
tests/fe/fe_prolongation_rt.cc
tests/fe/fe_prolongation_sys_01.cc
tests/fe/fe_prolongation_sys_02.cc
tests/fe/fe_prolongation_sys_03.cc
tests/fe/fe_prolongation_sys_04.cc
tests/fe/fe_prolongation_sys_05.cc
tests/fe/fe_prolongation_sys_06.cc
tests/fe/fe_prolongation_sys_07.cc
tests/fe/fe_prolongation_sys_08.cc
tests/fe/fe_prolongation_sys_09.cc
tests/fe/fe_prolongation_sys_10.cc
tests/fe/fe_q_3rd_derivative_divergence_theorem.cc
tests/fe/fe_q_bubbles.cc
tests/fe/fe_q_dg0.cc
tests/fe/fe_q_gradient_divergence_theorem.cc
tests/fe/fe_q_hessian_divergence_theorem.cc
tests/fe/fe_q_hierarchical_3rd_derivative_divergence_theorem.cc
tests/fe/fe_restriction_bdm.cc
tests/fe/fe_restriction_dgp.cc
tests/fe/fe_restriction_dgq.cc
tests/fe/fe_restriction_nedelec.cc
tests/fe/fe_restriction_q.cc
tests/fe/fe_restriction_q_bubbles.cc
tests/fe/fe_restriction_q_dg0.cc
tests/fe/fe_restriction_q_hierarchical.cc
tests/fe/fe_restriction_q_iso_q1.cc
tests/fe/fe_restriction_rt.cc
tests/fe/fe_restriction_sys_01.cc
tests/fe/fe_restriction_sys_02.cc
tests/fe/fe_restriction_sys_03.cc
tests/fe/fe_restriction_sys_04.cc
tests/fe/fe_restriction_sys_05.cc
tests/fe/fe_restriction_sys_06.cc
tests/fe/fe_restriction_sys_07.cc
tests/fe/fe_restriction_sys_08.cc
tests/fe/fe_restriction_sys_09.cc
tests/fe/fe_restriction_sys_10.cc
tests/fe/fe_rt_gradient_divergence_theorem.cc
tests/fe/fe_rt_hessian_divergence_theorem.cc
tests/fe/fe_series_01.cc
tests/fe/fe_series_02.cc
tests/fe/fe_series_03.cc
tests/fe/fe_series_04.cc
tests/fe/fe_series_05.cc
tests/fe/fe_series_06.cc
tests/fe/fe_series_07.cc
tests/fe/fe_series_08.cc
tests/fe/fe_subface_values_01.cc
tests/fe/fe_support_points_bdm.cc
tests/fe/fe_support_points_common.h
tests/fe/fe_support_points_nedelec.cc
tests/fe/fe_support_points_q.cc
tests/fe/fe_support_points_q_bubbles.cc
tests/fe/fe_support_points_q_dg0.cc
tests/fe/fe_support_points_q_hierarchical.cc
tests/fe/fe_support_points_q_iso_q1.cc
tests/fe/fe_support_points_rt.cc
tests/fe/fe_support_points_sys_01.cc
tests/fe/fe_support_points_sys_02.cc
tests/fe/fe_support_points_sys_03.cc
tests/fe/fe_support_points_sys_04.cc
tests/fe/fe_support_points_sys_05.cc
tests/fe/fe_support_points_sys_06.cc
tests/fe/fe_support_points_sys_07.cc
tests/fe/fe_support_points_sys_08.cc
tests/fe/fe_support_points_sys_09.cc
tests/fe/fe_support_points_sys_10.cc
tests/fe/fe_system_3rd_derivative_divergence_theorem.cc
tests/fe/fe_system_generalized_support_points.cc
tests/fe/fe_tools.cc
tests/fe/fe_tools_01.cc
tests/fe/fe_traceq_interpolate.cc
tests/fe/fe_values_extractor_01.cc
tests/fe/fe_values_function_manifold.cc
tests/fe/fe_values_no_mapping.cc
tests/fe/fe_values_view_01.cc
tests/fe/fe_values_view_02.cc
tests/fe/fe_values_view_03.cc
tests/fe/fe_values_view_04.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_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_18.cc
tests/fe/fe_values_view_19.cc
tests/fe/fe_values_view_20.cc
tests/fe/fe_values_view_21.cc
tests/fe/fe_values_view_21_nonsymmetric.cc
tests/fe/fe_values_view_22.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_25b_nonsymmetric.cc
tests/fe/fe_values_view_26.cc
tests/fe/fe_values_view_27.cc
tests/fe/fe_values_view_28.cc
tests/fe/fe_values_view_29.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/fe_values_view_tensor_01.cc
tests/fe/interpolate_nedelec.cc
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_q_system_mixed_01.cc
tests/fe/interpolate_rt.cc
tests/fe/interpolate_rtn.cc
tests/fe/interpolate_system.cc
tests/fe/jacobians.cc
tests/fe/jacobians_face.cc
tests/fe/jacobians_face_cartesian.cc
tests/fe/jacobians_face_fe_field.cc
tests/fe/multiple_redistribute_dofs_01.cc
tests/fe/multiple_redistribute_dofs_02.cc
tests/fe/nedelec_2.cc
tests/fe/nedelec_crash_01.cc
tests/fe/nedelec_face_interpolation.cc
tests/fe/nedelec_non_rect_2d.cc
tests/fe/nedelec_non_rect_face.cc
tests/fe/non_primitive_1.cc
tests/fe/non_primitive_2.cc
tests/fe/numbering.cc
tests/fe/p1nc_01.cc
tests/fe/p1nc_02.cc
tests/fe/p1nc_03.cc
tests/fe/p1nc_04.cc
tests/fe/p1nc_05.cc
tests/fe/p1nc_06.cc
tests/fe/p1nc_07.cc
tests/fe/p1nc_08.cc
tests/fe/restrict_prolongation_01.cc
tests/fe/rt_approximation_01.cc
tests/fe/rt_covariant.cc
tests/fe/rt_hessian.cc
tests/fe/rt_normal_02.cc
tests/fe/rtdiff.cc
tests/fe/rtn_1.cc
tests/fe/shapes.h
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/fe/transfer.cc
tests/fe/up_and_down.cc
tests/feinterface/face_orientation_01.cc
tests/feinterface/fe_interface_values_01.cc
tests/feinterface/fe_interface_values_02.cc
tests/feinterface/fe_interface_values_03.cc
tests/feinterface/fe_interface_values_04.cc
tests/feinterface/fe_interface_values_05.cc
tests/feinterface/fe_interface_values_06.cc
tests/feinterface/fe_interface_values_07.cc
tests/feinterface/fe_interface_values_08.cc
tests/feinterface/fe_interface_values_09.cc
tests/feinterface/step-12.cc
tests/full_matrix/complex_complex_full_matrix_01.cc
tests/full_matrix/complex_complex_full_matrix_02.cc
tests/full_matrix/complex_complex_full_matrix_03.cc
tests/full_matrix/complex_complex_full_matrix_04.cc
tests/full_matrix/complex_complex_full_matrix_06.cc
tests/full_matrix/complex_complex_full_matrix_07.cc
tests/full_matrix/complex_complex_full_matrix_08.cc
tests/full_matrix/complex_complex_full_matrix_10.cc
tests/full_matrix/complex_complex_full_matrix_11.cc
tests/full_matrix/complex_complex_full_matrix_12.cc
tests/full_matrix/complex_complex_full_matrix_13.cc
tests/full_matrix/complex_complex_full_matrix_14.cc
tests/full_matrix/complex_complex_full_matrix_15.cc
tests/full_matrix/complex_complex_full_matrix_16.cc
tests/full_matrix/complex_complex_full_matrix_17.cc
tests/full_matrix/complex_complex_full_matrix_18.cc
tests/full_matrix/complex_complex_full_matrix_19.cc
tests/full_matrix/complex_complex_full_matrix_20.cc
tests/full_matrix/complex_complex_full_matrix_21.cc
tests/full_matrix/complex_complex_full_matrix_22.cc
tests/full_matrix/complex_complex_full_matrix_23.cc
tests/full_matrix/complex_complex_full_matrix_24.cc
tests/full_matrix/complex_complex_full_matrix_25.cc
tests/full_matrix/complex_complex_full_matrix_26.cc
tests/full_matrix/complex_complex_full_matrix_27.cc
tests/full_matrix/complex_complex_full_matrix_28.cc
tests/full_matrix/complex_complex_full_matrix_29.cc
tests/full_matrix/complex_complex_full_matrix_30.cc
tests/full_matrix/complex_complex_full_matrix_31.cc
tests/full_matrix/complex_complex_full_matrix_32.cc
tests/full_matrix/complex_complex_full_matrix_33.cc
tests/full_matrix/complex_complex_full_matrix_34.cc
tests/full_matrix/complex_complex_full_matrix_36.cc
tests/full_matrix/complex_complex_full_matrix_37.cc
tests/full_matrix/complex_complex_full_matrix_38.cc
tests/full_matrix/complex_complex_full_matrix_39.cc
tests/full_matrix/complex_complex_full_matrix_40.cc
tests/full_matrix/complex_complex_full_matrix_41.cc
tests/full_matrix/complex_complex_full_matrix_42.cc
tests/full_matrix/complex_complex_full_matrix_43.cc
tests/full_matrix/complex_complex_full_matrix_44.cc
tests/full_matrix/complex_complex_full_matrix_45.cc
tests/full_matrix/complex_complex_full_matrix_46.cc
tests/full_matrix/complex_complex_full_matrix_47.cc
tests/full_matrix/complex_complex_full_matrix_48.cc
tests/full_matrix/complex_complex_full_matrix_49.cc
tests/full_matrix/complex_complex_full_matrix_50.cc
tests/full_matrix/complex_complex_full_matrix_51.cc
tests/full_matrix/complex_complex_full_matrix_52.cc
tests/full_matrix/complex_real_full_matrix_01.cc
tests/full_matrix/complex_real_full_matrix_02.cc
tests/full_matrix/complex_real_full_matrix_03.cc
tests/full_matrix/complex_real_full_matrix_04.cc
tests/full_matrix/complex_real_full_matrix_05.cc
tests/full_matrix/complex_real_full_matrix_06.cc
tests/full_matrix/complex_real_full_matrix_07.cc
tests/full_matrix/complex_real_full_matrix_08.cc
tests/full_matrix/complex_real_full_matrix_09.cc
tests/full_matrix/complex_real_full_matrix_10.cc
tests/full_matrix/complex_real_full_matrix_11.cc
tests/full_matrix/complex_real_full_matrix_12.cc
tests/full_matrix/complex_real_full_matrix_13.cc
tests/full_matrix/complex_real_full_matrix_14.cc
tests/full_matrix/complex_real_full_matrix_15.cc
tests/full_matrix/complex_real_full_matrix_16.cc
tests/full_matrix/complex_real_full_matrix_17.cc
tests/full_matrix/complex_real_full_matrix_18.cc
tests/full_matrix/complex_real_full_matrix_19.cc
tests/full_matrix/complex_real_full_matrix_20.cc
tests/full_matrix/complex_real_full_matrix_21.cc
tests/full_matrix/complex_real_full_matrix_22.cc
tests/full_matrix/complex_real_full_matrix_23.cc
tests/full_matrix/complex_real_full_matrix_24.cc
tests/full_matrix/complex_real_full_matrix_25.cc
tests/full_matrix/complex_real_full_matrix_26.cc
tests/full_matrix/complex_real_full_matrix_27.cc
tests/full_matrix/complex_real_full_matrix_28.cc
tests/full_matrix/complex_real_full_matrix_29.cc
tests/full_matrix/complex_real_full_matrix_30.cc
tests/full_matrix/complex_real_full_matrix_31.cc
tests/full_matrix/complex_real_full_matrix_32.cc
tests/full_matrix/complex_real_full_matrix_33.cc
tests/full_matrix/complex_real_full_matrix_34.cc
tests/full_matrix/complex_real_full_matrix_36.cc
tests/full_matrix/complex_real_full_matrix_37.cc
tests/full_matrix/complex_real_full_matrix_38.cc
tests/full_matrix/complex_real_full_matrix_39.cc
tests/full_matrix/complex_real_full_matrix_40.cc
tests/full_matrix/complex_real_full_matrix_41.cc
tests/full_matrix/complex_real_full_matrix_42.cc
tests/full_matrix/complex_real_full_matrix_43.cc
tests/full_matrix/complex_real_full_matrix_44.cc
tests/full_matrix/complex_real_full_matrix_45.cc
tests/full_matrix/complex_real_full_matrix_46.cc
tests/full_matrix/complex_real_full_matrix_47.cc
tests/full_matrix/complex_real_full_matrix_48.cc
tests/full_matrix/complex_real_full_matrix_49.cc
tests/full_matrix/complex_real_full_matrix_50.cc
tests/full_matrix/complex_real_full_matrix_51.cc
tests/full_matrix/complex_real_full_matrix_52.cc
tests/full_matrix/full_matrix_01.cc
tests/full_matrix/full_matrix_12.cc
tests/full_matrix/full_matrix_13.cc
tests/full_matrix/full_matrix_14.cc
tests/full_matrix/full_matrix_15.cc
tests/full_matrix/full_matrix_16.cc
tests/full_matrix/full_matrix_17.cc
tests/full_matrix/full_matrix_18.cc
tests/full_matrix/full_matrix_19.cc
tests/full_matrix/full_matrix_20.cc
tests/full_matrix/full_matrix_21.cc
tests/full_matrix/full_matrix_22.cc
tests/full_matrix/full_matrix_23.cc
tests/full_matrix/full_matrix_24.cc
tests/full_matrix/full_matrix_25.cc
tests/full_matrix/full_matrix_26.cc
tests/full_matrix/full_matrix_27.cc
tests/full_matrix/full_matrix_28.cc
tests/full_matrix/full_matrix_29.cc
tests/full_matrix/full_matrix_30.cc
tests/full_matrix/full_matrix_31.cc
tests/full_matrix/full_matrix_32.cc
tests/full_matrix/full_matrix_33.cc
tests/full_matrix/full_matrix_34.cc
tests/full_matrix/full_matrix_36.cc
tests/full_matrix/full_matrix_37.cc
tests/full_matrix/full_matrix_38.cc
tests/full_matrix/full_matrix_39.cc
tests/full_matrix/full_matrix_40.cc
tests/full_matrix/full_matrix_41.cc
tests/full_matrix/full_matrix_42.cc
tests/full_matrix/full_matrix_43.cc
tests/full_matrix/full_matrix_44.cc
tests/full_matrix/full_matrix_45.cc
tests/full_matrix/full_matrix_46.cc
tests/full_matrix/full_matrix_47.cc
tests/full_matrix/full_matrix_48.cc
tests/full_matrix/full_matrix_49.cc
tests/full_matrix/full_matrix_50.cc
tests/full_matrix/full_matrix_51.cc
tests/full_matrix/full_matrix_52.cc
tests/full_matrix/full_matrix_53.cc
tests/full_matrix/full_matrix_54.cc
tests/full_matrix/full_matrix_55.cc
tests/full_matrix/full_matrix_56.cc
tests/full_matrix/full_matrix_57.cc
tests/full_matrix/full_matrix_59.cc
tests/full_matrix/full_matrix_60.cc
tests/full_matrix/full_matrix_61.cc
tests/full_matrix/full_matrix_62.cc
tests/full_matrix/full_matrix_63.cc
tests/full_matrix/full_matrix_64.cc
tests/full_matrix/full_matrix_65.cc
tests/full_matrix/full_matrix_66.cc
tests/full_matrix/full_matrix_67.cc
tests/full_matrix/full_matrix_68.cc
tests/full_matrix/full_matrix_determinant_01.cc
tests/full_matrix/full_matrix_invert_01.cc
tests/fullydistributed_grids/copy_distributed_tria_01.cc
tests/fullydistributed_grids/copy_distributed_tria_02.cc
tests/fullydistributed_grids/copy_distributed_tria_03.cc
tests/fullydistributed_grids/copy_serial_tria_01.cc
tests/fullydistributed_grids/copy_serial_tria_02.cc
tests/fullydistributed_grids/copy_serial_tria_03.cc
tests/fullydistributed_grids/copy_serial_tria_04.cc
tests/fullydistributed_grids/copy_serial_tria_05.cc
tests/fullydistributed_grids/copy_serial_tria_06.cc
tests/fullydistributed_grids/copy_serial_tria_07.cc
tests/fullydistributed_grids/copy_serial_tria_08.cc
tests/fullydistributed_grids/copy_serial_tria_09.cc
tests/fullydistributed_grids/copy_serial_tria_grouped_01.cc
tests/fullydistributed_grids/tests.h
tests/ginkgo/solver.cc
tests/gla/block_mat_01.cc
tests/gla/block_mat_02.cc
tests/gla/block_mat_03.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/mat_03.cc
tests/gla/mat_04.cc
tests/gla/mat_05.cc
tests/gla/mat_06.cc
tests/gla/vec_00.cc
tests/gla/vec_01.cc
tests/gla/vec_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/gla/vec_all_zero_01.cc
tests/gmsh/create_tria_01.cc
tests/grid/accessor_01.cc
tests/grid/accessor_02.cc
tests/grid/build_global_description_tree.cc
tests/grid/cell_id_04.cc
tests/grid/cell_id_06.cc
tests/grid/coarsening_02.cc
tests/grid/coarsening_02_1d.cc
tests/grid/coarsening_03.cc
tests/grid/compute_point_locations_01.cc
tests/grid/compute_point_locations_02.cc
tests/grid/compute_point_locations_try_all_01.cc
tests/grid/concentric_hyper_shell_01.cc
tests/grid/concentric_hyper_shell_02.cc
tests/grid/distributed_compute_point_locations_01.cc
tests/grid/distributed_compute_point_locations_02.cc
tests/grid/distributed_compute_point_locations_03.cc
tests/grid/enclosing_sphere_01.cc
tests/grid/extrude_copy_manifold.cc
tests/grid/extrude_orientation_01.cc
tests/grid/extrude_orientation_02.cc
tests/grid/extrude_orientation_03.cc
tests/grid/face_orientations_3d.cc
tests/grid/filtered_iterator_06.cc
tests/grid/grid_generator_01.cc
tests/grid/grid_generator_01b.cc
tests/grid/grid_generator_10.cc
tests/grid/grid_generator_airfoil_01.cc
tests/grid/grid_generator_half_hyper_shell.cc
tests/grid/grid_generator_hyper_cube_slit_01.cc
tests/grid/grid_generator_hyper_sphere.cc
tests/grid/grid_generator_open_torus.cc
tests/grid/grid_generator_plate_with_a_hole.cc
tests/grid/grid_generator_plate_with_a_hole_2.cc
tests/grid/grid_generator_plate_with_a_hole_3.cc
tests/grid/grid_generator_plate_with_a_hole_4.cc
tests/grid/grid_hyper_shell.cc
tests/grid/grid_hyper_shell_05.cc
tests/grid/grid_hyper_shell_06.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_abaqus_02.cc
tests/grid/grid_in_gmsh_01.cc
tests/grid/grid_in_gmsh_01_v4.cc
tests/grid/grid_in_gmsh_01_v41.cc
tests/grid/grid_in_msh_version_4.cc
tests/grid/grid_in_ucd_01.cc
tests/grid/grid_in_ucd_02.cc
tests/grid/grid_in_vtk_3d_04.cc
tests/grid/grid_invert.cc
tests/grid/grid_out_08.cc
tests/grid/grid_out_09.cc
tests/grid/grid_out_in_vtk_01.cc
tests/grid/grid_out_svg_01.cc
tests/grid/grid_out_svg_02.cc
tests/grid/grid_out_svg_03.cc
tests/grid/grid_out_vtk_03.cc
tests/grid/grid_parallelepiped_04.cc
tests/grid/grid_tools_05.cc
tests/grid/grid_tools_06.cc
tests/grid/grid_tools_aspect_ratio.cc
tests/grid/grid_tools_cache_04.cc
tests/grid/grid_tools_cache_05.cc
tests/grid/grid_tools_compute_mesh_predicate_bounding_box_1.cc
tests/grid/grid_transform.cc
tests/grid/grid_transform_02.cc
tests/grid/grid_transform_03.cc
tests/grid/grid_transform_3d.cc
tests/grid/grid_transform_coefficient.cc
tests/grid/intergrid_constraints.cc
tests/grid/intergrid_map.cc
tests/grid/merge_triangulations_02.cc
tests/grid/merge_triangulations_03.cc
tests/grid/merge_triangulations_04.cc
tests/grid/merge_triangulations_07.cc
tests/grid/mesh_3d_1.cc
tests/grid/mesh_3d_10.cc
tests/grid/mesh_3d_11.cc
tests/grid/mesh_3d_12.cc
tests/grid/mesh_3d_13.cc
tests/grid/mesh_3d_14.cc
tests/grid/mesh_3d_15.cc
tests/grid/mesh_3d_16.cc
tests/grid/mesh_3d_17.cc
tests/grid/mesh_3d_2.cc
tests/grid/mesh_3d_20.cc
tests/grid/mesh_3d_21.cc
tests/grid/mesh_3d_22.cc
tests/grid/mesh_3d_25.cc
tests/grid/mesh_3d_26.cc
tests/grid/mesh_3d_3.cc
tests/grid/mesh_3d_4.cc
tests/grid/mesh_3d_5.cc
tests/grid/mesh_3d_6.cc
tests/grid/mesh_3d_7.cc
tests/grid/mesh_3d_8.cc
tests/grid/mesh_3d_9.cc
tests/grid/mesh_smoothing_02.cc
tests/grid/mesh_smoothing_03.cc
tests/grid/n_faces_01.cc
tests/grid/normal_vector_01.cc
tests/grid/normal_vector_01_2d.cc
tests/grid/normal_vector_02.cc
tests/grid/normal_vector_02_2d.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/oned_vertex_manifold.cc
tests/grid/partition_triangulation_zorder_01.cc
tests/grid/periodicity_01.cc
tests/grid/project_to_object_01.cc
tests/grid/refine_and_coarsen_fixed_fraction_02.cc
tests/grid/refine_and_coarsen_fixed_number.cc
tests/grid/refine_and_coarsen_fixed_number_02.cc
tests/grid/refine_boundary_domain.cc
tests/grid/subcelldata.cc
tests/grid/user_data_01.cc
tests/hp/accessor_0.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_10.cc
tests/hp/crash_14.cc
tests/hp/crash_17.cc
tests/hp/crash_18.cc
tests/hp/crash_21.cc
tests/hp/distribute_dofs_linear_time.cc
tests/hp/do_function_derivatives_01.cc
tests/hp/do_function_hessians_01.cc
tests/hp/do_function_laplacians_01.cc
tests/hp/dof_handler_number_cache.cc
tests/hp/dof_renumbering_04.cc
tests/hp/dof_renumbering_05.cc
tests/hp/dof_renumbering_06.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_11.cc
tests/hp/fe_nothing_15.cc
tests/hp/fe_nothing_16.cc
tests/hp/fe_nothing_18.cc
tests/hp/fe_nothing_20.cc
tests/hp/fe_nothing_21.cc
tests/hp/hp_constraints_neither_dominate_01.cc
tests/hp/hp_constraints_neither_dominate_02.cc
tests/hp/hp_hanging_nodes_01.cc
tests/hp/hp_q_hierarchical_constraints.cc
tests/hp/interpolate_nothing_03.cc
tests/hp/n_active_fe_indices.cc
tests/hp/n_boundary_dofs_01.cc
tests/hp/p_adaptivity_absolute_threshold.cc
tests/hp/p_adaptivity_fixed_number.cc
tests/hp/p_adaptivity_flags.cc
tests/hp/p_adaptivity_full.cc
tests/hp/p_adaptivity_reference.cc
tests/hp/p_adaptivity_regularity.cc
tests/hp/p_adaptivity_relative_threshold.cc
tests/hp/project_01.cc
tests/hp/project_01_curved_boundary.cc
tests/hp/project_02.cc
tests/hp/q_vs_dgq.cc
tests/hp/renumber_block_wise_02.cc
tests/hp/renumber_component_wise.cc
tests/hp/solution_transfer_04.cc
tests/hp/solution_transfer_05.cc
tests/hp/solution_transfer_06.cc
tests/hp/solution_transfer_07.cc
tests/hp/solution_transfer_08.cc
tests/hp/solution_transfer_09.cc
tests/hp/solution_transfer_10.cc
tests/hp/solution_transfer_13.cc
tests/hp/solution_transfer_15.cc
tests/hp/solution_transfer_16.cc
tests/hp/step-10.cc
tests/hp/step-12.cc
tests/hp/step-13.cc
tests/hp/step-2.cc
tests/hp/step-27.cc
tests/hp/step-7.cc
tests/integrators/advection_01.cc
tests/integrators/assembler_simple_matrix_01.cc
tests/integrators/assembler_simple_matrix_01m.cc
tests/integrators/assembler_simple_matrix_02.cc
tests/integrators/assembler_simple_matrix_02m.cc
tests/integrators/assembler_simple_matrix_03.cc
tests/integrators/assembler_simple_matrix_03m.cc
tests/integrators/assembler_simple_matrix_03tri.cc
tests/integrators/assembler_simple_matrix_04.cc
tests/integrators/assembler_simple_mgmatrix_01.cc
tests/integrators/assembler_simple_mgmatrix_02.cc
tests/integrators/assembler_simple_mgmatrix_03.cc
tests/integrators/assembler_simple_mgmatrix_04.cc
tests/integrators/assembler_simple_system_inhom_01.cc
tests/integrators/cells_and_faces_01.cc
tests/integrators/cochain_01.cc
tests/integrators/divergence_01.cc
tests/integrators/elasticity_01.cc
tests/integrators/elasticity_02.cc
tests/integrators/functional_01.cc
tests/integrators/grad_div_01.cc
tests/integrators/laplacian_01.cc
tests/integrators/laplacian_02.cc
tests/integrators/maxwell_curl.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/bicgstab_early.cc
tests/lac/bicgstab_large.cc
tests/lac/block_linear_operator_01.cc
tests/lac/block_linear_operator_02.cc
tests/lac/block_linear_operator_03.cc
tests/lac/block_linear_operator_04.cc
tests/lac/block_linear_operator_05.cc
tests/lac/block_linear_operator_06.cc
tests/lac/block_matrices_04.cc
tests/lac/block_minres.cc
tests/lac/block_vector_iterator.cc
tests/lac/block_vector_move_operations.cc
tests/lac/block_vector_vector_assign.cc
tests/lac/complex_block_vector_iterator.cc
tests/lac/complex_block_vector_vector_assign.cc
tests/lac/constrained_linear_operator_01.cc
tests/lac/constraint_graph_zero.cc
tests/lac/constraint_matrix_copy_01.cc
tests/lac/constraint_matrix_distribute_complex.cc
tests/lac/constraint_matrix_distribute_local_global.cc
tests/lac/constraints_01.cc
tests/lac/constraints_02.cc
tests/lac/constraints_block_01.cc
tests/lac/constraints_c1.cc
tests/lac/constraints_c1_02.cc
tests/lac/constraints_inhomogeneous.cc
tests/lac/constraints_move.cc
tests/lac/constraints_shift_01.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/diagonal_matrix_02.cc
tests/lac/eigen.cc
tests/lac/gmres_eigenvalues.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.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/inhomogeneous_constraints_vector.cc
tests/lac/la_parallel_vector_add_and_dot_complex.cc
tests/lac/la_vector_add_and_dot.cc
tests/lac/la_vector_add_and_dot_complex.cc
tests/lac/linear_operator_01.cc
tests/lac/linear_operator_01a.cc
tests/lac/linear_operator_01b.cc
tests/lac/linear_operator_01c.cc
tests/lac/linear_operator_01d.cc
tests/lac/linear_operator_02.cc
tests/lac/linear_operator_02a.cc
tests/lac/linear_operator_03.cc
tests/lac/linear_operator_04.cc
tests/lac/linear_operator_04a.cc
tests/lac/linear_operator_05.cc
tests/lac/linear_operator_06.cc
tests/lac/linear_operator_07.cc
tests/lac/linear_operator_08.cc
tests/lac/linear_operator_09.cc
tests/lac/linear_operator_10.cc
tests/lac/linear_operator_10a.cc
tests/lac/linear_operator_12.cc
tests/lac/linear_operator_12a.cc
tests/lac/linear_operator_13.cc
tests/lac/linear_operator_14.cc
tests/lac/linear_operator_15.cc
tests/lac/linear_operator_16.cc
tests/lac/linear_operator_17.cc
tests/lac/linear_operator_17a.cc
tests/lac/linear_operator_18.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/packaged_operation_01.cc
tests/lac/packaged_operation_01a.cc
tests/lac/packaged_operation_02.cc
tests/lac/precondition_chebyshev_02.cc
tests/lac/precondition_chebyshev_03.cc
tests/lac/precondition_chebyshev_04.cc
tests/lac/precondition_chebyshev_05.cc
tests/lac/print_formatted_ez_01.cc
tests/lac/schur_complement_01.cc
tests/lac/schur_complement_02.cc
tests/lac/schur_complement_03.cc
tests/lac/schur_complement_04.cc
tests/lac/solver.cc
tests/lac/solver_02.cc
tests/lac/solver_control_01.cc
tests/lac/solver_control_02.cc
tests/lac/solver_control_03.cc
tests/lac/solver_control_04.cc
tests/lac/solver_control_05.cc
tests/lac/solver_control_06.cc
tests/lac/solver_fire_01.cc
tests/lac/solver_fire_rosenbrock_01.cc
tests/lac/solver_memorytest.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_relaxation_04.cc
tests/lac/solver_selector_01.cc
tests/lac/solver_selector_02.cc
tests/lac/solver_selector_03.cc
tests/lac/solver_signals.cc
tests/lac/sparse_ilu.cc
tests/lac/sparse_ilu_inverse.cc
tests/lac/sparse_ilu_t.cc
tests/lac/sparse_matrices.cc
tests/lac/sparse_matrix_move.cc
tests/lac/sparse_mic.cc
tests/lac/tensor_product_matrix_01.cc
tests/lac/tensor_product_matrix_02.cc
tests/lac/tensor_product_matrix_03.cc
tests/lac/tensor_product_matrix_04.cc
tests/lac/tensor_product_matrix_05.cc
tests/lac/tensor_product_matrix_06.cc
tests/lac/tensor_product_matrix_vectorized_01.cc
tests/lac/tensor_product_matrix_vectorized_02.cc
tests/lac/tensor_product_matrix_vectorized_03.cc
tests/lac/tensor_product_matrix_vectorized_04.cc
tests/lac/utilities_01.cc
tests/lac/utilities_02.cc
tests/lac/utilities_03.cc
tests/lac/utilities_04.cc
tests/lac/utilities_05.cc
tests/lac/vector-vector.cc
tests/lac/vector_accumulation_02.cc
tests/lac/vector_add_and_dot.cc
tests/lac/vector_add_and_dot_complex.cc
tests/lac/vector_memory.cc
tests/lac/vector_move_operations.cc
tests/lapack/full_matrix_02.cc
tests/lapack/full_matrix_12.cc
tests/lapack/full_matrix_14.cc
tests/lapack/full_matrix_15.cc
tests/lapack/full_matrix_16.cc
tests/lapack/full_matrix_17.cc
tests/lapack/full_matrix_18.cc
tests/lapack/full_matrix_19.cc
tests/lapack/full_matrix_20.cc
tests/lapack/full_matrix_21.cc
tests/lapack/full_matrix_22.cc
tests/lapack/full_matrix_23.cc
tests/lapack/full_matrix_24.cc
tests/lapack/full_matrix_25.cc
tests/lapack/full_matrix_27.cc
tests/lapack/full_matrix_28.cc
tests/lapack/full_matrix_29.cc
tests/lapack/full_matrix_31.cc
tests/lapack/full_matrix_32.cc
tests/lapack/full_matrix_33.cc
tests/lapack/full_matrix_34.cc
tests/lapack/full_matrix_36.cc
tests/lapack/solver_cg.cc
tests/manifold/chart_manifold_02.cc
tests/manifold/chart_manifold_02_embedded.cc
tests/manifold/copy_boundary_to_manifold_id_01.cc
tests/manifold/copy_material_to_manifold_id_01.cc
tests/manifold/elliptical_manifold_02.cc
tests/manifold/flat_manifold_02.cc
tests/manifold/flat_manifold_08.cc
tests/manifold/flat_manifold_09.cc
tests/manifold/manifold_id_01.cc
tests/manifold/manifold_id_02.cc
tests/manifold/manifold_id_03.cc
tests/manifold/manifold_id_04.cc
tests/manifold/manifold_id_05.cc
tests/manifold/manifold_id_06.cc
tests/manifold/manifold_id_07.cc
tests/manifold/map_boundary_to_manifold_id_01.cc
tests/manifold/map_boundary_to_manifold_id_02.cc
tests/manifold/set_all_manifold_ids_01.cc
tests/manifold/set_all_manifold_ids_02.cc
tests/manifold/spherical_manifold_02.cc
tests/manifold/spherical_manifold_04.cc
tests/manifold/spherical_manifold_07.cc
tests/manifold/spherical_manifold_08.cc
tests/manifold/spherical_manifold_09.cc
tests/manifold/spherical_manifold_10.cc
tests/manifold/spherical_manifold_12.cc
tests/manifold/transfinite_manifold_01.cc
tests/manifold/transfinite_manifold_02.cc
tests/manifold/transfinite_manifold_03.cc
tests/manifold/transfinite_manifold_04.cc
tests/manifold/transfinite_manifold_05.cc
tests/manifold/transfinite_manifold_06.cc
tests/manifold/transfinite_manifold_07.cc
tests/manifold/transfinite_manifold_08.cc
tests/manifold/transfinite_manifold_09.cc
tests/manifold/transfinite_manifold_10.cc
tests/manifold/tria_accessor_point_01.cc
tests/manifold/tria_accessor_point_02.cc
tests/manifold/tria_boundary_id_01.cc
tests/mappings/fe_face_values_1d_mapping_cartesian.cc
tests/mappings/fe_face_values_1d_mapping_q2.cc
tests/mappings/mapping.cc
tests/mappings/mapping_c1.cc
tests/mappings/mapping_fe_field_01.cc
tests/mappings/mapping_fe_field_02.cc
tests/mappings/mapping_fe_field_03.cc
tests/mappings/mapping_fe_field_04.cc
tests/mappings/mapping_fe_field_05.cc
tests/mappings/mapping_fe_field_06.cc
tests/mappings/mapping_fe_field_08.cc
tests/mappings/mapping_fe_field_contravariant_01.cc
tests/mappings/mapping_fe_field_real_to_unit_b1.cc
tests/mappings/mapping_fe_field_real_to_unit_b2_curved.cc
tests/mappings/mapping_fe_field_real_to_unit_b2_mask.cc
tests/mappings/mapping_fe_field_real_to_unit_b3_curved.cc
tests/mappings/mapping_fe_field_real_to_unit_b4_curved.cc
tests/mappings/mapping_fe_field_real_to_unit_b5_curved.cc
tests/mappings/mapping_fe_field_real_to_unit_q1.cc
tests/mappings/mapping_fe_field_real_to_unit_q2_curved.cc
tests/mappings/mapping_fe_field_real_to_unit_q2_mask.cc
tests/mappings/mapping_fe_field_real_to_unit_q3_curved.cc
tests/mappings/mapping_fe_field_real_to_unit_q4_curved.cc
tests/mappings/mapping_fe_field_real_to_unit_q5_curved.cc
tests/mappings/mapping_manifold_05.cc
tests/mappings/mapping_manifold_06.cc
tests/mappings/mapping_manifold_07.cc
tests/mappings/mapping_project_01.cc
tests/mappings/mapping_q1_cartesian_grid.cc
tests/mappings/mapping_q1_eulerian_01.cc
tests/mappings/mapping_q_convergence.cc
tests/mappings/mapping_q_eulerian_01.cc
tests/mappings/mapping_q_eulerian_02.cc
tests/mappings/mapping_q_eulerian_03.cc
tests/mappings/mapping_q_eulerian_07.cc
tests/mappings/mapping_q_eulerian_08.cc
tests/mappings/mapping_q_eulerian_09.cc
tests/mappings/mapping_q_eulerian_10.cc
tests/mappings/mapping_q_eulerian_11.cc
tests/mappings/mapping_q_eulerian_12.cc
tests/mappings/mapping_q_eulerian_13.cc
tests/mappings/mapping_q_generic_cell_cache.cc
tests/mappings/mapping_q_manifold_01.cc
tests/mappings/mapping_q_manifold_02.cc
tests/mappings/mapping_q_mixed_manifolds_02.cc
tests/matrix_free/additional_data_copy.cc
tests/matrix_free/advect_1d.cc
tests/matrix_free/advect_1d_system.cc
tests/matrix_free/advect_1d_vectorization_mask.cc
tests/matrix_free/assemble_matrix_01.cc
tests/matrix_free/assemble_matrix_02.cc
tests/matrix_free/assemble_matrix_03.cc
tests/matrix_free/cell_categorization.cc
tests/matrix_free/cell_categorization_02.cc
tests/matrix_free/cell_level_and_index.cc
tests/matrix_free/compare_faces_by_cells.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/dg_pbc_01.cc
tests/matrix_free/dg_pbc_02.cc
tests/matrix_free/dof_info_01.cc
tests/matrix_free/dof_info_02.cc
tests/matrix_free/estimate_condition_number_mass.cc
tests/matrix_free/evaluate_1d_shape_07.cc
tests/matrix_free/evaluate_1d_shape_08.cc
tests/matrix_free/evaluate_1d_shape_09.cc
tests/matrix_free/face_setup_01.cc
tests/matrix_free/faces_value_optimization.cc
tests/matrix_free/faces_value_optimization_02.cc
tests/matrix_free/get_functions_cartesian.cc
tests/matrix_free/get_functions_circle.cc
tests/matrix_free/get_functions_common.h
tests/matrix_free/get_functions_constraints.cc
tests/matrix_free/get_functions_faces.cc
tests/matrix_free/get_functions_float.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_notempl.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_functions_variants_gl.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/interpolate_constant.cc
tests/matrix_free/interpolate_cubic.cc
tests/matrix_free/interpolate_functions_common.h
tests/matrix_free/interpolate_linear.cc
tests/matrix_free/interpolate_quadratic.cc
tests/matrix_free/interpolate_to_mg.cc
tests/matrix_free/inverse_mass_01.cc
tests/matrix_free/inverse_mass_03.cc
tests/matrix_free/inverse_mass_05.cc
tests/matrix_free/iterators.cc
tests/matrix_free/jxw_values.cc
tests/matrix_free/laplace_operator_01.cc
tests/matrix_free/laplace_operator_02.cc
tests/matrix_free/mass_operator_01.cc
tests/matrix_free/mass_operator_02.cc
tests/matrix_free/mass_operator_03.cc
tests/matrix_free/matrix_vector_01.cc
tests/matrix_free/matrix_vector_02.cc
tests/matrix_free/matrix_vector_03.cc
tests/matrix_free/matrix_vector_04.cc
tests/matrix_free/matrix_vector_04b.cc
tests/matrix_free/matrix_vector_05.cc
tests/matrix_free/matrix_vector_06.cc
tests/matrix_free/matrix_vector_06_notempl.cc
tests/matrix_free/matrix_vector_07.cc
tests/matrix_free/matrix_vector_08.cc
tests/matrix_free/matrix_vector_09.cc
tests/matrix_free/matrix_vector_10.cc
tests/matrix_free/matrix_vector_11.cc
tests/matrix_free/matrix_vector_12.cc
tests/matrix_free/matrix_vector_13.cc
tests/matrix_free/matrix_vector_14.cc
tests/matrix_free/matrix_vector_14_notempl.cc
tests/matrix_free/matrix_vector_14b.cc
tests/matrix_free/matrix_vector_15.cc
tests/matrix_free/matrix_vector_16.cc
tests/matrix_free/matrix_vector_17.cc
tests/matrix_free/matrix_vector_19.cc
tests/matrix_free/matrix_vector_20.cc
tests/matrix_free/matrix_vector_21.cc
tests/matrix_free/matrix_vector_22.cc
tests/matrix_free/matrix_vector_23.cc
tests/matrix_free/matrix_vector_24.cc
tests/matrix_free/matrix_vector_blocks.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_faces_01.cc
tests/matrix_free/matrix_vector_faces_02.cc
tests/matrix_free/matrix_vector_faces_03.cc
tests/matrix_free/matrix_vector_faces_04.cc
tests/matrix_free/matrix_vector_faces_05.cc
tests/matrix_free/matrix_vector_faces_06.cc
tests/matrix_free/matrix_vector_faces_07.cc
tests/matrix_free/matrix_vector_faces_08.cc
tests/matrix_free/matrix_vector_faces_09.cc
tests/matrix_free/matrix_vector_faces_10.cc
tests/matrix_free/matrix_vector_faces_11.cc
tests/matrix_free/matrix_vector_faces_12.cc
tests/matrix_free/matrix_vector_faces_13.cc
tests/matrix_free/matrix_vector_faces_14.cc
tests/matrix_free/matrix_vector_faces_15.cc
tests/matrix_free/matrix_vector_faces_16.cc
tests/matrix_free/matrix_vector_faces_17.cc
tests/matrix_free/matrix_vector_faces_18.cc
tests/matrix_free/matrix_vector_faces_19.cc
tests/matrix_free/matrix_vector_faces_20.cc
tests/matrix_free/matrix_vector_faces_21.cc
tests/matrix_free/matrix_vector_faces_22.cc
tests/matrix_free/matrix_vector_faces_23.cc
tests/matrix_free/matrix_vector_faces_24.cc
tests/matrix_free/matrix_vector_faces_25.cc
tests/matrix_free/matrix_vector_faces_26.cc
tests/matrix_free/matrix_vector_faces_28.cc
tests/matrix_free/matrix_vector_faces_common.h
tests/matrix_free/matrix_vector_float.cc
tests/matrix_free/matrix_vector_hp.cc
tests/matrix_free/matrix_vector_large_degree_01.cc
tests/matrix_free/matrix_vector_large_degree_02.cc
tests/matrix_free/matrix_vector_large_degree_03.cc
tests/matrix_free/matrix_vector_mg.cc
tests/matrix_free/matrix_vector_stokes.cc
tests/matrix_free/matrix_vector_stokes_base.cc
tests/matrix_free/matrix_vector_stokes_flux.cc
tests/matrix_free/matrix_vector_stokes_noflux.cc
tests/matrix_free/matrix_vector_stokes_notempl.cc
tests/matrix_free/matrix_vector_stokes_onedof.cc
tests/matrix_free/matrix_vector_stokes_qdg0.cc
tests/matrix_free/matrix_vector_stokes_qdg0b.cc
tests/matrix_free/multigrid_dg_periodic.cc
tests/matrix_free/multigrid_dg_sip_01.cc
tests/matrix_free/multigrid_dg_sip_02.cc
tests/matrix_free/no_index_initialize.cc
tests/matrix_free/parallel_multigrid.cc
tests/matrix_free/parallel_multigrid_02.cc
tests/matrix_free/parallel_multigrid_adaptive_01.cc
tests/matrix_free/parallel_multigrid_adaptive_02.cc
tests/matrix_free/parallel_multigrid_adaptive_03.cc
tests/matrix_free/parallel_multigrid_adaptive_04.cc
tests/matrix_free/parallel_multigrid_adaptive_05.cc
tests/matrix_free/parallel_multigrid_adaptive_06.cc
tests/matrix_free/parallel_multigrid_adaptive_06ref.cc
tests/matrix_free/parallel_multigrid_adaptive_07.cc
tests/matrix_free/parallel_multigrid_adaptive_08.cc
tests/matrix_free/parallel_multigrid_fullydistributed.cc
tests/matrix_free/parallel_multigrid_mf.cc
tests/matrix_free/parallel_multigrid_mf_02.cc
tests/matrix_free/partitioner_01.cc
tests/matrix_free/pre_and_post_loops_01.cc
tests/matrix_free/pre_and_post_loops_02.cc
tests/matrix_free/pre_and_post_loops_03.cc
tests/matrix_free/pre_and_post_loops_04.cc
tests/matrix_free/pre_and_post_loops_05.cc
tests/matrix_free/quadrature_points.cc
tests/matrix_free/read_cell_data_01.cc
tests/matrix_free/read_cell_data_02.cc
tests/matrix_free/shape_info.cc
tests/matrix_free/shape_info_inverse.cc
tests/matrix_free/step-37-inhomogeneous-1.cc
tests/matrix_free/step-37.cc
tests/matrix_free/step-48.cc
tests/matrix_free/step-48b.cc
tests/matrix_free/step-48c.cc
tests/matrix_free/stokes_computation.cc
tests/matrix_free/thread_correctness.cc
tests/matrix_free/thread_correctness_dg.cc
tests/matrix_free/thread_correctness_hp.cc
tests/matrix_free/update_mapping_only.cc
tests/meshworker/codim_01.cc
tests/meshworker/mesh_loop_04.cc
tests/meshworker/mesh_loop_05.cc
tests/meshworker/mesh_loop_06.cc
tests/meshworker/mesh_loop_gmg_01.cc
tests/meshworker/scratch_data_01.cc
tests/meshworker/scratch_data_02.cc
tests/meshworker/scratch_data_03.cc
tests/meshworker/scratch_data_05.cc
tests/meshworker/scratch_data_06.cc
tests/meshworker/scratch_data_07.cc
tests/meshworker/step-11-mesh_loop.cc
tests/meshworker/step-50-mesh_loop.cc
tests/mpi/blockvec_02.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/collective_sparse_matrix_01.cc
tests/mpi/communicate_moved_vertices_03.cc
tests/mpi/compute_index_owner_01.cc
tests/mpi/constraints_consistent_01.cc
tests/mpi/count_dofs_per_block_01.cc
tests/mpi/count_dofs_per_block_02.cc
tests/mpi/count_dofs_per_component_01.cc
tests/mpi/cuthill_mckee_01.cc
tests/mpi/data_out_faces_01.cc
tests/mpi/data_out_hdf5_02.cc
tests/mpi/distort_random_01.cc
tests/mpi/distort_random_02.cc
tests/mpi/distribute_flux_sparsity_pattern.cc
tests/mpi/distribute_sp_01.cc
tests/mpi/distribute_sp_02.cc
tests/mpi/dof_handler_number_cache.cc
tests/mpi/fe_field_function_02.cc
tests/mpi/flux_edge_01.cc
tests/mpi/has_hanging_nodes.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_hanging_node_constraints_01.cc
tests/mpi/hp_step-4.cc
tests/mpi/hp_step-40.cc
tests/mpi/hp_step-40_variable_01.cc
tests/mpi/hp_unify_dof_indices_07.cc
tests/mpi/interpolate_to_different_mesh_01.cc
tests/mpi/interpolate_to_different_mesh_02.cc
tests/mpi/mesh_worker_01.cc
tests/mpi/mesh_worker_02.cc
tests/mpi/mesh_worker_03.cc
tests/mpi/mesh_worker_04.cc
tests/mpi/mesh_worker_05.cc
tests/mpi/mesh_worker_matrix_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/mg_ghost_dofs_periodic_01.cc
tests/mpi/mg_ghost_dofs_periodic_02.cc
tests/mpi/mg_ghost_dofs_periodic_03.cc
tests/mpi/mg_ghost_dofs_periodic_04.cc
tests/mpi/mg_ghost_dofs_periodic_05.cc
tests/mpi/mg_ghost_dofs_periodic_06.cc
tests/mpi/mg_ghost_dofs_periodic_07.cc
tests/mpi/muelu_periodicity.cc
tests/mpi/multigrid_adaptive.cc
tests/mpi/multigrid_uniform.cc
tests/mpi/p4est_2d_constraintmatrix_04.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_ghost_01.cc
tests/mpi/p4est_2d_ghost_02.cc
tests/mpi/p4est_2d_renumber_02.cc
tests/mpi/p4est_3d_constraintmatrix_03.cc
tests/mpi/p4est_3d_ghost_01.cc
tests/mpi/p4est_data_out_01.cc
tests/mpi/p4est_get_subdomain_association.cc
tests/mpi/p4est_save_03.cc
tests/mpi/parallel_partitioner_08.cc
tests/mpi/parallel_partitioner_09.cc
tests/mpi/parallel_vector_03a.cc
tests/mpi/parallel_vector_09.cc
tests/mpi/parallel_vector_11.cc
tests/mpi/parallel_vector_16.cc
tests/mpi/parallel_vector_24.cc
tests/mpi/parallel_vector_back_interpolate_02.cc
tests/mpi/parallel_vector_interpolate.cc
tests/mpi/periodic_neighbor_01.cc
tests/mpi/periodicity_01.cc
tests/mpi/periodicity_02.cc
tests/mpi/periodicity_03.cc
tests/mpi/periodicity_04.cc
tests/mpi/periodicity_05.cc
tests/mpi/periodicity_06.cc
tests/mpi/periodicity_07.cc
tests/mpi/petsc_step-27.cc
tests/mpi/project_bv_div_conf.cc
tests/mpi/refine_and_coarsen_fixed_fraction_01.cc
tests/mpi/refine_and_coarsen_fixed_fraction_02.cc
tests/mpi/refine_and_coarsen_fixed_fraction_03.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_07.cc
tests/mpi/renumber_cuthill_mckee.cc
tests/mpi/renumber_cuthill_mckee_02.cc
tests/mpi/renumber_cuthill_mckee_03.cc
tests/mpi/renumber_z_order_01.cc
tests/mpi/renumber_z_order_02.cc
tests/mpi/solution_transfer_03.cc
tests/mpi/solution_transfer_05.cc
tests/mpi/step-39-block.cc
tests/mpi/step-39.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/torus.cc
tests/mpi/tria_copy_triangulation.cc
tests/mpi/tria_ghost_owners_01.cc
tests/mpi/tria_ghost_owners_02.cc
tests/mpi/trilinos_step-27.cc
tests/multigrid/boundary_01.cc
tests/multigrid/constrained_dofs_01.cc
tests/multigrid/constrained_dofs_02.cc
tests/multigrid/constrained_dofs_03.cc
tests/multigrid/constrained_dofs_05.cc
tests/multigrid/count_01.cc
tests/multigrid/cycles.cc
tests/multigrid/distribute_bug_01.cc
tests/multigrid/dof_01.cc
tests/multigrid/dof_02.cc
tests/multigrid/dof_03.cc
tests/multigrid/dof_04.cc
tests/multigrid/dof_05.cc
tests/multigrid/events_01.cc
tests/multigrid/interface_matrix_entry_01.cc
tests/multigrid/max_level_for_coarse_mesh.cc
tests/multigrid/mg_coarse_01.cc
tests/multigrid/mg_data_out_01.cc
tests/multigrid/mg_data_out_02.cc
tests/multigrid/mg_data_out_03.cc
tests/multigrid/mg_data_out_04.cc
tests/multigrid/mg_data_out_05.cc
tests/multigrid/mg_output_dirichlet.cc
tests/multigrid/mg_output_neumann.cc
tests/multigrid/mg_renumbered_01.cc
tests/multigrid/mg_renumbered_02.cc
tests/multigrid/mg_renumbered_03.cc
tests/multigrid/renumbering_01.cc
tests/multigrid/renumbering_02.cc
tests/multigrid/renumbering_03.cc
tests/multigrid/renumbering_04.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-50-mpi-linear-operator.cc
tests/multigrid/step-16-50-mpi-smoother.cc
tests/multigrid/step-16-50-mpi.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/multigrid/step-50_01.cc
tests/multigrid/step-50_02.cc
tests/multigrid/transfer_01.cc
tests/multigrid/transfer_02.cc
tests/multigrid/transfer_03.cc
tests/multigrid/transfer_04.cc
tests/multigrid/transfer_04a.cc
tests/multigrid/transfer_04b.cc
tests/multigrid/transfer_06.cc
tests/multigrid/transfer_block.cc
tests/multigrid/transfer_block_select.cc
tests/multigrid/transfer_compare_01.cc
tests/multigrid/transfer_matrix_free_01.cc
tests/multigrid/transfer_matrix_free_02.cc
tests/multigrid/transfer_matrix_free_02_block.cc
tests/multigrid/transfer_matrix_free_02_block_02.cc
tests/multigrid/transfer_matrix_free_03.cc
tests/multigrid/transfer_matrix_free_04.cc
tests/multigrid/transfer_matrix_free_05.cc
tests/multigrid/transfer_matrix_free_06.cc
tests/multigrid/transfer_matrix_free_07.cc
tests/multigrid/transfer_matrix_free_08.cc
tests/multigrid/transfer_matrix_free_09.cc
tests/multigrid/transfer_matrix_free_10.cc
tests/multigrid/transfer_matrix_free_11.cc
tests/multigrid/transfer_matrix_free_12.cc
tests/multigrid/transfer_matrix_free_13.cc
tests/multigrid/transfer_prebuilt_01.cc
tests/multigrid/transfer_prebuilt_02.cc
tests/multigrid/transfer_prebuilt_03.cc
tests/multigrid/transfer_prebuilt_04.cc
tests/multigrid/transfer_select.cc
tests/multigrid/transfer_system_01.cc
tests/multigrid/transfer_system_02.cc
tests/multigrid/transfer_system_03.cc
tests/multigrid/transfer_system_04.cc
tests/multigrid/transfer_system_05.cc
tests/multigrid/transfer_system_adaptive_01.cc
tests/multigrid/transfer_system_adaptive_02.cc
tests/multigrid/transfer_system_adaptive_03.cc
tests/multigrid/transfer_system_adaptive_04.cc
tests/multigrid/transfer_system_adaptive_05.cc
tests/multigrid/transfer_system_adaptive_06.cc
tests/multigrid/transfer_system_adaptive_07.cc
tests/multigrid/transfer_system_adaptive_08.cc
tests/multigrid/transfer_system_adaptive_09.cc
tests/multigrid/workload_imbalance.cc
tests/non_matching/coupling_01.cc
tests/non_matching/coupling_02.cc
tests/non_matching/coupling_03.cc
tests/non_matching/coupling_04.cc
tests/non_matching/coupling_05.cc
tests/non_matching/coupling_06.cc
tests/non_matching/coupling_07.cc
tests/non_matching/coupling_08.cc
tests/non_matching/immersed_surface_quadrature.cc
tests/numerics/assemble_matrix_parallel_01.cc
tests/numerics/assemble_matrix_parallel_02.cc
tests/numerics/assemble_matrix_parallel_03.cc
tests/numerics/assemble_matrix_parallel_04.cc
tests/numerics/error_estimator_02.cc
tests/numerics/error_estimator_02_complex.cc
tests/numerics/generalized_interpolation_02.cc
tests/numerics/generalized_interpolation_03.cc
tests/numerics/generalized_interpolation_04.cc
tests/numerics/generalized_interpolation_05.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/kelly_crash_02.cc
tests/numerics/nedelec_projection_mixed_01.cc
tests/numerics/no_flux_01.cc
tests/numerics/no_flux_02.cc
tests/numerics/no_flux_05.cc
tests/numerics/no_flux_08.cc
tests/numerics/no_flux_09.cc
tests/numerics/no_flux_10.cc
tests/numerics/no_flux_11.cc
tests/numerics/no_flux_12.cc
tests/numerics/no_flux_13.cc
tests/numerics/no_flux_14.cc
tests/numerics/no_flux_15.cc
tests/numerics/no_flux_hp_01.cc
tests/numerics/no_flux_hp_02.cc
tests/numerics/no_flux_hp_05.cc
tests/numerics/normal_flux_01.cc
tests/numerics/normal_flux_02.cc
tests/numerics/normal_flux_hp_01.cc
tests/numerics/normal_flux_inhom_01.cc
tests/numerics/point_value_history_01.cc
tests/numerics/point_value_history_02.cc
tests/numerics/point_value_history_03.cc
tests/numerics/project_01.cc
tests/numerics/project_01_curved_boundary.cc
tests/numerics/project_02.cc
tests/numerics/project_03.cc
tests/numerics/project_bv_curl_conf_03.cc
tests/numerics/project_bv_curl_conf_04.cc
tests/numerics/project_bv_curl_conf_complex.cc
tests/numerics/project_bv_div_conf_03.cc
tests/numerics/project_common.h
tests/numerics/project_parallel_qp_common.h
tests/numerics/project_parallel_qp_q_01.cc
tests/numerics/project_parallel_qp_q_02.cc
tests/numerics/project_parallel_qpmf_common.h
tests/numerics/project_parallel_qpmf_q_01.cc
tests/numerics/project_parallel_qpmf_q_02.cc
tests/numerics/project_parallel_qpmf_q_03.cc
tests/numerics/tangential_flux_inhom_01.cc
tests/opencascade/circle_normal_projection.cc
tests/opencascade/iges_describe.cc
tests/opencascade/iges_describe_02.cc
tests/opencascade/interpolation_curve_boundary.cc
tests/opencascade/step_describe.cc
tests/opencascade/step_describe_02.cc
tests/opencascade/stl_creation_single_patch.cc
tests/opencascade/stl_creation_watertight.cc
tests/opencascade/stl_refinement.cc
tests/opencascade/stl_write.cc
tests/optimization/bfgs_03.cc
tests/optimization/bfgs_04.cc
tests/optimization/bfgs_05.cc
tests/optimization/bfgs_05b.cc
tests/optimization/cubic_fit.cc
tests/optimization/cubic_fit_three_points.cc
tests/optimization/line_minimization.cc
tests/optimization/line_minimization_02.cc
tests/optimization/line_minimization_03.cc
tests/optimization/line_minimization_03b.cc
tests/optimization/quadratic_fit.cc
tests/optimization/step-44-with_line_search.cc
tests/optimization/step-44-with_line_search_ptrb.cc
tests/optimization/step-44-without_line_search.cc
tests/optimization/step-44.h
tests/parameter_handler/parameter_handler_25.cc
tests/parameter_handler/parameter_handler_26.cc
tests/parameter_handler/parameter_handler_3_with_sorting_01.cc
tests/parameter_handler/parameter_handler_dos_endings.cc
tests/parameter_handler/parameter_handler_read_json.cc
tests/parameter_handler/parameter_handler_read_xml_error_02.cc
tests/parameter_handler/parameter_handler_read_xml_error_04.cc
tests/parameter_handler/parameter_handler_subsection_exists.cc
tests/parameter_handler/parameter_handler_write_json.cc
tests/parameter_handler/parameter_handler_write_xml.cc
tests/parameter_handler/pattern_tools_01.cc
tests/parameter_handler/pattern_tools_02.cc
tests/parameter_handler/pattern_tools_03.cc
tests/parameter_handler/pattern_tools_04.cc
tests/parameter_handler/pattern_tools_05.cc
tests/parameter_handler/pattern_tools_06.cc
tests/parameter_handler/pattern_tools_07.cc
tests/parameter_handler/patterns_05.cc
tests/parameter_handler/patterns_06.cc
tests/parameter_handler/patterns_07.cc
tests/particles/data_out_01.cc
tests/particles/extract_index_set_01.cc
tests/particles/generators_01.cc
tests/particles/generators_02.cc
tests/particles/generators_03.cc
tests/particles/generators_04.cc
tests/particles/generators_05.cc
tests/particles/generators_06.cc
tests/particles/generators_07.cc
tests/particles/generators_08.cc
tests/particles/generators_09.cc
tests/particles/generators_10.cc
tests/particles/generators_11.cc
tests/particles/generators_12.cc
tests/particles/particle_01.cc
tests/particles/particle_handler_01.cc
tests/particles/particle_handler_02.cc
tests/particles/particle_handler_03.cc
tests/particles/particle_handler_04.cc
tests/particles/particle_handler_05.cc
tests/particles/particle_handler_serial_01.cc
tests/particles/particle_handler_serial_02.cc
tests/particles/particle_handler_serial_03.cc
tests/particles/particle_handler_serial_07.cc
tests/particles/particle_interpolation_01.cc
tests/particles/particle_interpolation_02.cc
tests/particles/particle_interpolation_03.cc
tests/particles/particle_interpolation_04.cc
tests/particles/particle_interpolation_05.cc
tests/particles/set_particle_positions_01.cc
tests/particles/set_particle_positions_02.cc
tests/particles/set_particle_positions_03.cc
tests/petsc/copy_parallel_vector.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/matrix_base_iterator_01.cc
tests/petsc/preconditioner_tvmult_01.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/update_ghosts.cc
tests/petsc/vector_print.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/physics/elasticity-kinematics_01.cc
tests/physics/elasticity-kinematics_02.cc
tests/physics/elasticity-standard_tensors_01.cc
tests/physics/notation-kelvin_01.cc
tests/physics/notation-kelvin_02.cc
tests/physics/notation-kelvin_03.cc
tests/physics/step-18-rotation_matrix.cc
tests/physics/step-18.cc
tests/physics/step-44-standard_tensors-material_push_forward.cc
tests/physics/step-44-standard_tensors-spatial.cc
tests/physics/step-44.cc
tests/physics/transformations-push_forward_01.cc
tests/physics/transformations-rotations_01.cc
tests/quick_tests/arpack.cc
tests/quick_tests/gsl.cc
tests/quick_tests/p4est.cc
tests/quick_tests/tbb.cc
tests/quick_tests/umfpack.cc
tests/rol/vector_adaptor_01.cc
tests/rol/vector_adaptor_02.cc
tests/rol/vector_adaptor_apply_binary_01.cc
tests/rol/vector_adaptor_no_ghost_01.cc
tests/rol/vector_adaptor_with_ghost_01.cc
tests/sacado/ad_number_traits_01.cc
tests/sacado/ad_number_traits_02_none.cc
tests/sacado/ad_number_traits_02a.cc
tests/sacado/ad_number_traits_02b.cc
tests/sacado/ad_number_traits_02c.cc
tests/sacado/ad_number_traits_02d.cc
tests/sacado/ad_number_traits_03.cc
tests/sacado/helper_scalar_coupled_2_components_01_1.cc
tests/sacado/helper_scalar_coupled_2_components_01_2.cc
tests/sacado/helper_scalar_coupled_2_components_01_3.cc
tests/sacado/helper_scalar_coupled_2_components_01_4.cc
tests/sacado/helper_scalar_coupled_2_components_02_1.cc
tests/sacado/helper_scalar_coupled_2_components_02_2.cc
tests/sacado/helper_scalar_coupled_2_components_02_3.cc
tests/sacado/helper_scalar_coupled_2_components_02_4.cc
tests/sacado/helper_scalar_coupled_2_components_03_1.cc
tests/sacado/helper_scalar_coupled_2_components_03_2.cc
tests/sacado/helper_scalar_coupled_2_components_03_3.cc
tests/sacado/helper_scalar_coupled_2_components_03_4.cc
tests/sacado/helper_scalar_coupled_2_components_04_1.cc
tests/sacado/helper_scalar_coupled_2_components_04_2.cc
tests/sacado/helper_scalar_coupled_2_components_04_3.cc
tests/sacado/helper_scalar_coupled_2_components_04_4.cc
tests/sacado/helper_scalar_coupled_2_components_05_1.cc
tests/sacado/helper_scalar_coupled_2_components_05_2.cc
tests/sacado/helper_scalar_coupled_2_components_05_3.cc
tests/sacado/helper_scalar_coupled_2_components_05_4.cc
tests/sacado/helper_scalar_coupled_2_components_06_1.cc
tests/sacado/helper_scalar_coupled_2_components_06_2.cc
tests/sacado/helper_scalar_coupled_2_components_06_3.cc
tests/sacado/helper_scalar_coupled_2_components_06_4.cc
tests/sacado/helper_scalar_coupled_2_components_07_1.cc
tests/sacado/helper_scalar_coupled_2_components_07_2.cc
tests/sacado/helper_scalar_coupled_2_components_07_3.cc
tests/sacado/helper_scalar_coupled_2_components_07_4.cc
tests/sacado/helper_scalar_coupled_2_components_08_1.cc
tests/sacado/helper_scalar_coupled_2_components_08_2.cc
tests/sacado/helper_scalar_coupled_2_components_08_3.cc
tests/sacado/helper_scalar_coupled_2_components_08_4.cc
tests/sacado/helper_scalar_coupled_3_components_01_1.cc
tests/sacado/helper_scalar_coupled_3_components_01_2.cc
tests/sacado/helper_scalar_coupled_3_components_01_3.cc
tests/sacado/helper_scalar_coupled_3_components_01_4.cc
tests/sacado/helper_scalar_coupled_3_components_01_tapeless_only_1.cc
tests/sacado/helper_scalar_coupled_3_components_01_tapeless_only_2.cc
tests/sacado/helper_scalar_coupled_3_components_01_tapeless_only_3.cc
tests/sacado/helper_scalar_coupled_3_components_01_tapeless_only_4.cc
tests/sacado/helper_scalar_coupled_4_components_01_1.cc
tests/sacado/helper_scalar_coupled_4_components_01_2.cc
tests/sacado/helper_scalar_coupled_4_components_01_3.cc
tests/sacado/helper_scalar_coupled_4_components_01_4.cc
tests/sacado/helper_scalar_single_component_01_1.cc
tests/sacado/helper_scalar_single_component_01_2.cc
tests/sacado/helper_scalar_single_component_01_3.cc
tests/sacado/helper_scalar_single_component_01_4.cc
tests/sacado/helper_scalar_single_component_02_1.cc
tests/sacado/helper_scalar_single_component_02_2.cc
tests/sacado/helper_scalar_single_component_02_3.cc
tests/sacado/helper_scalar_single_component_02_4.cc
tests/sacado/helper_scalar_single_component_03_1.cc
tests/sacado/helper_scalar_single_component_03_2.cc
tests/sacado/helper_scalar_single_component_03_3.cc
tests/sacado/helper_scalar_single_component_03_4.cc
tests/sacado/helper_scalar_single_component_04_1.cc
tests/sacado/helper_scalar_single_component_04_2.cc
tests/sacado/helper_scalar_single_component_04_3.cc
tests/sacado/helper_scalar_single_component_04_4.cc
tests/sacado/helper_vector_1_indep_1_dep_vars_01_1.cc
tests/sacado/helper_vector_1_indep_1_dep_vars_01_2.cc
tests/sacado/helper_vector_1_indep_1_dep_vars_01_3.cc
tests/sacado/helper_vector_1_indep_1_dep_vars_01_4.cc
tests/sacado/helper_vector_1_indep_2_dep_vars_01_1.cc
tests/sacado/helper_vector_1_indep_2_dep_vars_01_2.cc
tests/sacado/helper_vector_1_indep_2_dep_vars_01_3.cc
tests/sacado/helper_vector_1_indep_2_dep_vars_01_4.cc
tests/sacado/helper_vector_2_indep_1_dep_vars_01_1.cc
tests/sacado/helper_vector_2_indep_1_dep_vars_01_2.cc
tests/sacado/helper_vector_2_indep_1_dep_vars_01_3.cc
tests/sacado/helper_vector_2_indep_1_dep_vars_01_4.cc
tests/sacado/helper_vector_2_indep_2_dep_vars_01_1.cc
tests/sacado/helper_vector_2_indep_2_dep_vars_01_2.cc
tests/sacado/helper_vector_2_indep_2_dep_vars_01_3.cc
tests/sacado/helper_vector_2_indep_2_dep_vars_01_4.cc
tests/sacado/physics_functions_01_1.cc
tests/sacado/physics_functions_01_2.cc
tests/sacado/physics_functions_01_3.cc
tests/sacado/physics_functions_01_4.cc
tests/sacado/physics_functions_02_1.cc
tests/sacado/physics_functions_02_2.cc
tests/sacado/physics_functions_02_3.cc
tests/sacado/physics_functions_02_4.cc
tests/sacado/physics_functions_03_1.cc
tests/sacado/physics_functions_03_2.cc
tests/sacado/physics_functions_03_3.cc
tests/sacado/physics_functions_03_4.cc
tests/sacado/step-44-helper_res_lin_01_1.cc
tests/sacado/step-44-helper_res_lin_01_2.cc
tests/sacado/step-44-helper_res_lin_01_3.cc
tests/sacado/step-44-helper_res_lin_01_4.cc
tests/sacado/step-44-helper_scalar_01_1.cc
tests/sacado/step-44-helper_scalar_01_2.cc
tests/sacado/step-44-helper_var_form_01_1.cc
tests/sacado/step-44-helper_var_form_01_2.cc
tests/sacado/step-44-helper_vector_01_1.cc
tests/sacado/step-44-helper_vector_01_2.cc
tests/sacado/step-44-helper_vector_01_3.cc
tests/sacado/step-44-helper_vector_01_4.cc
tests/sacado/symmetric_tensor_functions_01_1.cc
tests/sacado/symmetric_tensor_functions_01_2.cc
tests/sacado/symmetric_tensor_functions_01_3.cc
tests/sacado/symmetric_tensor_functions_01_4.cc
tests/sacado/symmetric_tensor_functions_02_1.cc
tests/sacado/symmetric_tensor_functions_02_2.cc
tests/sacado/symmetric_tensor_functions_02_3.cc
tests/sacado/symmetric_tensor_functions_02_4.cc
tests/sacado/symmetric_tensor_functions_03_1.cc
tests/sacado/symmetric_tensor_functions_03_2.cc
tests/sacado/symmetric_tensor_functions_03_3.cc
tests/sacado/symmetric_tensor_functions_03_4.cc
tests/sacado/symmetric_tensor_functions_04_1.cc
tests/sacado/symmetric_tensor_functions_04_2.cc
tests/sacado/symmetric_tensor_functions_04_3.cc
tests/sacado/symmetric_tensor_functions_04_4.cc
tests/sacado/tensor_functions_01_1.cc
tests/sacado/tensor_functions_01_2.cc
tests/sacado/tensor_functions_01_3.cc
tests/sacado/tensor_functions_01_4.cc
tests/sacado/tensor_functions_02_1.cc
tests/sacado/tensor_functions_02_2.cc
tests/sacado/tensor_functions_02_3.cc
tests/sacado/tensor_functions_02_4.cc
tests/scalapack/scalapack_02.cc
tests/scalapack/scalapack_03.cc
tests/scalapack/scalapack_03_b.cc
tests/scalapack/scalapack_03_c.cc
tests/scalapack/scalapack_04.cc
tests/scalapack/scalapack_04_b.cc
tests/scalapack/scalapack_05.cc
tests/scalapack/scalapack_06.cc
tests/scalapack/scalapack_06a.cc
tests/scalapack/scalapack_06b.cc
tests/scalapack/scalapack_06c.cc
tests/scalapack/scalapack_07.cc
tests/scalapack/scalapack_08.cc
tests/scalapack/scalapack_10.cc
tests/scalapack/scalapack_10_a.cc
tests/scalapack/scalapack_10_b.cc
tests/scalapack/scalapack_10_c.cc
tests/scalapack/scalapack_10_d.cc
tests/scalapack/scalapack_11.cc
tests/scalapack/scalapack_12_a.cc
tests/scalapack/scalapack_12_b.cc
tests/scalapack/scalapack_12_c.cc
tests/scalapack/scalapack_12_d.cc
tests/scalapack/scalapack_13_a.cc
tests/scalapack/scalapack_13_b.cc
tests/scalapack/scalapack_14_a.cc
tests/scalapack/scalapack_14_b.cc
tests/scalapack/scalapack_15.cc
tests/scalapack/scalapack_15_a.cc
tests/scalapack/scalapack_16.cc
tests/scalapack/scalapack_16_a.cc
tests/scalapack/scalapack_17_a.cc
tests/scalapack/scalapack_17_b.cc
tests/serialization/cell_data_1.cc
tests/serialization/dof_handler_01.cc
tests/serialization/fe_series_01.cc
tests/serialization/fe_series_02.cc
tests/serialization/hp_dof_handler_01.cc
tests/serialization/parallel_fullydistributed_construction_data_1.cc
tests/serialization/tensor.cc
tests/serialization/tensor_base_scalar.cc
tests/serialization/triangulation_01.cc
tests/serialization/triangulation_02.cc
tests/sharedtria/dof_01.cc
tests/sharedtria/dof_02.cc
tests/sharedtria/dof_03.cc
tests/sharedtria/dof_04.cc
tests/sharedtria/dof_05.cc
tests/sharedtria/dof_06.cc
tests/sharedtria/hp_dof_01.cc
tests/sharedtria/hp_dof_02.cc
tests/sharedtria/hp_dof_03.cc
tests/sharedtria/hp_dof_04.cc
tests/sharedtria/hp_no_cells_01.cc
tests/sharedtria/mg_dof_02.cc
tests/sharedtria/no_cells_01.cc
tests/sharedtria/tria_custom_refine02.cc
tests/slepc/solve_01.cc
tests/slepc/solve_04.cc
tests/sparsity/block_dynamic_01.cc
tests/sparsity/block_dynamic_sparsity_pattern_indexset_01.cc
tests/sparsity/block_sparsity_pattern_01.cc
tests/sparsity/block_sparsity_pattern_02.cc
tests/sparsity/chunk_sparsity_pattern_01.cc
tests/sparsity/chunk_sparsity_pattern_02.cc
tests/sparsity/chunk_sparsity_pattern_03.cc
tests/sparsity/chunk_sparsity_pattern_04.cc
tests/sparsity/chunk_sparsity_pattern_05.cc
tests/sparsity/chunk_sparsity_pattern_06.cc
tests/sparsity/chunk_sparsity_pattern_07.cc
tests/sparsity/chunk_sparsity_pattern_09.cc
tests/sparsity/chunk_sparsity_pattern_10.cc
tests/sparsity/chunk_sparsity_pattern_11.cc
tests/sparsity/dynamic_sparsity_pattern_10.cc
tests/sparsity/dynamic_sparsity_pattern_11.cc
tests/sparsity/dynamic_sparsity_pattern_12.cc
tests/sparsity/dynamic_sparsity_pattern_13.cc
tests/sparsity/dynamic_sparsity_pattern_14.cc
tests/sparsity/dynamic_sparsity_pattern_15.cc
tests/sparsity/dynamic_sparsity_pattern_16.cc
tests/sparsity/dynamic_sparsity_pattern_19.cc
tests/sparsity/dynamic_sparsity_pattern_index_set_01.cc
tests/sparsity/dynamic_sparsity_pattern_index_set_02.cc
tests/sparsity/sparsity_pattern.cc
tests/sparsity/sparsity_pattern_01.cc
tests/sparsity/sparsity_pattern_02.cc
tests/sparsity/sparsity_pattern_03.cc
tests/sparsity/sparsity_pattern_04.cc
tests/sparsity/sparsity_pattern_05.cc
tests/sparsity/sparsity_pattern_06.cc
tests/sparsity/sparsity_pattern_07.cc
tests/sparsity/sparsity_pattern_09.cc
tests/sparsity/sparsity_pattern_10.cc
tests/sparsity/sparsity_pattern_11.cc
tests/sparsity/sparsity_pattern_12.cc
tests/sparsity/sparsity_pattern_13.cc
tests/sparsity/sparsity_pattern_common.h
tests/sparsity/sparsity_pattern_copy_from_01.cc
tests/sparsity/sparsity_pattern_copy_from_02.cc
tests/sparsity/sparsity_tools_01.cc
tests/sparsity/sparsity_tools_02.cc
tests/sundials/kinsol_01.cc
tests/symengine/basic_01.cc
tests/symengine/basic_02.cc
tests/symengine/basic_03.cc
tests/symengine/basic_04.cc
tests/symengine/basic_05.cc
tests/symengine/basic_06.cc
tests/symengine/basic_07.cc
tests/symengine/substitution_maps_cyclic_dependencies_01.cc
tests/symengine/substitution_maps_cyclic_dependencies_02.cc
tests/symengine/substitution_maps_scalar_01.cc
tests/symengine/substitution_maps_scalar_02.cc
tests/symengine/substitution_maps_scalar_03.cc
tests/symengine/substitution_maps_scalar_04.cc
tests/symengine/substitution_maps_scalar_05.cc
tests/symengine/substitution_maps_tensor_01.cc
tests/symengine/substitution_maps_tensor_02.cc
tests/symengine/substitution_maps_tensor_03.cc
tests/symengine/substitution_maps_tensor_04.cc
tests/symengine/symengine_number_type_01.cc
tests/symengine/symengine_number_type_02.cc
tests/symengine/symengine_number_type_03.cc
tests/symengine/symengine_scalar_operations_01.cc
tests/symengine/symengine_scalar_operations_02.cc
tests/symengine/symengine_scalar_operations_03.cc
tests/symengine/symengine_scalar_operations_04.cc
tests/symengine/symengine_tensor_operations_01.cc
tests/symengine/symengine_tensor_operations_02.cc
tests/symengine/symengine_tensor_operations_03.cc
tests/symengine/symengine_tensor_operations_04.cc
tests/symengine/symengine_utilities_01.cc
tests/tensors/constexpr_tensor.cc
tests/tensors/project_orthogonal.cc
tests/tensors/symmetric_tensor_01.cc
tests/tensors/symmetric_tensor_02.cc
tests/tensors/symmetric_tensor_03.cc
tests/tensors/symmetric_tensor_04.cc
tests/tensors/symmetric_tensor_05.cc
tests/tensors/symmetric_tensor_06.cc
tests/tensors/symmetric_tensor_07.cc
tests/tensors/symmetric_tensor_08.cc
tests/tensors/symmetric_tensor_09.cc
tests/tensors/symmetric_tensor_10.cc
tests/tensors/symmetric_tensor_11.cc
tests/tensors/symmetric_tensor_12.cc
tests/tensors/symmetric_tensor_13.cc
tests/tensors/symmetric_tensor_14.cc
tests/tensors/symmetric_tensor_15.cc
tests/tensors/symmetric_tensor_16.cc
tests/tensors/symmetric_tensor_17.cc
tests/tensors/symmetric_tensor_18.cc
tests/tensors/symmetric_tensor_19.cc
tests/tensors/symmetric_tensor_20.cc
tests/tensors/symmetric_tensor_21.cc
tests/tensors/symmetric_tensor_22.cc
tests/tensors/symmetric_tensor_23.cc
tests/tensors/symmetric_tensor_24.cc
tests/tensors/symmetric_tensor_25.cc
tests/tensors/symmetric_tensor_26.cc
tests/tensors/symmetric_tensor_27.cc
tests/tensors/symmetric_tensor_28.cc
tests/tensors/symmetric_tensor_29.cc
tests/tensors/symmetric_tensor_30.cc
tests/tensors/symmetric_tensor_32.cc
tests/tensors/symmetric_tensor_33.cc
tests/tensors/symmetric_tensor_34.cc
tests/tensors/symmetric_tensor_35.cc
tests/tensors/symmetric_tensor_36.cc
tests/tensors/symmetric_tensor_37.cc
tests/tensors/symmetric_tensor_38.cc
tests/tensors/symmetric_tensor_39.cc
tests/tensors/symmetric_tensor_40.cc
tests/tensors/tensor.cc
tests/tensors/tensor_02.cc
tests/tensors/tensor_03.cc
tests/tensors/tensor_04.cc
tests/tensors/tensor_05.cc
tests/tensors/tensor_06.cc
tests/tensors/tensor_07.cc
tests/tensors/tensor_08.cc
tests/tensors/tensor_09.cc
tests/tensors/tensor_24.cc
tests/tensors/tensor_25.cc
tests/tensors/tensor_26.cc
tests/tensors/tensor_27.cc
tests/tensors/tensor_28.cc
tests/tensors/tensor_30.cc
tests/tensors/tensor_complex.cc
tests/tensors/tensor_complex_02.cc
tests/tensors/tensor_complex_06.cc
tests/tensors/tensor_float.cc
tests/tensors/tensor_nondefault_constructor.cc
tests/tests.h
tests/trilinos/64.cc
tests/trilinos/assemble_matrix_parallel_01.cc
tests/trilinos/assemble_matrix_parallel_02.cc
tests/trilinos/assemble_matrix_parallel_03.cc
tests/trilinos/assemble_matrix_parallel_04.cc
tests/trilinos/assemble_matrix_parallel_05.cc
tests/trilinos/assemble_matrix_parallel_06.cc
tests/trilinos/assemble_matrix_parallel_07.cc
tests/trilinos/deal_solver_01.cc
tests/trilinos/deal_solver_02.cc
tests/trilinos/deal_solver_03.cc
tests/trilinos/deal_solver_04.cc
tests/trilinos/deal_solver_05.cc
tests/trilinos/deal_solver_06.cc
tests/trilinos/direct_solver_2.cc
tests/trilinos/direct_solver_3.cc
tests/trilinos/elide_zeros.cc
tests/trilinos/mg_transfer_prebuilt_01.cc
tests/trilinos/parallel_sparse_matrix_01.cc
tests/trilinos/precondition.cc
tests/trilinos/precondition_amg_dgp_01.cc
tests/trilinos/precondition_amg_dgp_03.cc
tests/trilinos/precondition_muelu_dgp.cc
tests/trilinos/renumbering_01.cc
tests/trilinos/solver_03.cc
tests/trilinos/solver_05.cc
tests/trilinos/solver_07.cc
tests/trilinos/solver_control_01.cc
tests/trilinos/solver_control_02.cc
tests/trilinos/solver_control_03.cc
tests/trilinos/solver_control_04.cc
tests/trilinos/solver_control_05.cc
tests/trilinos/solver_control_06.cc
tests/trilinos/sparse_matrix_02.cc
tests/trilinos/sparse_matrix_03.cc
tests/trilinos/sparse_matrix_04.cc
tests/trilinos/sparse_matrix_05.cc
tests/trilinos/sparse_matrix_07.cc
tests/trilinos/sparse_matrix_07_rectangle.cc
tests/trilinos/sparse_matrix_copy_from_01.cc
tests/trilinos/sparse_matrix_set_03.cc
tests/trilinos/sparsity_pattern_01.cc
tests/trilinos/sparsity_pattern_02.cc
tests/trilinos/sparsity_pattern_03.cc
tests/trilinos/sparsity_pattern_common.h
tests/trilinos/subtract_mean_value_04.cc
tests/trilinos/trilinos_sparsity_pattern_02.cc
tests/trilinos/trilinos_sparsity_pattern_03.cc
tests/trilinos/trilinos_sparsity_pattern_04.cc
tests/trilinos/update_ghosts.cc
tests/trilinos/vector_reinit.cc
tests/trilinos/vector_reinit_to_linear_map.cc
tests/umfpack/umfpack_03.cc
tests/umfpack/umfpack_03_complex.cc
tests/umfpack/umfpack_03_complex_complex.cc
tests/umfpack/umfpack_04.cc
tests/umfpack/umfpack_09.cc
tests/umfpack/umfpack_09_complex.cc
tests/umfpack/umfpack_09_complex_complex_complex_nonblock.cc
tests/vector_tools/integrate_difference_01.cc
tests/vector_tools/integrate_difference_01_complex_01.cc
tests/vector_tools/integrate_difference_01_complex_02.cc
tests/vector_tools/integrate_difference_01_complex_03.cc
tests/vector_tools/integrate_difference_01_complex_04.cc
tests/vector_tools/integrate_difference_02.cc
tests/vector_tools/integrate_difference_02_nan.cc
tests/vector_tools/integrate_difference_03.cc
tests/vector_tools/integrate_difference_04.cc
tests/vector_tools/integrate_difference_04_hp.cc
tests/vector_tools/integrate_difference_04_hp_02.cc
tests/vector_tools/integrate_difference_05.cc
tests/vector_tools/interpolate_with_material_id_01.cc
tests/vector_tools/interpolate_with_material_id_02.cc
tests/zoltan/tria_zoltan_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.