diff --git a/math/deal.ii/Makefile b/math/deal.ii/Makefile index b36cd05450d9..c4c5563bb6a6 100644 --- a/math/deal.ii/Makefile +++ b/math/deal.ii/Makefile @@ -1,105 +1,104 @@ PORTNAME= deal.II -DISTVERSION= 9.5.0 -PORTREVISION= 4 +DISTVERSION= 9.5.2 CATEGORIES= math MASTER_SITES= https://github.com/dealii/dealii/releases/download/v${DISTVERSION}/ DISTNAME= dealii-${DISTVERSION} MAINTAINER= yuri@FreeBSD.org COMMENT= Finite element Differential Equations Analysis Library (DEAL) WWW= https://www.dealii.org/ LICENSE= LGPL21 LICENSE_FILE= ${WRKSRC}/LICENSE.md -BROKEN_FreeBSD_14= clang crashes: https://bugs.freebsd.org/bugzilla/show_bug.cgi?id=257876 BROKEN_aarch64= error: use of undeclared identifier '__TBB_machine_fetchadd4' BROKEN_armv7= clang runs out of memory BUILD_DEPENDS= ${LOCALBASE}/include/boost/config.hpp:devel/boost-libs -LIB_DEPENDS= libboost_serialization.so:devel/boost-libs \ +LIB_DEPENDS= libblis.so:math/blis \ + libboost_serialization.so:devel/boost-libs \ libhdf5.so:science/hdf5 \ libmetis.so:math/metis # libkokkoscore.so:devel/kokkos TMP commented out for bundled kokkos, tests fail for non-bundled kokkos, see https://github.com/dealii/dealii/issues/15692 USES= blaslapack cmake:testing compiler:c++17-lang localbase:ldflags xorg USE_LDCONFIG= yes CMAKE_OFF= DEAL_II_ALLOW_BUNDLED DEAL_II_COMPONENT_EXAMPLES \ DEAL_II_WITH_P4EST DEAL_II_WITH_TRILINOS DEAL_II_WITH_UMFPACK \ DEAL_II_WITH_NANOFLANN DEAL_II_WITH_MUPARSER DEAL_II_WITH_ASSIMP \ DEAL_II_WITH_HDF5 CMAKE_ON= DEAL_II_FORCE_BUNDLED_TBB # instead of LIB_DEPENDS+=libtbb.so:devel/onetbb, pending https://github.com/dealii/dealii/issues/11561 CMAKE_ON+= FORCE_BUNDLED_KOKKOS # TMP turn on bundled kokkos CMAKE_TESTING_ON= FREEBSD_ENABLE_TESTS LDFLAGS+= -lomp LDFLAGS+= -lexecinfo # TMP for bundled kokkos OPTIONS_DEFINE= ADOLC ARPACK GSL LAPACK MPI OPENCASCADE PETSC SCALAPACK SLEPC SUNDIALS # for all options see contrib/docker/Dockerfile, TODO some of them need to be enabled here OPTIONS_DEFAULT= GSL LAPACK MPI OPENCASCADE PETSC SCALAPACK SLEPC SUNDIALS ADOLC_DESC= Compile with ADOL-C ADOLC_CMAKE_BOOL= DEAL_II_WITH_ADOLC ADOLC_LIB_DEPENDS= libadolc.so:math/adol-c ADOLC_BROKEN= requires the development version: see https://github.com/dealii/dealii/issues/7293 ARPACK_DESC= Compile with Arpack and PArpack (only with MPI, LAPACK) ARPACK_CMAKE_BOOL= DEAL_II_WITH_ARPACK ARPACK_CMAKE_ON= -DARPACK_LINKER_FLAGS:STRING="${LDFLAGS}" ARPACK_BUILD_DEPENDS= arpack-ng>0:math/arpack-ng ARPACK_RUN_DEPENDS= arpack-ng>0:math/arpack-ng # itself doesn't link to arpack, but makes depending project link to it ARPACK_IMPLIES= LAPACK GSL_DESC= Compile with gsl GSL_CMAKE_BOOL= DEAL_II_WITH_GSL GSL_LIB_DEPENDS= libgsl.so:math/gsl LAPACK_DESC= Compile with LAPACK for matrix operations LAPACK_USES= fortran LAPACK_CMAKE_BOOL= DEAL_II_WITH_LAPACK LAPACK_CMAKE_ON= -DLAPACK_LINKER_FLAGS:STRING="${LDFLAGS}" LAPACK_LIB_DEPENDS= libopenblas.so:math/openblas MPI_DESC= MPI support (math/sundials must be compiled with MPI) MPI_USES= fortran MPI_CMAKE_BOOL= DEAL_II_WITH_MPI MPI_CMAKE_ON= -DMPI_LINKER_FLAGS:STRING="${LDFLAGS}" MPI_LIB_DEPENDS= libboost_iostreams.so:devel/boost-libs \ libmpich.so:net/mpich OPENCASCADE_DESC= Compile with OpenCascade OPENCASCADE_CMAKE_BOOL= DEAL_II_WITH_OPENCASCADE OPENCASCADE_CMAKE_ON= -DOPENCASCADE_INCLUDE_DIR:STRING=${LOCALBASE}/include/OpenCASCADE OPENCASCADE_LIB_DEPENDS= libTKernel.so:cad/opencascade PETSC_DESC= Compile with Petsc (only with MPI) PETSC_USES= xorg PETSC_USE= XORG=x11 # PETSc adds x11 through interface libraries PETSC_CMAKE_BOOL= DEAL_II_WITH_PETSC DEAL_II_WITH_64BIT_INDICES PETSC_LIB_DEPENDS= libpetsc.so:science/PETSc PETSC_IMPLIES= MPI # has to use the same MPI as PETSc uses SCALAPACK_DESC= Compile with ScaLAPACK (only with MPI) SCALAPACK_CMAKE_BOOL= DEAL_II_WITH_SCALAPACK SCALAPACK_IMPLIES= MPI LAPACK SCALAPACK_LIB_DEPENDS= libscalapack.so:math/scalapack SLEPC_DESC= Compile with Slepc (only with MPI) SLEPC_USES= xorg SLEPC_USE= XORG=x11 # SLEPc adds x11 through interface libraries SLEPC_CMAKE_BOOL= DEAL_II_WITH_SLEPC SLEPC_LIB_DEPENDS= libslepc.so:math/slepc SLEPC_IMPLIES= MPI # has to use the same MPI as PETSc uses SUNDIALS_DESC= Compile with SUNDIALS SUNDIALS_CMAKE_BOOL= DEAL_II_WITH_SUNDIALS SUNDIALS_LIB_DEPENDS= libsundials_arkode.so:math/sundials post-patch: # unbundle boost @${RM} -r ${WRKSRC}/dealii/bundled/boost-* post-stage: @${RM} ${STAGEDIR}${PREFIX}/*.log .include diff --git a/math/deal.ii/distinfo b/math/deal.ii/distinfo index a04a5d3b9a9c..c4822c3aea3e 100644 --- a/math/deal.ii/distinfo +++ b/math/deal.ii/distinfo @@ -1,3 +1,3 @@ -TIMESTAMP = 1688878324 -SHA256 (dealii-9.5.0.tar.gz) = a81f41565f0d3a22d491ee687957dd48053225da72e8d6d628d210358f4a0464 -SIZE (dealii-9.5.0.tar.gz) = 31524412 +TIMESTAMP = 1709202081 +SHA256 (dealii-9.5.2.tar.gz) = 7930e5218a9807d60cc05c300a3b70f36f4af22c3551a2cd1141fbab013bbaf1 +SIZE (dealii-9.5.2.tar.gz) = 31523493 diff --git a/math/deal.ii/pkg-plist b/math/deal.ii/pkg-plist index 16fb33919575..0f58a55e4363 100644 --- a/math/deal.ii/pkg-plist +++ b/math/deal.ii/pkg-plist @@ -1,1219 +1,1219 @@ include/deal.II/algorithms/any_data.h include/deal.II/algorithms/general_data_storage.h include/deal.II/algorithms/named_selection.h include/deal.II/algorithms/newton.h include/deal.II/algorithms/newton.templates.h include/deal.II/algorithms/operator.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/arborx/access_traits.h include/deal.II/arborx/bvh.h include/deal.II/arborx/distributed_tree.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/bounding_box_data_out.h include/deal.II/base/communication_pattern_base.h include/deal.II/base/complex_overloads.h include/deal.II/base/conditional_ostream.h include/deal.II/base/config.h include/deal.II/base/convergence_table.h include/deal.II/base/cuda.h include/deal.II/base/cuda_size.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/event.h include/deal.II/base/exceptions.h include/deal.II/base/floating_point_comparator.h include/deal.II/base/flow_function.h include/deal.II/base/function.h include/deal.II/base/function.templates.h include/deal.II/base/function_bessel.h include/deal.II/base/function_cspline.h include/deal.II/base/function_derivative.h include/deal.II/base/function_level_set.h include/deal.II/base/function_lib.h include/deal.II/base/function_parser.h include/deal.II/base/function_restriction.h include/deal.II/base/function_signed_distance.h include/deal.II/base/function_spherical.h include/deal.II/base/function_time.h include/deal.II/base/function_time.templates.h include/deal.II/base/function_tools.h include/deal.II/base/geometric_utilities.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/iterator_range.h include/deal.II/base/job_identifier.h include/deal.II/base/kokkos.h include/deal.II/base/linear_index_iterator.h include/deal.II/base/logstream.h include/deal.II/base/memory_consumption.h include/deal.II/base/memory_space.h include/deal.II/base/memory_space_data.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.h include/deal.II/base/mpi_consensus_algorithms.templates.h include/deal.II/base/mpi_large_count.h include/deal.II/base/mpi_noncontiguous_partitioner.h include/deal.II/base/mpi_noncontiguous_partitioner.templates.h include/deal.II/base/mpi_remote_point_evaluation.h include/deal.II/base/mpi_stub.h include/deal.II/base/mpi_tags.h include/deal.II/base/mu_parser_internal.h include/deal.II/base/multithread_info.h include/deal.II/base/mutable_bind.h include/deal.II/base/mutex.h include/deal.II/base/ndarray.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/path_search.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_barycentric.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_hermite.h include/deal.II/base/polynomials_integrated_legendre_sz.h include/deal.II/base/polynomials_nedelec.h include/deal.II/base/polynomials_p.h include/deal.II/base/polynomials_piecewise.h include/deal.II/base/polynomials_pyramid.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/polynomials_wedge.h include/deal.II/base/process_grid.h include/deal.II/base/qprojector.h include/deal.II/base/quadrature.h include/deal.II/base/quadrature_lib.h include/deal.II/base/quadrature_point_data.h include/deal.II/base/quadrature_selector.h include/deal.II/base/revision.h include/deal.II/base/sacado_product_type.h include/deal.II/base/scalar_polynomials_base.h include/deal.II/base/scope_exit.h include/deal.II/base/signaling_nan.h include/deal.II/base/smartpointer.h include/deal.II/base/std_cxx14/algorithm.h include/deal.II/base/std_cxx14/memory.h include/deal.II/base/std_cxx14/utility.h include/deal.II/base/std_cxx17/algorithm.h include/deal.II/base/std_cxx17/cmath.h include/deal.II/base/std_cxx17/optional.h include/deal.II/base/std_cxx17/tuple.h include/deal.II/base/std_cxx17/variant.h include/deal.II/base/std_cxx20/iota_view.h include/deal.II/base/std_cxx20/type_traits.h include/deal.II/base/subscriptor.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/synchronous_iterator.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.h include/deal.II/base/tensor_function.templates.h include/deal.II/base/tensor_function_parser.h include/deal.II/base/tensor_polynomials_base.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.h include/deal.II/base/time_stepping.templates.h include/deal.II/base/timer.h include/deal.II/base/trilinos_utilities.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/bundled/Cuda/Kokkos_Cuda_Alloc.hpp include/deal.II/bundled/Cuda/Kokkos_Cuda_Atomic_Intrinsics.hpp include/deal.II/bundled/Cuda/Kokkos_Cuda_Atomic_Intrinsics_Restore_Builtins.hpp include/deal.II/bundled/Cuda/Kokkos_Cuda_BlockSize_Deduction.hpp include/deal.II/bundled/Cuda/Kokkos_Cuda_Error.hpp include/deal.II/bundled/Cuda/Kokkos_Cuda_GraphNodeKernel.hpp include/deal.II/bundled/Cuda/Kokkos_Cuda_GraphNode_Impl.hpp include/deal.II/bundled/Cuda/Kokkos_Cuda_Graph_Impl.hpp include/deal.II/bundled/Cuda/Kokkos_Cuda_Half_Conversion.hpp include/deal.II/bundled/Cuda/Kokkos_Cuda_Half_Impl_Type.hpp include/deal.II/bundled/Cuda/Kokkos_Cuda_Instance.hpp include/deal.II/bundled/Cuda/Kokkos_Cuda_KernelLaunch.hpp include/deal.II/bundled/Cuda/Kokkos_Cuda_Locks.hpp include/deal.II/bundled/Cuda/Kokkos_Cuda_MDRangePolicy.hpp include/deal.II/bundled/Cuda/Kokkos_Cuda_Parallel_MDRange.hpp include/deal.II/bundled/Cuda/Kokkos_Cuda_Parallel_Range.hpp include/deal.II/bundled/Cuda/Kokkos_Cuda_Parallel_Team.hpp include/deal.II/bundled/Cuda/Kokkos_Cuda_ReduceScan.hpp include/deal.II/bundled/Cuda/Kokkos_Cuda_Task.hpp include/deal.II/bundled/Cuda/Kokkos_Cuda_Team.hpp include/deal.II/bundled/Cuda/Kokkos_Cuda_UniqueToken.hpp include/deal.II/bundled/Cuda/Kokkos_Cuda_Vectorization.hpp include/deal.II/bundled/Cuda/Kokkos_Cuda_View.hpp include/deal.II/bundled/Cuda/Kokkos_Cuda_WorkGraphPolicy.hpp include/deal.II/bundled/Cuda/Kokkos_Cuda_abort.hpp include/deal.II/bundled/HIP/Kokkos_HIP_Abort.hpp include/deal.II/bundled/HIP/Kokkos_HIP_Atomic.hpp include/deal.II/bundled/HIP/Kokkos_HIP_BlockSize_Deduction.hpp include/deal.II/bundled/HIP/Kokkos_HIP_Error.hpp include/deal.II/bundled/HIP/Kokkos_HIP_Half_Conversion.hpp include/deal.II/bundled/HIP/Kokkos_HIP_Half_Impl_Type.hpp include/deal.II/bundled/HIP/Kokkos_HIP_Instance.hpp include/deal.II/bundled/HIP/Kokkos_HIP_KernelLaunch.hpp include/deal.II/bundled/HIP/Kokkos_HIP_Locks.hpp include/deal.II/bundled/HIP/Kokkos_HIP_MDRangePolicy.hpp include/deal.II/bundled/HIP/Kokkos_HIP_Parallel_MDRange.hpp include/deal.II/bundled/HIP/Kokkos_HIP_Parallel_Range.hpp include/deal.II/bundled/HIP/Kokkos_HIP_Parallel_Team.hpp include/deal.II/bundled/HIP/Kokkos_HIP_ReduceScan.hpp include/deal.II/bundled/HIP/Kokkos_HIP_Shuffle_Reduce.hpp include/deal.II/bundled/HIP/Kokkos_HIP_Team.hpp include/deal.II/bundled/HIP/Kokkos_HIP_UniqueToken.hpp include/deal.II/bundled/HIP/Kokkos_HIP_Vectorization.hpp include/deal.II/bundled/HIP/Kokkos_HIP_WorkGraphPolicy.hpp include/deal.II/bundled/HPX/Kokkos_HPX_Task.hpp include/deal.II/bundled/HPX/Kokkos_HPX_WorkGraphPolicy.hpp include/deal.II/bundled/KokkosCore_Config_DeclareBackend.hpp include/deal.II/bundled/KokkosCore_Config_FwdBackend.hpp include/deal.II/bundled/KokkosCore_Config_PostInclude.hpp include/deal.II/bundled/KokkosCore_Config_SetupBackend.hpp include/deal.II/bundled/KokkosCore_config.h include/deal.II/bundled/KokkosExp_InterOp.hpp include/deal.II/bundled/KokkosExp_MDRangePolicy.hpp include/deal.II/bundled/Kokkos_AcquireUniqueTokenImpl.hpp include/deal.II/bundled/Kokkos_AnonymousSpace.hpp include/deal.II/bundled/Kokkos_Array.hpp include/deal.II/bundled/Kokkos_Atomic.hpp include/deal.II/bundled/Kokkos_Atomics_Desul_Config.hpp include/deal.II/bundled/Kokkos_Atomics_Desul_Volatile_Wrapper.hpp include/deal.II/bundled/Kokkos_Atomics_Desul_Wrapper.hpp include/deal.II/bundled/Kokkos_Bitset.hpp include/deal.II/bundled/Kokkos_Complex.hpp include/deal.II/bundled/Kokkos_Concepts.hpp include/deal.II/bundled/Kokkos_CopyViews.hpp include/deal.II/bundled/Kokkos_Core.hpp include/deal.II/bundled/Kokkos_Core_fwd.hpp include/deal.II/bundled/Kokkos_Crs.hpp include/deal.II/bundled/Kokkos_Cuda.hpp include/deal.II/bundled/Kokkos_CudaSpace.hpp include/deal.II/bundled/Kokkos_DetectionIdiom.hpp include/deal.II/bundled/Kokkos_DualView.hpp include/deal.II/bundled/Kokkos_DynRankView.hpp include/deal.II/bundled/Kokkos_DynamicView.hpp include/deal.II/bundled/Kokkos_ErrorReporter.hpp include/deal.II/bundled/Kokkos_ExecPolicy.hpp include/deal.II/bundled/Kokkos_Extents.hpp include/deal.II/bundled/Kokkos_Functional.hpp include/deal.II/bundled/Kokkos_Future.hpp include/deal.II/bundled/Kokkos_Graph.hpp include/deal.II/bundled/Kokkos_GraphNode.hpp include/deal.II/bundled/Kokkos_Graph_fwd.hpp include/deal.II/bundled/Kokkos_HBWSpace.hpp include/deal.II/bundled/Kokkos_HIP.hpp include/deal.II/bundled/Kokkos_HIP_Space.hpp include/deal.II/bundled/Kokkos_HPX.hpp include/deal.II/bundled/Kokkos_Half.hpp include/deal.II/bundled/Kokkos_HostSpace.hpp include/deal.II/bundled/Kokkos_Layout.hpp include/deal.II/bundled/Kokkos_LogicalSpaces.hpp include/deal.II/bundled/Kokkos_Macros.hpp include/deal.II/bundled/Kokkos_MasterLock.hpp include/deal.II/bundled/Kokkos_MathematicalConstants.hpp include/deal.II/bundled/Kokkos_MathematicalFunctions.hpp include/deal.II/bundled/Kokkos_MathematicalSpecialFunctions.hpp include/deal.II/bundled/Kokkos_MemoryPool.hpp include/deal.II/bundled/Kokkos_MemoryTraits.hpp include/deal.II/bundled/Kokkos_MinMaxClamp.hpp include/deal.II/bundled/Kokkos_NumericTraits.hpp include/deal.II/bundled/Kokkos_OffsetView.hpp include/deal.II/bundled/Kokkos_OpenMP.hpp include/deal.II/bundled/Kokkos_OpenMPTarget.hpp include/deal.II/bundled/Kokkos_OpenMPTargetSpace.hpp include/deal.II/bundled/Kokkos_Pair.hpp include/deal.II/bundled/Kokkos_Parallel.hpp include/deal.II/bundled/Kokkos_Parallel_Reduce.hpp include/deal.II/bundled/Kokkos_PointerOwnership.hpp include/deal.II/bundled/Kokkos_Profiling_ProfileSection.hpp include/deal.II/bundled/Kokkos_Random.hpp include/deal.II/bundled/Kokkos_Rank.hpp include/deal.II/bundled/Kokkos_SIMD.hpp include/deal.II/bundled/Kokkos_SIMD_AVX512.hpp include/deal.II/bundled/Kokkos_SIMD_Common.hpp include/deal.II/bundled/Kokkos_SIMD_Scalar.hpp include/deal.II/bundled/Kokkos_SYCL.hpp include/deal.II/bundled/Kokkos_SYCL_Space.hpp include/deal.II/bundled/Kokkos_ScatterView.hpp include/deal.II/bundled/Kokkos_ScratchSpace.hpp include/deal.II/bundled/Kokkos_Serial.hpp include/deal.II/bundled/Kokkos_Sort.hpp include/deal.II/bundled/Kokkos_StaticCrsGraph.hpp include/deal.II/bundled/Kokkos_StdAlgorithms.hpp include/deal.II/bundled/Kokkos_TaskPolicy.hpp include/deal.II/bundled/Kokkos_TaskScheduler.hpp include/deal.II/bundled/Kokkos_TaskScheduler_fwd.hpp include/deal.II/bundled/Kokkos_Threads.hpp include/deal.II/bundled/Kokkos_Timer.hpp include/deal.II/bundled/Kokkos_Tuners.hpp include/deal.II/bundled/Kokkos_UniqueToken.hpp include/deal.II/bundled/Kokkos_UnorderedMap.hpp include/deal.II/bundled/Kokkos_Vector.hpp include/deal.II/bundled/Kokkos_Vectorization.hpp include/deal.II/bundled/Kokkos_View.hpp include/deal.II/bundled/Kokkos_WorkGraphPolicy.hpp include/deal.II/bundled/Kokkos_hwloc.hpp include/deal.II/bundled/OpenACC/Kokkos_OpenACC.hpp include/deal.II/bundled/OpenACC/Kokkos_OpenACCSpace.hpp include/deal.II/bundled/OpenACC/Kokkos_OpenACC_Instance.hpp include/deal.II/bundled/OpenACC/Kokkos_OpenACC_Traits.hpp include/deal.II/bundled/OpenMP/Kokkos_OpenMP_Instance.hpp include/deal.II/bundled/OpenMP/Kokkos_OpenMP_Parallel.hpp include/deal.II/bundled/OpenMP/Kokkos_OpenMP_Task.hpp include/deal.II/bundled/OpenMP/Kokkos_OpenMP_Team.hpp include/deal.II/bundled/OpenMP/Kokkos_OpenMP_WorkGraphPolicy.hpp include/deal.II/bundled/OpenMPTarget/Kokkos_OpenMPTarget_Abort.hpp include/deal.II/bundled/OpenMPTarget/Kokkos_OpenMPTarget_Error.hpp include/deal.II/bundled/OpenMPTarget/Kokkos_OpenMPTarget_Exec.hpp include/deal.II/bundled/OpenMPTarget/Kokkos_OpenMPTarget_Instance.hpp include/deal.II/bundled/OpenMPTarget/Kokkos_OpenMPTarget_Parallel.hpp include/deal.II/bundled/OpenMPTarget/Kokkos_OpenMPTarget_Parallel_MDRange.hpp include/deal.II/bundled/OpenMPTarget/Kokkos_OpenMPTarget_Task.hpp include/deal.II/bundled/OpenMPTarget/Kokkos_OpenMPTarget_UniqueToken.hpp include/deal.II/bundled/SYCL/Kokkos_SYCL_Abort.hpp include/deal.II/bundled/SYCL/Kokkos_SYCL_DeepCopy.hpp include/deal.II/bundled/SYCL/Kokkos_SYCL_Half_Conversion.hpp include/deal.II/bundled/SYCL/Kokkos_SYCL_Half_Impl_Type.hpp include/deal.II/bundled/SYCL/Kokkos_SYCL_Instance.hpp include/deal.II/bundled/SYCL/Kokkos_SYCL_MDRangePolicy.hpp include/deal.II/bundled/SYCL/Kokkos_SYCL_Parallel_Range.hpp include/deal.II/bundled/SYCL/Kokkos_SYCL_Parallel_Reduce.hpp include/deal.II/bundled/SYCL/Kokkos_SYCL_Parallel_Scan.hpp include/deal.II/bundled/SYCL/Kokkos_SYCL_Parallel_Team.hpp include/deal.II/bundled/SYCL/Kokkos_SYCL_Team.hpp include/deal.II/bundled/SYCL/Kokkos_SYCL_UniqueToken.hpp include/deal.II/bundled/Serial/Kokkos_Serial_Parallel_MDRange.hpp include/deal.II/bundled/Serial/Kokkos_Serial_Parallel_Range.hpp include/deal.II/bundled/Serial/Kokkos_Serial_Parallel_Team.hpp include/deal.II/bundled/Serial/Kokkos_Serial_Task.hpp include/deal.II/bundled/Serial/Kokkos_Serial_UniqueToken.hpp include/deal.II/bundled/Serial/Kokkos_Serial_WorkGraphPolicy.hpp include/deal.II/bundled/Threads/Kokkos_ThreadsExec.hpp include/deal.II/bundled/Threads/Kokkos_ThreadsTeam.hpp include/deal.II/bundled/Threads/Kokkos_Threads_Parallel_MDRange.hpp include/deal.II/bundled/Threads/Kokkos_Threads_Parallel_Range.hpp include/deal.II/bundled/Threads/Kokkos_Threads_Parallel_Team.hpp include/deal.II/bundled/Threads/Kokkos_Threads_UniqueToken.hpp include/deal.II/bundled/Threads/Kokkos_Threads_WorkGraphPolicy.hpp include/deal.II/bundled/View/Hooks/Kokkos_ViewHooks.hpp include/deal.II/bundled/decl/Kokkos_Declare_CUDA.hpp include/deal.II/bundled/decl/Kokkos_Declare_HBWSpace.hpp include/deal.II/bundled/decl/Kokkos_Declare_HIP.hpp include/deal.II/bundled/decl/Kokkos_Declare_HPX.hpp include/deal.II/bundled/decl/Kokkos_Declare_OPENACC.hpp include/deal.II/bundled/decl/Kokkos_Declare_OPENMP.hpp include/deal.II/bundled/decl/Kokkos_Declare_OPENMPTARGET.hpp include/deal.II/bundled/decl/Kokkos_Declare_SERIAL.hpp include/deal.II/bundled/decl/Kokkos_Declare_SYCL.hpp include/deal.II/bundled/decl/Kokkos_Declare_THREADS.hpp include/deal.II/bundled/desul/atomics.hpp include/deal.II/bundled/desul/atomics/Atomic_Ref.hpp include/deal.II/bundled/desul/atomics/CUDA.hpp include/deal.II/bundled/desul/atomics/Common.hpp include/deal.II/bundled/desul/atomics/Compare_Exchange.hpp include/deal.II/bundled/desul/atomics/Compare_Exchange_CUDA.hpp include/deal.II/bundled/desul/atomics/Compare_Exchange_GCC.hpp include/deal.II/bundled/desul/atomics/Compare_Exchange_HIP.hpp include/deal.II/bundled/desul/atomics/Compare_Exchange_MSVC.hpp include/deal.II/bundled/desul/atomics/Compare_Exchange_OpenMP.hpp include/deal.II/bundled/desul/atomics/Compare_Exchange_SYCL.hpp include/deal.II/bundled/desul/atomics/Compare_Exchange_ScopeCaller.hpp include/deal.II/bundled/desul/atomics/Compare_Exchange_Serial.hpp include/deal.II/bundled/desul/atomics/GCC.hpp include/deal.II/bundled/desul/atomics/Generic.hpp include/deal.II/bundled/desul/atomics/HIP.hpp include/deal.II/bundled/desul/atomics/Lock_Array.hpp include/deal.II/bundled/desul/atomics/Lock_Array_Cuda.hpp include/deal.II/bundled/desul/atomics/Lock_Array_HIP.hpp include/deal.II/bundled/desul/atomics/Macros.hpp include/deal.II/bundled/desul/atomics/OpenMP.hpp include/deal.II/bundled/desul/atomics/SYCL.hpp include/deal.II/bundled/desul/atomics/SYCLConversions.hpp include/deal.II/bundled/desul/atomics/cuda/CUDA_asm.hpp include/deal.II/bundled/desul/atomics/cuda/CUDA_asm_exchange.hpp include/deal.II/bundled/desul/atomics/openmp/OpenMP_40.hpp include/deal.II/bundled/fwd/Kokkos_Fwd_CUDA.hpp include/deal.II/bundled/fwd/Kokkos_Fwd_HBWSpace.hpp include/deal.II/bundled/fwd/Kokkos_Fwd_HIP.hpp include/deal.II/bundled/fwd/Kokkos_Fwd_HPX.hpp include/deal.II/bundled/fwd/Kokkos_Fwd_OPENACC.hpp include/deal.II/bundled/fwd/Kokkos_Fwd_OPENMP.hpp include/deal.II/bundled/fwd/Kokkos_Fwd_OPENMPTARGET.hpp include/deal.II/bundled/fwd/Kokkos_Fwd_SERIAL.hpp include/deal.II/bundled/fwd/Kokkos_Fwd_SYCL.hpp include/deal.II/bundled/fwd/Kokkos_Fwd_THREADS.hpp include/deal.II/bundled/impl/KokkosExp_Host_IterateTile.hpp include/deal.II/bundled/impl/KokkosExp_IterateTileGPU.hpp include/deal.II/bundled/impl/KokkosExp_ViewMapping.hpp include/deal.II/bundled/impl/Kokkos_AnalyzePolicy.hpp include/deal.II/bundled/impl/Kokkos_Atomic_Assembly.hpp include/deal.II/bundled/impl/Kokkos_Atomic_Compare_Exchange_Strong.hpp include/deal.II/bundled/impl/Kokkos_Atomic_Compare_Exchange_Weak.hpp include/deal.II/bundled/impl/Kokkos_Atomic_Decrement.hpp include/deal.II/bundled/impl/Kokkos_Atomic_Exchange.hpp include/deal.II/bundled/impl/Kokkos_Atomic_Fetch_Add.hpp include/deal.II/bundled/impl/Kokkos_Atomic_Fetch_And.hpp include/deal.II/bundled/impl/Kokkos_Atomic_Fetch_Or.hpp include/deal.II/bundled/impl/Kokkos_Atomic_Fetch_Sub.hpp include/deal.II/bundled/impl/Kokkos_Atomic_Generic.hpp include/deal.II/bundled/impl/Kokkos_Atomic_Generic_Secondary.hpp include/deal.II/bundled/impl/Kokkos_Atomic_Increment.hpp include/deal.II/bundled/impl/Kokkos_Atomic_Load.hpp include/deal.II/bundled/impl/Kokkos_Atomic_Memory_Order.hpp include/deal.II/bundled/impl/Kokkos_Atomic_MinMax.hpp include/deal.II/bundled/impl/Kokkos_Atomic_Store.hpp include/deal.II/bundled/impl/Kokkos_Atomic_View.hpp include/deal.II/bundled/impl/Kokkos_Atomic_Windows.hpp include/deal.II/bundled/impl/Kokkos_BitOps.hpp include/deal.II/bundled/impl/Kokkos_Bitset_impl.hpp include/deal.II/bundled/impl/Kokkos_CPUDiscovery.hpp include/deal.II/bundled/impl/Kokkos_ChaseLev.hpp include/deal.II/bundled/impl/Kokkos_ClockTic.hpp include/deal.II/bundled/impl/Kokkos_Combined_Reducer.hpp include/deal.II/bundled/impl/Kokkos_Command_Line_Parsing.hpp include/deal.II/bundled/impl/Kokkos_ConcurrentBitset.hpp include/deal.II/bundled/impl/Kokkos_Default_GraphNodeKernel.hpp include/deal.II/bundled/impl/Kokkos_Default_GraphNode_Impl.hpp include/deal.II/bundled/impl/Kokkos_Default_Graph_Impl.hpp include/deal.II/bundled/impl/Kokkos_Default_Graph_fwd.hpp include/deal.II/bundled/impl/Kokkos_DeviceManagement.hpp include/deal.II/bundled/impl/Kokkos_EBO.hpp include/deal.II/bundled/impl/Kokkos_Error.hpp include/deal.II/bundled/impl/Kokkos_ExecSpaceManager.hpp include/deal.II/bundled/impl/Kokkos_FixedBufferMemoryPool.hpp include/deal.II/bundled/impl/Kokkos_Functional_impl.hpp include/deal.II/bundled/impl/Kokkos_FunctorAnalysis.hpp include/deal.II/bundled/impl/Kokkos_GraphImpl.hpp include/deal.II/bundled/impl/Kokkos_GraphImpl_Utilities.hpp include/deal.II/bundled/impl/Kokkos_GraphImpl_fwd.hpp include/deal.II/bundled/impl/Kokkos_GraphNodeCustomization.hpp include/deal.II/bundled/impl/Kokkos_GraphNodeImpl.hpp include/deal.II/bundled/impl/Kokkos_HostBarrier.hpp include/deal.II/bundled/impl/Kokkos_HostSharedPtr.hpp include/deal.II/bundled/impl/Kokkos_HostSpace_deepcopy.hpp include/deal.II/bundled/impl/Kokkos_HostThreadTeam.hpp include/deal.II/bundled/impl/Kokkos_InitializationSettings.hpp include/deal.II/bundled/impl/Kokkos_LIFO.hpp include/deal.II/bundled/impl/Kokkos_LinkedListNode.hpp include/deal.II/bundled/impl/Kokkos_MemoryPoolAllocator.hpp include/deal.II/bundled/impl/Kokkos_MemorySpace.hpp include/deal.II/bundled/impl/Kokkos_Memory_Fence.hpp include/deal.II/bundled/impl/Kokkos_MultipleTaskQueue.hpp include/deal.II/bundled/impl/Kokkos_OptionalRef.hpp include/deal.II/bundled/impl/Kokkos_ParseCommandLineArgumentsAndEnvironmentVariables.hpp include/deal.II/bundled/impl/Kokkos_PhysicalLayout.hpp include/deal.II/bundled/impl/Kokkos_Profiling.hpp include/deal.II/bundled/impl/Kokkos_Profiling_C_Interface.h include/deal.II/bundled/impl/Kokkos_Profiling_DeviceInfo.hpp include/deal.II/bundled/impl/Kokkos_Profiling_Interface.hpp include/deal.II/bundled/impl/Kokkos_QuadPrecisionMath.hpp include/deal.II/bundled/impl/Kokkos_SharedAlloc.hpp include/deal.II/bundled/impl/Kokkos_SharedAlloc_timpl.hpp include/deal.II/bundled/impl/Kokkos_SimpleTaskScheduler.hpp include/deal.II/bundled/impl/Kokkos_SingleTaskQueue.hpp include/deal.II/bundled/impl/Kokkos_Spinwait.hpp include/deal.II/bundled/impl/Kokkos_Stacktrace.hpp include/deal.II/bundled/impl/Kokkos_StaticCrsGraph_factory.hpp include/deal.II/bundled/impl/Kokkos_StringManipulation.hpp include/deal.II/bundled/impl/Kokkos_TaskBase.hpp include/deal.II/bundled/impl/Kokkos_TaskNode.hpp include/deal.II/bundled/impl/Kokkos_TaskPolicyData.hpp include/deal.II/bundled/impl/Kokkos_TaskQueue.hpp include/deal.II/bundled/impl/Kokkos_TaskQueueCommon.hpp include/deal.II/bundled/impl/Kokkos_TaskQueueMemoryManager.hpp include/deal.II/bundled/impl/Kokkos_TaskQueueMultiple.hpp include/deal.II/bundled/impl/Kokkos_TaskQueueMultiple_impl.hpp include/deal.II/bundled/impl/Kokkos_TaskQueue_impl.hpp include/deal.II/bundled/impl/Kokkos_TaskResult.hpp include/deal.II/bundled/impl/Kokkos_TaskTeamMember.hpp include/deal.II/bundled/impl/Kokkos_Timer.hpp include/deal.II/bundled/impl/Kokkos_Tools.hpp include/deal.II/bundled/impl/Kokkos_Tools_Generic.hpp include/deal.II/bundled/impl/Kokkos_Traits.hpp include/deal.II/bundled/impl/Kokkos_UnorderedMap_impl.hpp include/deal.II/bundled/impl/Kokkos_Utilities.hpp include/deal.II/bundled/impl/Kokkos_VLAEmulation.hpp include/deal.II/bundled/impl/Kokkos_ViewArray.hpp include/deal.II/bundled/impl/Kokkos_ViewCtor.hpp include/deal.II/bundled/impl/Kokkos_ViewLayoutTiled.hpp include/deal.II/bundled/impl/Kokkos_ViewMapping.hpp include/deal.II/bundled/impl/Kokkos_ViewTracker.hpp include/deal.II/bundled/impl/Kokkos_ViewUniformType.hpp include/deal.II/bundled/impl/Kokkos_Volatile_Load.hpp include/deal.II/bundled/setup/Kokkos_Setup_Cuda.hpp include/deal.II/bundled/setup/Kokkos_Setup_HIP.hpp include/deal.II/bundled/setup/Kokkos_Setup_SYCL.hpp include/deal.II/bundled/std_algorithms/Kokkos_AdjacentDifference.hpp include/deal.II/bundled/std_algorithms/Kokkos_AdjacentFind.hpp include/deal.II/bundled/std_algorithms/Kokkos_AllOf.hpp include/deal.II/bundled/std_algorithms/Kokkos_AnyOf.hpp include/deal.II/bundled/std_algorithms/Kokkos_BeginEnd.hpp include/deal.II/bundled/std_algorithms/Kokkos_Copy.hpp include/deal.II/bundled/std_algorithms/Kokkos_CopyBackward.hpp include/deal.II/bundled/std_algorithms/Kokkos_CopyIf.hpp include/deal.II/bundled/std_algorithms/Kokkos_CopyN.hpp include/deal.II/bundled/std_algorithms/Kokkos_Count.hpp include/deal.II/bundled/std_algorithms/Kokkos_CountIf.hpp include/deal.II/bundled/std_algorithms/Kokkos_Distance.hpp include/deal.II/bundled/std_algorithms/Kokkos_Equal.hpp include/deal.II/bundled/std_algorithms/Kokkos_ExclusiveScan.hpp include/deal.II/bundled/std_algorithms/Kokkos_Fill.hpp include/deal.II/bundled/std_algorithms/Kokkos_FillN.hpp include/deal.II/bundled/std_algorithms/Kokkos_Find.hpp include/deal.II/bundled/std_algorithms/Kokkos_FindEnd.hpp include/deal.II/bundled/std_algorithms/Kokkos_FindFirstOf.hpp include/deal.II/bundled/std_algorithms/Kokkos_FindIf.hpp include/deal.II/bundled/std_algorithms/Kokkos_FindIfNot.hpp include/deal.II/bundled/std_algorithms/Kokkos_ForEach.hpp include/deal.II/bundled/std_algorithms/Kokkos_ForEachN.hpp include/deal.II/bundled/std_algorithms/Kokkos_Generate.hpp include/deal.II/bundled/std_algorithms/Kokkos_GenerateN.hpp include/deal.II/bundled/std_algorithms/Kokkos_InclusiveScan.hpp include/deal.II/bundled/std_algorithms/Kokkos_IsPartitioned.hpp include/deal.II/bundled/std_algorithms/Kokkos_IsSorted.hpp include/deal.II/bundled/std_algorithms/Kokkos_IsSortedUntil.hpp include/deal.II/bundled/std_algorithms/Kokkos_IterSwap.hpp include/deal.II/bundled/std_algorithms/Kokkos_LexicographicalCompare.hpp include/deal.II/bundled/std_algorithms/Kokkos_MaxElement.hpp include/deal.II/bundled/std_algorithms/Kokkos_MinElement.hpp include/deal.II/bundled/std_algorithms/Kokkos_MinMaxElement.hpp include/deal.II/bundled/std_algorithms/Kokkos_Mismatch.hpp include/deal.II/bundled/std_algorithms/Kokkos_Move.hpp include/deal.II/bundled/std_algorithms/Kokkos_MoveBackward.hpp include/deal.II/bundled/std_algorithms/Kokkos_NoneOf.hpp include/deal.II/bundled/std_algorithms/Kokkos_PartitionCopy.hpp include/deal.II/bundled/std_algorithms/Kokkos_PartitionPoint.hpp include/deal.II/bundled/std_algorithms/Kokkos_Reduce.hpp include/deal.II/bundled/std_algorithms/Kokkos_Remove.hpp include/deal.II/bundled/std_algorithms/Kokkos_RemoveCopy.hpp include/deal.II/bundled/std_algorithms/Kokkos_RemoveCopyIf.hpp include/deal.II/bundled/std_algorithms/Kokkos_RemoveIf.hpp include/deal.II/bundled/std_algorithms/Kokkos_Replace.hpp include/deal.II/bundled/std_algorithms/Kokkos_ReplaceCopy.hpp include/deal.II/bundled/std_algorithms/Kokkos_ReplaceCopyIf.hpp include/deal.II/bundled/std_algorithms/Kokkos_ReplaceIf.hpp include/deal.II/bundled/std_algorithms/Kokkos_Reverse.hpp include/deal.II/bundled/std_algorithms/Kokkos_ReverseCopy.hpp include/deal.II/bundled/std_algorithms/Kokkos_Rotate.hpp include/deal.II/bundled/std_algorithms/Kokkos_RotateCopy.hpp include/deal.II/bundled/std_algorithms/Kokkos_Search.hpp include/deal.II/bundled/std_algorithms/Kokkos_SearchN.hpp include/deal.II/bundled/std_algorithms/Kokkos_ShiftLeft.hpp include/deal.II/bundled/std_algorithms/Kokkos_ShiftRight.hpp include/deal.II/bundled/std_algorithms/Kokkos_Swap.hpp include/deal.II/bundled/std_algorithms/Kokkos_SwapRanges.hpp include/deal.II/bundled/std_algorithms/Kokkos_Transform.hpp include/deal.II/bundled/std_algorithms/Kokkos_TransformExclusiveScan.hpp include/deal.II/bundled/std_algorithms/Kokkos_TransformInclusiveScan.hpp include/deal.II/bundled/std_algorithms/Kokkos_TransformReduce.hpp include/deal.II/bundled/std_algorithms/Kokkos_Unique.hpp include/deal.II/bundled/std_algorithms/Kokkos_UniqueCopy.hpp include/deal.II/bundled/std_algorithms/impl/Kokkos_AdjacentDifference.hpp include/deal.II/bundled/std_algorithms/impl/Kokkos_AdjacentFind.hpp include/deal.II/bundled/std_algorithms/impl/Kokkos_AllOfAnyOfNoneOf.hpp include/deal.II/bundled/std_algorithms/impl/Kokkos_Constraints.hpp include/deal.II/bundled/std_algorithms/impl/Kokkos_CopyBackward.hpp include/deal.II/bundled/std_algorithms/impl/Kokkos_CopyCopyN.hpp include/deal.II/bundled/std_algorithms/impl/Kokkos_CopyIf.hpp include/deal.II/bundled/std_algorithms/impl/Kokkos_CountCountIf.hpp include/deal.II/bundled/std_algorithms/impl/Kokkos_Equal.hpp include/deal.II/bundled/std_algorithms/impl/Kokkos_ExclusiveScan.hpp include/deal.II/bundled/std_algorithms/impl/Kokkos_FillFillN.hpp include/deal.II/bundled/std_algorithms/impl/Kokkos_FindEnd.hpp include/deal.II/bundled/std_algorithms/impl/Kokkos_FindFirstOf.hpp include/deal.II/bundled/std_algorithms/impl/Kokkos_FindIfOrNot.hpp include/deal.II/bundled/std_algorithms/impl/Kokkos_ForEachForEachN.hpp include/deal.II/bundled/std_algorithms/impl/Kokkos_GenerateGenerateN.hpp include/deal.II/bundled/std_algorithms/impl/Kokkos_HelperPredicates.hpp include/deal.II/bundled/std_algorithms/impl/Kokkos_IdentityReferenceUnaryFunctor.hpp include/deal.II/bundled/std_algorithms/impl/Kokkos_InclusiveScan.hpp include/deal.II/bundled/std_algorithms/impl/Kokkos_IsPartitioned.hpp include/deal.II/bundled/std_algorithms/impl/Kokkos_IsSorted.hpp include/deal.II/bundled/std_algorithms/impl/Kokkos_IsSortedUntil.hpp include/deal.II/bundled/std_algorithms/impl/Kokkos_LexicographicalCompare.hpp include/deal.II/bundled/std_algorithms/impl/Kokkos_MinMaxMinmaxElement.hpp include/deal.II/bundled/std_algorithms/impl/Kokkos_Mismatch.hpp include/deal.II/bundled/std_algorithms/impl/Kokkos_Move.hpp include/deal.II/bundled/std_algorithms/impl/Kokkos_MoveBackward.hpp include/deal.II/bundled/std_algorithms/impl/Kokkos_PartitionCopy.hpp include/deal.II/bundled/std_algorithms/impl/Kokkos_PartitionPoint.hpp include/deal.II/bundled/std_algorithms/impl/Kokkos_RandomAccessIterator.hpp include/deal.II/bundled/std_algorithms/impl/Kokkos_Reduce.hpp include/deal.II/bundled/std_algorithms/impl/Kokkos_ReducerWithArbitraryJoinerNoNeutralElement.hpp include/deal.II/bundled/std_algorithms/impl/Kokkos_RemoveAllVariants.hpp include/deal.II/bundled/std_algorithms/impl/Kokkos_Replace.hpp include/deal.II/bundled/std_algorithms/impl/Kokkos_ReplaceCopy.hpp include/deal.II/bundled/std_algorithms/impl/Kokkos_ReplaceCopyIf.hpp include/deal.II/bundled/std_algorithms/impl/Kokkos_ReplaceIf.hpp include/deal.II/bundled/std_algorithms/impl/Kokkos_Reverse.hpp include/deal.II/bundled/std_algorithms/impl/Kokkos_ReverseCopy.hpp include/deal.II/bundled/std_algorithms/impl/Kokkos_Rotate.hpp include/deal.II/bundled/std_algorithms/impl/Kokkos_RotateCopy.hpp include/deal.II/bundled/std_algorithms/impl/Kokkos_Search.hpp include/deal.II/bundled/std_algorithms/impl/Kokkos_SearchN.hpp include/deal.II/bundled/std_algorithms/impl/Kokkos_ShiftLeft.hpp include/deal.II/bundled/std_algorithms/impl/Kokkos_ShiftRight.hpp include/deal.II/bundled/std_algorithms/impl/Kokkos_SwapRanges.hpp include/deal.II/bundled/std_algorithms/impl/Kokkos_Transform.hpp include/deal.II/bundled/std_algorithms/impl/Kokkos_TransformExclusiveScan.hpp include/deal.II/bundled/std_algorithms/impl/Kokkos_TransformInclusiveScan.hpp include/deal.II/bundled/std_algorithms/impl/Kokkos_TransformReduce.hpp include/deal.II/bundled/std_algorithms/impl/Kokkos_Unique.hpp include/deal.II/bundled/std_algorithms/impl/Kokkos_UniqueCopy.hpp include/deal.II/bundled/std_algorithms/impl/Kokkos_ValueWrapperForNoNeutralElement.hpp include/deal.II/bundled/tbb/aggregator.h include/deal.II/bundled/tbb/aligned_space.h include/deal.II/bundled/tbb/atomic.h include/deal.II/bundled/tbb/blocked_range.h include/deal.II/bundled/tbb/blocked_range2d.h include/deal.II/bundled/tbb/blocked_range3d.h include/deal.II/bundled/tbb/cache_aligned_allocator.h include/deal.II/bundled/tbb/combinable.h include/deal.II/bundled/tbb/compat/ppl.h include/deal.II/bundled/tbb/concurrent_hash_map.h include/deal.II/bundled/tbb/concurrent_lru_cache.h include/deal.II/bundled/tbb/concurrent_priority_queue.h include/deal.II/bundled/tbb/concurrent_queue.h include/deal.II/bundled/tbb/concurrent_unordered_map.h include/deal.II/bundled/tbb/concurrent_unordered_set.h include/deal.II/bundled/tbb/concurrent_vector.h include/deal.II/bundled/tbb/critical_section.h include/deal.II/bundled/tbb/enumerable_thread_specific.h include/deal.II/bundled/tbb/flow_graph.h include/deal.II/bundled/tbb/flow_graph_abstractions.h include/deal.II/bundled/tbb/flow_graph_opencl_node.h include/deal.II/bundled/tbb/gfx_factory.h include/deal.II/bundled/tbb/global_control.h include/deal.II/bundled/tbb/internal/_aggregator_impl.h include/deal.II/bundled/tbb/internal/_concurrent_queue_impl.h include/deal.II/bundled/tbb/internal/_concurrent_unordered_impl.h include/deal.II/bundled/tbb/internal/_flow_graph_async_msg_impl.h include/deal.II/bundled/tbb/internal/_flow_graph_body_impl.h include/deal.II/bundled/tbb/internal/_flow_graph_cache_impl.h include/deal.II/bundled/tbb/internal/_flow_graph_impl.h include/deal.II/bundled/tbb/internal/_flow_graph_indexer_impl.h include/deal.II/bundled/tbb/internal/_flow_graph_item_buffer_impl.h include/deal.II/bundled/tbb/internal/_flow_graph_join_impl.h include/deal.II/bundled/tbb/internal/_flow_graph_node_impl.h include/deal.II/bundled/tbb/internal/_flow_graph_streaming_node.h include/deal.II/bundled/tbb/internal/_flow_graph_tagged_buffer_impl.h include/deal.II/bundled/tbb/internal/_flow_graph_trace_impl.h include/deal.II/bundled/tbb/internal/_flow_graph_types_impl.h include/deal.II/bundled/tbb/internal/_mutex_padding.h include/deal.II/bundled/tbb/internal/_range_iterator.h include/deal.II/bundled/tbb/internal/_tbb_hash_compare_impl.h include/deal.II/bundled/tbb/internal/_tbb_strings.h include/deal.II/bundled/tbb/internal/_tbb_trace_impl.h include/deal.II/bundled/tbb/internal/_tbb_windef.h include/deal.II/bundled/tbb/internal/_template_helpers.h include/deal.II/bundled/tbb/internal/_x86_eliding_mutex_impl.h include/deal.II/bundled/tbb/internal/_x86_rtm_rw_mutex_impl.h include/deal.II/bundled/tbb/machine/gcc_armv7.h include/deal.II/bundled/tbb/machine/gcc_generic.h include/deal.II/bundled/tbb/machine/gcc_ia32_common.h include/deal.II/bundled/tbb/machine/gcc_itsx.h include/deal.II/bundled/tbb/machine/ibm_aix51.h include/deal.II/bundled/tbb/machine/icc_generic.h include/deal.II/bundled/tbb/machine/linux_common.h include/deal.II/bundled/tbb/machine/linux_ia32.h include/deal.II/bundled/tbb/machine/linux_ia64.h include/deal.II/bundled/tbb/machine/linux_intel64.h include/deal.II/bundled/tbb/machine/mac_ppc.h include/deal.II/bundled/tbb/machine/macos_common.h include/deal.II/bundled/tbb/machine/mic_common.h include/deal.II/bundled/tbb/machine/msvc_armv7.h include/deal.II/bundled/tbb/machine/msvc_ia32_common.h include/deal.II/bundled/tbb/machine/sunos_sparc.h include/deal.II/bundled/tbb/machine/windows_api.h include/deal.II/bundled/tbb/machine/windows_ia32.h include/deal.II/bundled/tbb/machine/windows_intel64.h include/deal.II/bundled/tbb/memory_pool.h include/deal.II/bundled/tbb/mutex.h include/deal.II/bundled/tbb/null_mutex.h include/deal.II/bundled/tbb/null_rw_mutex.h include/deal.II/bundled/tbb/parallel_do.h include/deal.II/bundled/tbb/parallel_for.h include/deal.II/bundled/tbb/parallel_for_each.h include/deal.II/bundled/tbb/parallel_invoke.h include/deal.II/bundled/tbb/parallel_reduce.h include/deal.II/bundled/tbb/parallel_scan.h include/deal.II/bundled/tbb/parallel_sort.h include/deal.II/bundled/tbb/parallel_while.h include/deal.II/bundled/tbb/partitioner.h include/deal.II/bundled/tbb/pipeline.h include/deal.II/bundled/tbb/queuing_mutex.h include/deal.II/bundled/tbb/queuing_rw_mutex.h include/deal.II/bundled/tbb/reader_writer_lock.h include/deal.II/bundled/tbb/recursive_mutex.h include/deal.II/bundled/tbb/runtime_loader.h include/deal.II/bundled/tbb/scalable_allocator.h include/deal.II/bundled/tbb/spin_mutex.h include/deal.II/bundled/tbb/spin_rw_mutex.h include/deal.II/bundled/tbb/task.h include/deal.II/bundled/tbb/task_arena.h include/deal.II/bundled/tbb/task_group.h include/deal.II/bundled/tbb/task_scheduler_init.h include/deal.II/bundled/tbb/task_scheduler_observer.h include/deal.II/bundled/tbb/tbb.h include/deal.II/bundled/tbb/tbb_allocator.h include/deal.II/bundled/tbb/tbb_config.h include/deal.II/bundled/tbb/tbb_disable_exceptions.h include/deal.II/bundled/tbb/tbb_exception.h include/deal.II/bundled/tbb/tbb_machine.h include/deal.II/bundled/tbb/tbb_profiling.h include/deal.II/bundled/tbb/tbb_stddef.h include/deal.II/bundled/tbb/tbb_thread.h include/deal.II/bundled/tbb/tbbmalloc_proxy.h include/deal.II/bundled/tbb/tick_count.h include/deal.II/bundled/traits/Kokkos_ExecutionSpaceTrait.hpp include/deal.II/bundled/traits/Kokkos_GraphKernelTrait.hpp include/deal.II/bundled/traits/Kokkos_IndexTypeTrait.hpp include/deal.II/bundled/traits/Kokkos_IterationPatternTrait.hpp include/deal.II/bundled/traits/Kokkos_LaunchBoundsTrait.hpp include/deal.II/bundled/traits/Kokkos_OccupancyControlTrait.hpp include/deal.II/bundled/traits/Kokkos_PolicyTraitAdaptor.hpp include/deal.II/bundled/traits/Kokkos_PolicyTraitMatcher.hpp include/deal.II/bundled/traits/Kokkos_ScheduleTrait.hpp include/deal.II/bundled/traits/Kokkos_Traits_fwd.hpp include/deal.II/bundled/traits/Kokkos_WorkItemPropertyTrait.hpp include/deal.II/bundled/traits/Kokkos_WorkTagTrait.hpp include/deal.II/cgal/additional_data.h include/deal.II/cgal/intersections.h include/deal.II/cgal/point_conversion.h include/deal.II/cgal/surface_mesh.h include/deal.II/cgal/triangulation.h include/deal.II/cgal/utilities.h include/deal.II/differentiation/ad.h include/deal.II/differentiation/ad/ad_drivers.h include/deal.II/differentiation/ad/ad_helpers.h include/deal.II/differentiation/ad/ad_number_traits.h include/deal.II/differentiation/ad/ad_number_types.h include/deal.II/differentiation/ad/adolc_math.h include/deal.II/differentiation/ad/adolc_number_types.h include/deal.II/differentiation/ad/adolc_product_types.h include/deal.II/differentiation/ad/sacado_math.h include/deal.II/differentiation/ad/sacado_number_types.h include/deal.II/differentiation/ad/sacado_product_types.h include/deal.II/differentiation/sd.h include/deal.II/differentiation/sd/symengine_math.h include/deal.II/differentiation/sd/symengine_number_traits.h include/deal.II/differentiation/sd/symengine_number_types.h include/deal.II/differentiation/sd/symengine_number_visitor_internal.h include/deal.II/differentiation/sd/symengine_optimizer.h include/deal.II/differentiation/sd/symengine_product_types.h include/deal.II/differentiation/sd/symengine_scalar_operations.h include/deal.II/differentiation/sd/symengine_tensor_operations.h include/deal.II/differentiation/sd/symengine_types.h include/deal.II/differentiation/sd/symengine_utilities.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/field_transfer.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/repartitioning_policy_tools.h include/deal.II/distributed/shared_tria.h include/deal.II/distributed/solution_transfer.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/dof_accessor.h include/deal.II/dofs/dof_accessor.templates.h include/deal.II/dofs/dof_faces.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_levels.h include/deal.II/dofs/dof_objects.h include/deal.II/dofs/dof_renumbering.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_base.h include/deal.II/fe/fe_bdm.h include/deal.II/fe/fe_bernardi_raugel.h include/deal.II/fe/fe_bernstein.h include/deal.II/fe/fe_data.h include/deal.II/fe/fe_dg_vector.h include/deal.II/fe/fe_dg_vector.templates.h include/deal.II/fe/fe_dgp.h include/deal.II/fe/fe_dgp_monomial.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_face.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.h include/deal.II/fe/fe_poly_face.templates.h include/deal.II/fe/fe_poly_tensor.h include/deal.II/fe/fe_pyramid_p.h include/deal.II/fe/fe_q.h include/deal.II/fe/fe_q_base.h include/deal.II/fe/fe_q_bubbles.h include/deal.II/fe/fe_q_dg0.h include/deal.II/fe/fe_q_hierarchical.h include/deal.II/fe/fe_q_iso_q1.h include/deal.II/fe/fe_rannacher_turek.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_simplex_p.h include/deal.II/fe/fe_simplex_p_bubbles.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_trace.h include/deal.II/fe/fe_update_flags.h include/deal.II/fe/fe_values.h include/deal.II/fe/fe_values_extractors.h include/deal.II/fe/fe_wedge_p.h include/deal.II/fe/mapping.h include/deal.II/fe/mapping_c1.h include/deal.II/fe/mapping_cartesian.h include/deal.II/fe/mapping_fe.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_q1.h include/deal.II/fe/mapping_q1_eulerian.h include/deal.II/fe/mapping_q_cache.h include/deal.II/fe/mapping_q_eulerian.h include/deal.II/fe/mapping_q_generic.h include/deal.II/fe/mapping_q_internal.h include/deal.II/fe/mapping_related_data.h include/deal.II/gmsh/utilities.h include/deal.II/grid/cell_id.h include/deal.II/grid/cell_id_translator.h include/deal.II/grid/composition_manifold.h include/deal.II/grid/connectivity.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_reordering.h include/deal.II/grid/grid_tools.h include/deal.II/grid/grid_tools_cache.h include/deal.II/grid/grid_tools_cache_update_flags.h include/deal.II/grid/intergrid_map.h include/deal.II/grid/magic_numbers.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/reference_cell.h include/deal.II/grid/tensor_product_manifold.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_faces.h include/deal.II/grid/tria_iterator.h include/deal.II/grid/tria_iterator.templates.h include/deal.II/grid/tria_iterator_base.h include/deal.II/grid/tria_iterator_selector.h include/deal.II/grid/tria_levels.h include/deal.II/grid/tria_objects.h include/deal.II/grid/tria_objects_orientations.h include/deal.II/hp/collection.h include/deal.II/hp/fe_collection.h include/deal.II/hp/fe_values.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/advection.h include/deal.II/integrators/divergence.h include/deal.II/integrators/elasticity.h include/deal.II/integrators/grad_div.h include/deal.II/integrators/l2.h include/deal.II/integrators/laplace.h include/deal.II/integrators/local_integrators.h include/deal.II/integrators/maxwell.h include/deal.II/integrators/patches.h include/deal.II/lac/affine_constraints.h include/deal.II/lac/affine_constraints.templates.h include/deal.II/lac/arpack_solver.h include/deal.II/lac/blas_extension_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.h include/deal.II/lac/block_sparse_matrix.templates.h include/deal.II/lac/block_sparse_matrix_ez.h include/deal.II/lac/block_sparse_matrix_ez.templates.h include/deal.II/lac/block_sparsity_pattern.h include/deal.II/lac/block_vector.h include/deal.II/lac/block_vector.templates.h include/deal.II/lac/block_vector_base.h include/deal.II/lac/chunk_sparse_matrix.h include/deal.II/lac/chunk_sparse_matrix.templates.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/constraint_matrix.h include/deal.II/lac/cuda_atomic.h include/deal.II/lac/cuda_kernels.h include/deal.II/lac/cuda_kernels.templates.h include/deal.II/lac/cuda_precondition.h include/deal.II/lac/cuda_solver_direct.h include/deal.II/lac/cuda_sparse_matrix.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/full_matrix.templates.h include/deal.II/lac/generic_linear_algebra.h include/deal.II/lac/ginkgo_solver.h include/deal.II/lac/householder.h include/deal.II/lac/identity_matrix.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/lapack_support.h include/deal.II/lac/lapack_templates.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/matrix_out.h include/deal.II/lac/orthogonalization.h include/deal.II/lac/packaged_operation.h include/deal.II/lac/parpack_solver.h include/deal.II/lac/petsc_block_sparse_matrix.h include/deal.II/lac/petsc_block_vector.h include/deal.II/lac/petsc_communication_pattern.h include/deal.II/lac/petsc_compatibility.h include/deal.II/lac/petsc_full_matrix.h include/deal.II/lac/petsc_matrix_base.h include/deal.II/lac/petsc_matrix_free.h include/deal.II/lac/petsc_parallel_block_sparse_matrix.h include/deal.II/lac/petsc_parallel_block_vector.h include/deal.II/lac/petsc_parallel_sparse_matrix.h include/deal.II/lac/petsc_parallel_vector.h include/deal.II/lac/petsc_precondition.h include/deal.II/lac/petsc_snes.h include/deal.II/lac/petsc_snes.templates.h include/deal.II/lac/petsc_solver.h include/deal.II/lac/petsc_sparse_matrix.h include/deal.II/lac/petsc_ts.h include/deal.II/lac/petsc_ts.templates.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.templates.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.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/scalapack.h include/deal.II/lac/scalapack.templates.h include/deal.II/lac/schur_complement.h include/deal.II/lac/slepc_solver.h include/deal.II/lac/slepc_spectral_transformation.h include/deal.II/lac/solver.h include/deal.II/lac/solver_bicgstab.h include/deal.II/lac/solver_cg.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_minres.h include/deal.II/lac/solver_qmrs.h include/deal.II/lac/solver_relaxation.h include/deal.II/lac/solver_richardson.h include/deal.II/lac/solver_selector.h include/deal.II/lac/sparse_decomposition.h include/deal.II/lac/sparse_decomposition.templates.h include/deal.II/lac/sparse_direct.h include/deal.II/lac/sparse_ilu.h include/deal.II/lac/sparse_ilu.templates.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_matrix_tools.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_pattern_base.h include/deal.II/lac/sparsity_tools.h include/deal.II/lac/tensor_product_matrix.h include/deal.II/lac/tensor_product_matrix.templates.h include/deal.II/lac/tridiagonal_matrix.h include/deal.II/lac/trilinos_block_sparse_matrix.h include/deal.II/lac/trilinos_epetra_communication_pattern.h include/deal.II/lac/trilinos_epetra_vector.h include/deal.II/lac/trilinos_index_access.h include/deal.II/lac/trilinos_linear_operator.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_communication_pattern.h include/deal.II/lac/trilinos_tpetra_vector.h include/deal.II/lac/trilinos_tpetra_vector.templates.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_element_access.h include/deal.II/lac/vector_memory.h include/deal.II/lac/vector_memory.templates.h include/deal.II/lac/vector_operation.h include/deal.II/lac/vector_operations_internal.h include/deal.II/lac/vector_space_vector.h include/deal.II/lac/vector_type_traits.h include/deal.II/matrix_free/constraint_info.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/cuda_tensor_product_kernels.h include/deal.II/matrix_free/dof_info.h include/deal.II/matrix_free/dof_info.templates.h include/deal.II/matrix_free/evaluation_flags.h include/deal.II/matrix_free/evaluation_kernels.h include/deal.II/matrix_free/evaluation_kernels_hanging_nodes.h include/deal.II/matrix_free/evaluation_selector.h include/deal.II/matrix_free/evaluation_template_face_factory.templates.h include/deal.II/matrix_free/evaluation_template_factory.h include/deal.II/matrix_free/evaluation_template_factory.templates.h include/deal.II/matrix_free/evaluation_template_factory_hanging_nodes.templates.h include/deal.II/matrix_free/evaluation_template_factory_internal.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/fe_evaluation_data.h include/deal.II/matrix_free/fe_point_evaluation.h include/deal.II/matrix_free/hanging_nodes_internal.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/mapping_info_storage.h include/deal.II/matrix_free/mapping_info_storage.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/tools.h include/deal.II/matrix_free/type_traits.h include/deal.II/matrix_free/util.h include/deal.II/matrix_free/vector_access_internal.h include/deal.II/matrix_free/vector_data_exchange.h include/deal.II/meshworker/assemble_flags.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/scratch_data.h include/deal.II/meshworker/simple.h include/deal.II/meshworker/vector_selector.h include/deal.II/meshworker/vector_selector.templates.h include/deal.II/multigrid/mg_base.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_matrix.h include/deal.II/multigrid/mg_smoother.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_global_coarsening.h include/deal.II/multigrid/mg_transfer_global_coarsening.templates.h include/deal.II/multigrid/mg_transfer_internal.h include/deal.II/multigrid/mg_transfer_matrix_free.h include/deal.II/multigrid/mg_transfer_matrix_free.templates.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/non_matching/fe_immersed_values.h include/deal.II/non_matching/fe_values.h include/deal.II/non_matching/immersed_surface_quadrature.h include/deal.II/non_matching/mapping_info.h include/deal.II/non_matching/mesh_classifier.h include/deal.II/non_matching/quadrature_generator.h include/deal.II/numerics/adaptation_strategies.h include/deal.II/numerics/cell_data_transfer.h include/deal.II/numerics/cell_data_transfer.templates.h include/deal.II/numerics/data_component_interpretation.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_resample.h include/deal.II/numerics/data_out_rotation.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.h include/deal.II/numerics/dof_output_operator.templates.h include/deal.II/numerics/dof_print_solver_step.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/histogram.h include/deal.II/numerics/history.h include/deal.II/numerics/matrix_creator.h include/deal.II/numerics/matrix_creator.templates.h include/deal.II/numerics/matrix_tools.h include/deal.II/numerics/nonlinear.h include/deal.II/numerics/point_value_history.h include/deal.II/numerics/rtree.h include/deal.II/numerics/smoothness_estimator.h include/deal.II/numerics/solution_transfer.h include/deal.II/numerics/tensor_product_matrix_creator.h include/deal.II/numerics/time_dependent.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_evaluate.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/boundary_lib.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/rol/vector_adaptor.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_accessor.h include/deal.II/particles/particle_handler.h include/deal.II/particles/particle_iterator.h include/deal.II/particles/partitioner.h include/deal.II/particles/property_pool.h include/deal.II/particles/utilities.h include/deal.II/physics/elasticity/kinematics.h include/deal.II/physics/elasticity/standard_tensors.h include/deal.II/physics/notation.h include/deal.II/physics/transformations.h include/deal.II/physics/vector_relations.h include/deal.II/sundials/arkode.h include/deal.II/sundials/ida.h include/deal.II/sundials/kinsol.h include/deal.II/sundials/n_vector.h include/deal.II/sundials/n_vector.templates.h include/deal.II/sundials/sunlinsol_wrapper.h include/deal.II/sundials/utilities.h include/deal.II/trilinos/nox.h include/deal.II/trilinos/nox.templates.h lib/cmake/deal.II/deal.IIConfig.cmake lib/cmake/deal.II/deal.IIConfigVersion.cmake lib/cmake/deal.II/deal.IITargets-%%CMAKE_BUILD_TYPE%%.cmake lib/cmake/deal.II/deal.IITargets.cmake lib/libdeal_II.so -lib/libdeal_II.so.9.5.0 +lib/libdeal_II.so.9.5.2 %%DATADIR%%/macros/macro_deal_ii_add_test.cmake %%DATADIR%%/macros/macro_deal_ii_initialize_cached_variables.cmake %%DATADIR%%/macros/macro_deal_ii_invoke_autopilot.cmake %%DATADIR%%/macros/macro_deal_ii_pickup_tests.cmake %%DATADIR%%/macros/macro_deal_ii_query_git_information.cmake %%DATADIR%%/macros/macro_deal_ii_setup_target.cmake %%DATADIR%%/macros/macro_shell_escape_option_groups.cmake %%DATADIR%%/macros/macro_target_compile_flags.cmake %%DATADIR%%/macros/macro_target_link_flags.cmake %%DATADIR%%/scripts/get_closest_tag.sh %%DATADIR%%/scripts/get_latest_tag.sh %%DATADIR%%/scripts/indent.py %%DATADIR%%/scripts/normalize.pl %%DATADIR%%/scripts/run_test.cmake %%DATADIR%%/scripts/run_test.sh