]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Ensure that no file is truly empty. 17932/head
authorWolfgang Bangerth <bangerth@colostate.edu>
Tue, 17 Dec 2024 04:13:48 +0000 (21:13 -0700)
committerWolfgang Bangerth <bangerth@colostate.edu>
Tue, 17 Dec 2024 04:33:09 +0000 (21:33 -0700)
92 files changed:
include/deal.II/arborx/access_traits.h
include/deal.II/arborx/bvh.h
include/deal.II/arborx/distributed_tree.h
include/deal.II/base/function_cspline.h
include/deal.II/base/hdf5.h
include/deal.II/base/mpi_large_count.h
include/deal.II/base/process_grid.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/ad_helpers.h
include/deal.II/differentiation/ad/adolc_math.h
include/deal.II/differentiation/ad/adolc_product_types.h
include/deal.II/differentiation/ad/sacado_math.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.templates.h
include/deal.II/distributed/p4est_wrappers.h
include/deal.II/gmsh/utilities.h
include/deal.II/lac/arpack_solver.h
include/deal.II/lac/ginkgo_solver.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_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/scalapack.h
include/deal.II/lac/slepc_solver.h
include/deal.II/lac/slepc_spectral_transformation.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_block_sparse_matrix.h
include/deal.II/lac/trilinos_tpetra_block_sparse_matrix.templates.h
include/deal.II/lac/trilinos_tpetra_block_vector.h
include/deal.II/lac/trilinos_tpetra_block_vector.templates.h
include/deal.II/lac/trilinos_tpetra_communication_pattern.h
include/deal.II/lac/trilinos_tpetra_precondition.h
include/deal.II/lac/trilinos_tpetra_precondition.templates.h
include/deal.II/lac/trilinos_tpetra_solver_direct.h
include/deal.II/lac/trilinos_tpetra_solver_direct.templates.h
include/deal.II/lac/trilinos_tpetra_sparse_matrix.h
include/deal.II/lac/trilinos_tpetra_sparse_matrix.templates.h
include/deal.II/lac/trilinos_tpetra_sparsity_pattern.h
include/deal.II/lac/trilinos_tpetra_types.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/opencascade/manifold_lib.h
include/deal.II/opencascade/utilities.h
include/deal.II/optimization/rol/vector_adaptor.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/sundials_types.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
include/deal.II/vtk/utilities.h

index b1f80496de02f80265374c7e152182f314c79af5..88cb92f09f6cc9b3fbe92db3d25e1bd2de6922e2 100644 (file)
@@ -696,6 +696,14 @@ namespace ArborX
   }
 } // namespace ArborX
 
+#else
+
+// Make sure the scripts that create the C++20 module input files have
+// something to latch on if the preprocessor #ifdef above would
+// otherwise lead to an empty content of the file.
+DEAL_II_NAMESPACE_OPEN
+DEAL_II_NAMESPACE_CLOSE
+
 #endif
 
 #endif
index f34d4ef419d4d5887093021256c59287bbd1ba8a..6819cdd6ecad76a0e1e7868a70b57fa03dc099da 100644 (file)
@@ -185,5 +185,13 @@ namespace ArborXWrappers
 
 DEAL_II_NAMESPACE_CLOSE
 
+#else
+
+// Make sure the scripts that create the C++20 module input files have
+// something to latch on if the preprocessor #ifdef above would
+// otherwise lead to an empty content of the file.
+DEAL_II_NAMESPACE_OPEN
+DEAL_II_NAMESPACE_CLOSE
+
 #endif
 #endif
index 5483eddc4ec5cb46bb69c39139a15c17406d773f..c02bd9d2feff821c33164e98080d60c169e5f83c 100644 (file)
@@ -129,5 +129,13 @@ namespace ArborXWrappers
 
 DEAL_II_NAMESPACE_CLOSE
 
+#else
+
+// Make sure the scripts that create the C++20 module input files have
+// something to latch on if the preprocessor #ifdef above would
+// otherwise lead to an empty content of the file.
+DEAL_II_NAMESPACE_OPEN
+DEAL_II_NAMESPACE_CLOSE
+
 #endif
 #endif
index 3a56efb0d9ef1cc5b35c86dc1572a8d0452cd35b..c8ac2f09f75bb0473df15e3c1f46aa6733076278 100644 (file)
@@ -135,6 +135,14 @@ namespace Functions
 
 DEAL_II_NAMESPACE_CLOSE
 
+#else
+
+// Make sure the scripts that create the C++20 module input files have
+// something to latch on if the preprocessor #ifdef above would
+// otherwise lead to an empty content of the file.
+DEAL_II_NAMESPACE_OPEN
+DEAL_II_NAMESPACE_CLOSE
+
 #endif
 
 #endif
index 888833edb210726beb2ce3027728c42a9527fdf9..7b2d7c5e16dddf06bcca04af63e1adfd15a7b087 100644 (file)
@@ -2253,6 +2253,14 @@ namespace HDF5
 DEAL_II_NAMESPACE_CLOSE
 
 
+#else
+
+// Make sure the scripts that create the C++20 module input files have
+// something to latch on if the preprocessor #ifdef above would
+// otherwise lead to an empty content of the file.
+DEAL_II_NAMESPACE_OPEN
+DEAL_II_NAMESPACE_CLOSE
+
 #endif // DEAL_II_WITH_HDF5
 
 #endif // dealii_hdf5_h
index d7848a7938f21c2f1ca208365a8b4c447b6c4dd1..61e499c85894637151a148c59e2fc893a402f9e4 100644 (file)
@@ -447,5 +447,13 @@ namespace Utilities
 
 DEAL_II_NAMESPACE_CLOSE
 
+#else
+
+// Make sure the scripts that create the C++20 module input files have
+// something to latch on if the preprocessor #ifdef above would
+// otherwise lead to an empty content of the file.
+DEAL_II_NAMESPACE_OPEN
+DEAL_II_NAMESPACE_CLOSE
+
 #endif
 #endif
index c9deac26a50b88474cd83f216bf6947a0a8cf442..31b28534df42d0d8fb3caf383495400fba5dbe02 100644 (file)
@@ -262,6 +262,14 @@ namespace Utilities
 
 DEAL_II_NAMESPACE_CLOSE
 
+#else
+
+// Make sure the scripts that create the C++20 module input files have
+// something to latch on if the preprocessor #ifdef above would
+// otherwise lead to an empty content of the file.
+DEAL_II_NAMESPACE_OPEN
+DEAL_II_NAMESPACE_CLOSE
+
 #endif // DEAL_II_WITH_SCALAPACK
 
 #endif
index 20244854e270526cb3e4244a0e44123897bd64f3..a19fc877b22430921048e95f1c2683e6f0d7826a 100644 (file)
@@ -100,5 +100,13 @@ namespace CGALWrappers
 
 DEAL_II_NAMESPACE_CLOSE
 
+#else
+
+// Make sure the scripts that create the C++20 module input files have
+// something to latch on if the preprocessor #ifdef above would
+// otherwise lead to an empty content of the file.
+DEAL_II_NAMESPACE_OPEN
+DEAL_II_NAMESPACE_CLOSE
+
 #endif
 #endif
index 6f50ee388ea689620c56cfe474f743ea25dda6a2..17fa1a6796cd056c3d15a0fe71f8571de4e9b7f7 100644 (file)
@@ -91,6 +91,14 @@ namespace CGALWrappers
 
 
 
+DEAL_II_NAMESPACE_CLOSE
+
+#else
+
+// Make sure the scripts that create the C++20 module input files have
+// something to latch on if the preprocessor #ifdef above would
+// otherwise lead to an empty content of the file.
+DEAL_II_NAMESPACE_OPEN
 DEAL_II_NAMESPACE_CLOSE
 
 #endif
index 97089e0f2a624fddd3ba93ed912d2e1cd6e679c5..3f86bce32c5932c261cd05ece5708516b523f122 100644 (file)
@@ -564,5 +564,13 @@ namespace CGALWrappers
 
 DEAL_II_NAMESPACE_CLOSE
 
+#else
+
+// Make sure the scripts that create the C++20 module input files have
+// something to latch on if the preprocessor #ifdef above would
+// otherwise lead to an empty content of the file.
+DEAL_II_NAMESPACE_OPEN
+DEAL_II_NAMESPACE_CLOSE
+
 #endif
 #endif
index a1cdb2a43e5b73de24e4106b6feddc768c180999..91723dbd99d9cd806e3ddef94d1d56688fac8b46 100644 (file)
@@ -692,5 +692,13 @@ namespace CGALWrappers
 
 DEAL_II_NAMESPACE_CLOSE
 
+#else
+
+// Make sure the scripts that create the C++20 module input files have
+// something to latch on if the preprocessor #ifdef above would
+// otherwise lead to an empty content of the file.
+DEAL_II_NAMESPACE_OPEN
+DEAL_II_NAMESPACE_CLOSE
+
 #endif
 #endif
index 4fd48e5c9645c1db3179af1f60c967f97b49e356..ad14e6f69f4dfcdceda2db8e89bee41ea0bb8fd2 100644 (file)
@@ -4137,6 +4137,14 @@ namespace Differentiation
 
 DEAL_II_NAMESPACE_CLOSE
 
+#else
+
+// Make sure the scripts that create the C++20 module input files have
+// something to latch on if the preprocessor #ifdef above would
+// otherwise lead to an empty content of the file.
+DEAL_II_NAMESPACE_OPEN
+DEAL_II_NAMESPACE_CLOSE
+
 #endif // defined(DEAL_II_WITH_ADOLC) || defined(DEAL_II_TRILINOS_WITH_SACADO)
 
 #endif // dealii_differentiation_ad_ad_helpers_h
index a4127a0ad7ad2a9289ad07e9a60689d46bd807e5..e221c9a761e79c75a8c6b8ed11a34eb394ca68ea 100644 (file)
@@ -76,6 +76,14 @@ abs(const adtl::adouble &x)
 DEAL_II_NAMESPACE_CLOSE
 #  endif // DOXYGEN
 
+#else
+
+// Make sure the scripts that create the C++20 module input files have
+// something to latch on if the preprocessor #ifdef above would
+// otherwise lead to an empty content of the file.
+DEAL_II_NAMESPACE_OPEN
+DEAL_II_NAMESPACE_CLOSE
+
 #endif // DEAL_II_WITH_ADOLC
 
 #endif
index e69f46b5d45b5afd027d604ce07721db1e95b442..ca679a47fff32a2a22ed361ccb08676172856bcb 100644 (file)
@@ -274,6 +274,14 @@ struct EnableIfScalar<std::complex<adtl::adouble>>
 
 DEAL_II_NAMESPACE_CLOSE
 
+#else
+
+// Make sure the scripts that create the C++20 module input files have
+// something to latch on if the preprocessor #ifdef above would
+// otherwise lead to an empty content of the file.
+DEAL_II_NAMESPACE_OPEN
+DEAL_II_NAMESPACE_CLOSE
+
 #endif // DEAL_II_WITH_ADOLC
 
 #endif
index 17a6c4195b75c36050ad45d5afd315ed1b5d70b8..e9c7e1adffba51462caff54aa607515aef816093 100644 (file)
@@ -93,6 +93,14 @@ DEAL_II_NAMESPACE_CLOSE
 
 #  endif // DOXYGEN
 
+#else
+
+// Make sure the scripts that create the C++20 module input files have
+// something to latch on if the preprocessor #ifdef above would
+// otherwise lead to an empty content of the file.
+DEAL_II_NAMESPACE_OPEN
+DEAL_II_NAMESPACE_CLOSE
+
 #endif // DEAL_II_TRILINOS_WITH_SACADO
 
 #endif
index 9b7c1bbf1e4ef5d5723f63775c66738ddd692b14..0fd0768a7d62ca4c6dae4fa6811e9b66d7f954ab 100644 (file)
@@ -253,6 +253,14 @@ struct EnableIfScalar<Sacado::Rad::ADvari<T>>
 
 DEAL_II_NAMESPACE_CLOSE
 
+#else
+
+// Make sure the scripts that create the C++20 module input files have
+// something to latch on if the preprocessor #ifdef above would
+// otherwise lead to an empty content of the file.
+DEAL_II_NAMESPACE_OPEN
+DEAL_II_NAMESPACE_CLOSE
+
 #endif // DEAL_II_TRILINOS_WITH_SACADO
 
 #endif
index 0a3caafaaf5a80131abccb9308c5bd42b1f08edf..68b85a2fe62a5dc6eef25ccacccebf3033b104d2 100644 (file)
@@ -53,6 +53,14 @@ namespace Differentiation
 
 DEAL_II_NAMESPACE_CLOSE
 
+#else
+
+// Make sure the scripts that create the C++20 module input files have
+// something to latch on if the preprocessor #ifdef above would
+// otherwise lead to an empty content of the file.
+DEAL_II_NAMESPACE_OPEN
+DEAL_II_NAMESPACE_CLOSE
+
 #endif // DEAL_II_WITH_SYMENGINE
 
 #endif // dealii_differentiation_sd_h
index c5f91cd4878a4250eabcdd2baf12c545d5b134af..2cde6f4e38504189cac80380ef168fbb2590274c 100644 (file)
@@ -776,6 +776,14 @@ namespace std
 
 #  endif // DOXYGEN
 
+#else
+
+// Make sure the scripts that create the C++20 module input files have
+// something to latch on if the preprocessor #ifdef above would
+// otherwise lead to an empty content of the file.
+DEAL_II_NAMESPACE_OPEN
+DEAL_II_NAMESPACE_CLOSE
+
 #endif // DEAL_II_WITH_SYMENGINE
 
 #endif
index 0d297be97db27c979fdc89ccaa9efb41e0f6b9c6..389aea6b0cb9f89aa4a1d3085b20959e8d3b78ed 100644 (file)
@@ -81,6 +81,14 @@ namespace Differentiation
 
 DEAL_II_NAMESPACE_CLOSE
 
+#else
+
+// Make sure the scripts that create the C++20 module input files have
+// something to latch on if the preprocessor #ifdef above would
+// otherwise lead to an empty content of the file.
+DEAL_II_NAMESPACE_OPEN
+DEAL_II_NAMESPACE_CLOSE
+
 #endif // DEAL_II_WITH_SYMENGINE
 
 #endif // dealii_differentiation_sd_symengine_number_traits_h
index a6c279786d3d5b5b88566a08210f5de81cf9c3a4..48933c47119b5b7eaffe5f155ce806bcc5522dd2 100644 (file)
@@ -1448,6 +1448,14 @@ namespace numbers
 
 DEAL_II_NAMESPACE_CLOSE
 
+#else
+
+// Make sure the scripts that create the C++20 module input files have
+// something to latch on if the preprocessor #ifdef above would
+// otherwise lead to an empty content of the file.
+DEAL_II_NAMESPACE_OPEN
+DEAL_II_NAMESPACE_CLOSE
+
 #endif // DEAL_II_WITH_SYMENGINE
 
 #endif // dealii_differentiation_sd_symengine_number_types_h
index 57aaaf58310ef212129d3cf15075a3bab82221d8..108c4d56ce348368c93f8c6932fa56ab175e091f 100644 (file)
@@ -1003,6 +1003,14 @@ namespace Differentiation
 
 DEAL_II_NAMESPACE_CLOSE
 
+#else
+
+// Make sure the scripts that create the C++20 module input files have
+// something to latch on if the preprocessor #ifdef above would
+// otherwise lead to an empty content of the file.
+DEAL_II_NAMESPACE_OPEN
+DEAL_II_NAMESPACE_CLOSE
+
 #endif // DEAL_II_WITH_SYMENGINE
 
 #endif // dealii_differentiation_sd_symengine_number_visitor_internal_h
index 59dfdbe6ae7e8f6242fe4f5713e2a5c2c2fc08ba..8b967a50dc145088502e4d89b7ae956bdb9c0bc2 100644 (file)
@@ -2572,6 +2572,14 @@ namespace Differentiation
 
 DEAL_II_NAMESPACE_CLOSE
 
+#else
+
+// Make sure the scripts that create the C++20 module input files have
+// something to latch on if the preprocessor #ifdef above would
+// otherwise lead to an empty content of the file.
+DEAL_II_NAMESPACE_OPEN
+DEAL_II_NAMESPACE_CLOSE
+
 #endif // DEAL_II_WITH_SYMENGINE
 
 #endif
index b4d0e109db373bbc64990f72f1aa75d4636cfb14..8eee93b683b11113e6e792833510cb5ee943a697 100644 (file)
@@ -129,6 +129,14 @@ namespace internal
 
 DEAL_II_NAMESPACE_CLOSE
 
+#else
+
+// Make sure the scripts that create the C++20 module input files have
+// something to latch on if the preprocessor #ifdef above would
+// otherwise lead to an empty content of the file.
+DEAL_II_NAMESPACE_OPEN
+DEAL_II_NAMESPACE_CLOSE
+
 #endif // DEAL_II_WITH_SYMENGINE
 
 #endif
index 392bce7e5967ebd2d3aaa58cd789296ef28317cb..d79ce546857ab6a65f4db112a0078bac3638f03c 100644 (file)
@@ -1928,6 +1928,14 @@ namespace Differentiation
 
 DEAL_II_NAMESPACE_CLOSE
 
+#else
+
+// Make sure the scripts that create the C++20 module input files have
+// something to latch on if the preprocessor #ifdef above would
+// otherwise lead to an empty content of the file.
+DEAL_II_NAMESPACE_OPEN
+DEAL_II_NAMESPACE_CLOSE
+
 #endif // DEAL_II_WITH_SYMENGINE
 
 #endif
index 2c8d7e9a8ed9bfb66e7d7ed4896d4ef4bf7436e5..f39392633e92c8eeb8953fa3a3a2166379a12546 100644 (file)
@@ -1570,6 +1570,14 @@ namespace Differentiation
 
 DEAL_II_NAMESPACE_CLOSE
 
+#else
+
+// Make sure the scripts that create the C++20 module input files have
+// something to latch on if the preprocessor #ifdef above would
+// otherwise lead to an empty content of the file.
+DEAL_II_NAMESPACE_OPEN
+DEAL_II_NAMESPACE_CLOSE
+
 #endif // DEAL_II_WITH_SYMENGINE
 
 #endif
index f634453bf41b9b271665ba9292b72e57ec82a727..c657752d574093991c3624d192afc323f81811fd 100644 (file)
@@ -100,6 +100,14 @@ namespace boost
 
 #  endif // DOXYGEN
 
+#else
+
+// Make sure the scripts that create the C++20 module input files have
+// something to latch on if the preprocessor #ifdef above would
+// otherwise lead to an empty content of the file.
+DEAL_II_NAMESPACE_OPEN
+DEAL_II_NAMESPACE_CLOSE
+
 #endif // DEAL_II_WITH_SYMENGINE
 
 #endif // dealii_differentiation_sd_symengine_types_h
index 029c3e49fee7933c8f7b074da0dab616f611076b..03f0cb5f4fc9141efd08bc59b04dd9f2a8c8a5ba 100644 (file)
@@ -162,6 +162,14 @@ namespace Differentiation
 
 DEAL_II_NAMESPACE_CLOSE
 
+#else
+
+// Make sure the scripts that create the C++20 module input files have
+// something to latch on if the preprocessor #ifdef above would
+// otherwise lead to an empty content of the file.
+DEAL_II_NAMESPACE_OPEN
+DEAL_II_NAMESPACE_CLOSE
+
 #endif // DEAL_II_WITH_SYMENGINE
 
 #endif // dealii_differentiation_sd_symengine_utilities_h
index ebbb1a856ba57f60acbe1fcdb81fd3764e4b19fb..0aadb157157a62f6816cdf4a2ba290f6c66dd513 100644 (file)
@@ -366,6 +366,14 @@ namespace parallel
 
 DEAL_II_NAMESPACE_CLOSE
 
+#else
+
+// Make sure the scripts that create the C++20 module input files have
+// something to latch on if the preprocessor #ifdef above would
+// otherwise lead to an empty content of the file.
+DEAL_II_NAMESPACE_OPEN
+DEAL_II_NAMESPACE_CLOSE
+
 #endif /* DEAL_II_WITH_P4EST */
 
 #endif /* dealii_distributed_cell_data_transfer_templates_h */
index 44e9b95665b3fbf5dcaa07b8e7caad7cd7f9d863..9f16e59e1cadba6548b58bff2ba566862aaf6512 100644 (file)
@@ -643,6 +643,14 @@ namespace internal
 
 DEAL_II_NAMESPACE_CLOSE
 
+#else
+
+// Make sure the scripts that create the C++20 module input files have
+// something to latch on if the preprocessor #ifdef above would
+// otherwise lead to an empty content of the file.
+DEAL_II_NAMESPACE_OPEN
+DEAL_II_NAMESPACE_CLOSE
+
 #endif // DEAL_II_WITH_P4EST
 
 #endif // dealii_p4est_wrappers_h
index 4f4e43ed07bad041f306563b4dae6205e2109ee4..f5e6770e465f6d95883e8223df0656f049778c07 100644 (file)
@@ -98,5 +98,13 @@ namespace Gmsh
 
 DEAL_II_NAMESPACE_CLOSE
 
+#else
+
+// Make sure the scripts that create the C++20 module input files have
+// something to latch on if the preprocessor #ifdef above would
+// otherwise lead to an empty content of the file.
+DEAL_II_NAMESPACE_OPEN
+DEAL_II_NAMESPACE_CLOSE
+
 #endif
 #endif
index 0a23be77bfd4d58ac097519865092767820fd9e7..5ac9faad3077ec4516f5b72704aaf695c38a7e2f 100644 (file)
@@ -899,5 +899,13 @@ ArpackSolver::control() const
 DEAL_II_NAMESPACE_CLOSE
 
 
+#else
+
+// Make sure the scripts that create the C++20 module input files have
+// something to latch on if the preprocessor #ifdef above would
+// otherwise lead to an empty content of the file.
+DEAL_II_NAMESPACE_OPEN
+DEAL_II_NAMESPACE_CLOSE
+
 #endif
 #endif
index 835e2a7e0a03bb518c62d0a722a69d9266911dbc..c6899749bb29ad0bfe399beff5402fd7b905cf2f 100644 (file)
@@ -557,6 +557,14 @@ namespace GinkgoWrappers
 
 DEAL_II_NAMESPACE_CLOSE
 
+#else
+
+// Make sure the scripts that create the C++20 module input files have
+// something to latch on if the preprocessor #ifdef above would
+// otherwise lead to an empty content of the file.
+DEAL_II_NAMESPACE_OPEN
+DEAL_II_NAMESPACE_CLOSE
+
 #endif // DEAL_II_WITH_GINKGO
 
 #endif
index bf37e51a3f82a3da84b81d941fe6fc4137f2cac9..f4a984c2724cd261710cad7667f787eb57d65136 100644 (file)
@@ -1164,5 +1164,13 @@ PArpackSolver<VectorType>::control() const
 DEAL_II_NAMESPACE_CLOSE
 
 
+#else
+
+// Make sure the scripts that create the C++20 module input files have
+// something to latch on if the preprocessor #ifdef above would
+// otherwise lead to an empty content of the file.
+DEAL_II_NAMESPACE_OPEN
+DEAL_II_NAMESPACE_CLOSE
+
 #endif
 #endif
index 9c301b43bb5549de2f0d217639014547a2fd285b..6e6696f160ab8d2aff2f2b5addb7c0bb2c76a42b 100644 (file)
@@ -473,6 +473,14 @@ namespace PETScWrappers
 DEAL_II_NAMESPACE_CLOSE
 
 
+#else
+
+// Make sure the scripts that create the C++20 module input files have
+// something to latch on if the preprocessor #ifdef above would
+// otherwise lead to an empty content of the file.
+DEAL_II_NAMESPACE_OPEN
+DEAL_II_NAMESPACE_CLOSE
+
 #endif // DEAL_II_WITH_PETSC
 
 #endif // dealii_petsc_block_sparse_matrix_h
index 067cb79a80ed8510ebc3718d42bcc0c5af666ccd..e036c895a17e1a27adcdcb626b19491f6a101d5d 100644 (file)
@@ -723,6 +723,14 @@ struct is_serial_vector<PETScWrappers::MPI::BlockVector> : std::false_type
 
 DEAL_II_NAMESPACE_CLOSE
 
+#else
+
+// Make sure the scripts that create the C++20 module input files have
+// something to latch on if the preprocessor #ifdef above would
+// otherwise lead to an empty content of the file.
+DEAL_II_NAMESPACE_OPEN
+DEAL_II_NAMESPACE_CLOSE
+
 #endif // DEAL_II_WITH_PETSC
 
 #endif
index 6c718f26e71cc264fb894725bfcac9578f06c003..f4e02a8708fc9a120b61731422ff17ff4413eafe 100644 (file)
@@ -369,6 +369,14 @@ namespace PETScWrappers
 
 DEAL_II_NAMESPACE_CLOSE
 
+#else
+
+// Make sure the scripts that create the C++20 module input files have
+// something to latch on if the preprocessor #ifdef above would
+// otherwise lead to an empty content of the file.
+DEAL_II_NAMESPACE_OPEN
+DEAL_II_NAMESPACE_CLOSE
+
 #endif
 
 #endif
index c9e345ba996250d1df019723f0be566896377755..77095332e06bc5ee65373688ed7626a787f240db 100644 (file)
@@ -216,5 +216,13 @@ namespace PETScWrappers
 
 DEAL_II_NAMESPACE_CLOSE
 
+#else
+
+// Make sure the scripts that create the C++20 module input files have
+// something to latch on if the preprocessor #ifdef above would
+// otherwise lead to an empty content of the file.
+DEAL_II_NAMESPACE_OPEN
+DEAL_II_NAMESPACE_CLOSE
+
 #endif // DEAL_II_WITH_PETSC
 #endif // dealii_petsc_compatibility_h
index 01e6eca1d8503733ff422d41e1118ff824065dce..ab7e5fc73f13c92e262c749d76d7b5fc18ae77f1 100644 (file)
@@ -91,6 +91,14 @@ namespace PETScWrappers
 
 DEAL_II_NAMESPACE_CLOSE
 
+#else
+
+// Make sure the scripts that create the C++20 module input files have
+// something to latch on if the preprocessor #ifdef above would
+// otherwise lead to an empty content of the file.
+DEAL_II_NAMESPACE_OPEN
+DEAL_II_NAMESPACE_CLOSE
+
 #endif // DEAL_II_WITH_PETSC
 
 #endif
index c4b116978e12481fd788d1a8d706457398cf6248..ad2d7143e1cafb97a78c6e5eaa34a1bb47719ad8 100644 (file)
@@ -1668,6 +1668,14 @@ namespace PETScWrappers
 DEAL_II_NAMESPACE_CLOSE
 
 
+#else
+
+// Make sure the scripts that create the C++20 module input files have
+// something to latch on if the preprocessor #ifdef above would
+// otherwise lead to an empty content of the file.
+DEAL_II_NAMESPACE_OPEN
+DEAL_II_NAMESPACE_CLOSE
+
 #endif // DEAL_II_WITH_PETSC
 
 #endif
index 200bfdfd491cda837d5b591620d6702c2107cbe3..1b26d7622806c723643b64c91c3386f91ddf7ee7 100644 (file)
@@ -278,6 +278,14 @@ namespace PETScWrappers
 
 DEAL_II_NAMESPACE_CLOSE
 
+#else
+
+// Make sure the scripts that create the C++20 module input files have
+// something to latch on if the preprocessor #ifdef above would
+// otherwise lead to an empty content of the file.
+DEAL_II_NAMESPACE_OPEN
+DEAL_II_NAMESPACE_CLOSE
+
 #endif // DEAL_II_WITH_PETSC
 
 #endif
index 9d5e117be8ca1c4680c2fe59b7b8ec7d18f257c5..d9d0be1034d005d060c16cc896f47145541ac7ac 100644 (file)
@@ -1164,6 +1164,14 @@ namespace PETScWrappers
 DEAL_II_NAMESPACE_CLOSE
 
 
+#else
+
+// Make sure the scripts that create the C++20 module input files have
+// something to latch on if the preprocessor #ifdef above would
+// otherwise lead to an empty content of the file.
+DEAL_II_NAMESPACE_OPEN
+DEAL_II_NAMESPACE_CLOSE
+
 #endif // DEAL_II_WITH_PETSC
 
 #endif
index 324de0ba51eb0d0fe931aa6dd912f046cb5c7e4e..55d14583a47cf8889a343653782a9eaa654bfd13 100644 (file)
@@ -492,6 +492,14 @@ namespace PETScWrappers
 
 DEAL_II_NAMESPACE_CLOSE
 
+#else
+
+// Make sure the scripts that create the C++20 module input files have
+// something to latch on if the preprocessor #ifdef above would
+// otherwise lead to an empty content of the file.
+DEAL_II_NAMESPACE_OPEN
+DEAL_II_NAMESPACE_CLOSE
+
 #endif // DEAL_II_WITH_PETSC
 
 #endif
index 3d343d9cb5702b236414c1623f6f70d5c5b3ca35..73d88d828fd4b1b0c837e6c32974ffdf940d3164 100644 (file)
@@ -707,6 +707,14 @@ namespace PETScWrappers
 
 DEAL_II_NAMESPACE_CLOSE
 
+#else
+
+// Make sure the scripts that create the C++20 module input files have
+// something to latch on if the preprocessor #ifdef above would
+// otherwise lead to an empty content of the file.
+DEAL_II_NAMESPACE_OPEN
+DEAL_II_NAMESPACE_CLOSE
+
 #endif // DEAL_II_WITH_PETSC
 
 #endif
index 350d8005e929dbf97249f3b526d337ba16227abb..eb9c78b0c04eb8f600563ac1ca5d3b84ae9b861a 100644 (file)
@@ -977,6 +977,14 @@ namespace PETScWrappers
 
 DEAL_II_NAMESPACE_CLOSE
 
+#else
+
+// Make sure the scripts that create the C++20 module input files have
+// something to latch on if the preprocessor #ifdef above would
+// otherwise lead to an empty content of the file.
+DEAL_II_NAMESPACE_OPEN
+DEAL_II_NAMESPACE_CLOSE
+
 #endif // DEAL_II_WITH_PETSC
 
 #endif
index 7b4ddf05ea0ce2defbed66ad5f59a7b7a27ea015..064ef82f4ac8375ab35ff6f6bf6fe315d7b0a1e2 100644 (file)
@@ -664,6 +664,14 @@ namespace PETScWrappers
 
 DEAL_II_NAMESPACE_CLOSE
 
+#else
+
+// Make sure the scripts that create the C++20 module input files have
+// something to latch on if the preprocessor #ifdef above would
+// otherwise lead to an empty content of the file.
+DEAL_II_NAMESPACE_OPEN
+DEAL_II_NAMESPACE_CLOSE
+
 #endif // DEAL_II_WITH_PETSC
 
 #endif
index d7bce504d1bc5491cbf0828818b3d1881cc64caa..d7c801fdb5c341ddf08cfc6caf9bb8b52ac77ea7 100644 (file)
@@ -777,6 +777,14 @@ namespace PETScWrappers
 
 DEAL_II_NAMESPACE_CLOSE
 
+#else
+
+// Make sure the scripts that create the C++20 module input files have
+// something to latch on if the preprocessor #ifdef above would
+// otherwise lead to an empty content of the file.
+DEAL_II_NAMESPACE_OPEN
+DEAL_II_NAMESPACE_CLOSE
+
 #endif // DEAL_II_WITH_PETSC
 
 #endif
index a292f466784bf5350960924021eb6abda763b7fd..eab98b3b024a501f64456a735d77667ea4612ed9 100644 (file)
@@ -1326,6 +1326,14 @@ namespace PETScWrappers
 
 DEAL_II_NAMESPACE_CLOSE
 
+#else
+
+// Make sure the scripts that create the C++20 module input files have
+// something to latch on if the preprocessor #ifdef above would
+// otherwise lead to an empty content of the file.
+DEAL_II_NAMESPACE_OPEN
+DEAL_II_NAMESPACE_CLOSE
+
 #endif // DEAL_II_WITH_PETSC
 
 #endif
index c3045925483b9ac9ed8eebe8e8f0b15b153ed673..d98a8f48bbc078c3298b6a13ee0b21aa91530f17 100644 (file)
@@ -574,6 +574,14 @@ struct is_serial_vector<PETScWrappers::MPI::Vector> : std::false_type
 
 DEAL_II_NAMESPACE_CLOSE
 
+#else
+
+// Make sure the scripts that create the C++20 module input files have
+// something to latch on if the preprocessor #ifdef above would
+// otherwise lead to an empty content of the file.
+DEAL_II_NAMESPACE_OPEN
+DEAL_II_NAMESPACE_CLOSE
+
 #endif // DEAL_II_WITH_PETSC
 
 #endif
index 8e0b7778730ee1add3dedc7bfc9b8bc1298731ab..54946d375ec6bb873bc12cdc7185a0f79a837f5d 100644 (file)
@@ -1379,6 +1379,14 @@ namespace PETScWrappers
 
 DEAL_II_NAMESPACE_CLOSE
 
+#else
+
+// Make sure the scripts that create the C++20 module input files have
+// something to latch on if the preprocessor #ifdef above would
+// otherwise lead to an empty content of the file.
+DEAL_II_NAMESPACE_OPEN
+DEAL_II_NAMESPACE_CLOSE
+
 #endif // DEAL_II_WITH_PETSC
 
 #endif
index 0ad740d815a32d00152691f769c3c2bf2bbfe578..7420b880b61803218f5b4f510811110bbe724dd7 100644 (file)
@@ -1047,6 +1047,14 @@ ScaLAPACKMatrix<NumberType>::local_n() const
 
 DEAL_II_NAMESPACE_CLOSE
 
+#else
+
+// Make sure the scripts that create the C++20 module input files have
+// something to latch on if the preprocessor #ifdef above would
+// otherwise lead to an empty content of the file.
+DEAL_II_NAMESPACE_OPEN
+DEAL_II_NAMESPACE_CLOSE
+
 #endif // DEAL_II_WITH_SCALAPACK
 
 #endif
index a4c85b825ace7bf7798de377e9903b0b792f5beb..c51c98ace2db438674721083313a4538613ee8cd 100644 (file)
@@ -855,6 +855,14 @@ namespace SLEPcWrappers
 
 DEAL_II_NAMESPACE_CLOSE
 
+#  else
+
+// Make sure the scripts that create the C++20 module input files have
+// something to latch on if the preprocessor #ifdef above would
+// otherwise lead to an empty content of the file.
+DEAL_II_NAMESPACE_OPEN
+DEAL_II_NAMESPACE_CLOSE
+
 #  endif // DEAL_II_WITH_SLEPC
 
 /*----------------------------   slepc_solver.h  ---------------------------*/
index d1ed243b8a51ea763a7fca43bb7a6b9ec59b6090..1f94f95fdf67d1000a13d44651a60a289ffe3846 100644 (file)
@@ -247,6 +247,14 @@ namespace SLEPcWrappers
 
 DEAL_II_NAMESPACE_CLOSE
 
+#  else
+
+// Make sure the scripts that create the C++20 module input files have
+// something to latch on if the preprocessor #ifdef above would
+// otherwise lead to an empty content of the file.
+DEAL_II_NAMESPACE_OPEN
+DEAL_II_NAMESPACE_CLOSE
+
 #  endif // DEAL_II_WITH_SLEPC
 
 /*--------------------   slepc_spectral_transformation.h   ------------------*/
index ff888c6a5e15ad9bc1623c365e416ddf09559615..240596e5656f5e0ff2dbdc11352da5e23e48fc4d 100644 (file)
@@ -616,6 +616,14 @@ namespace TrilinosWrappers
 
 DEAL_II_NAMESPACE_CLOSE
 
+#else
+
+// Make sure the scripts that create the C++20 module input files have
+// something to latch on if the preprocessor #ifdef above would
+// otherwise lead to an empty content of the file.
+DEAL_II_NAMESPACE_OPEN
+DEAL_II_NAMESPACE_CLOSE
+
 #endif // DEAL_II_WITH_TRILINOS
 
 #endif // dealii_trilinos_block_sparse_matrix_h
index 4b98a5e68d2a472c00dbe89e75fac5fcdfd4e74b..0755dc109d67e8e3e40f762e3e22495c845c9787 100644 (file)
@@ -103,6 +103,14 @@ namespace LinearAlgebra
 
 DEAL_II_NAMESPACE_CLOSE
 
+#else
+
+// Make sure the scripts that create the C++20 module input files have
+// something to latch on if the preprocessor #ifdef above would
+// otherwise lead to an empty content of the file.
+DEAL_II_NAMESPACE_OPEN
+DEAL_II_NAMESPACE_CLOSE
+
 #endif
 
 #endif
index 4f06d7808e4cec445bd46b26db98d4de50eb74a3..56d79202b0ac119f8d82681bdbd854b846a6b58b 100644 (file)
@@ -823,6 +823,14 @@ struct is_serial_vector<LinearAlgebra::EpetraWrappers::Vector> : std::false_type
 
 DEAL_II_NAMESPACE_CLOSE
 
+#else
+
+// Make sure the scripts that create the C++20 module input files have
+// something to latch on if the preprocessor #ifdef above would
+// otherwise lead to an empty content of the file.
+DEAL_II_NAMESPACE_OPEN
+DEAL_II_NAMESPACE_CLOSE
+
 #endif
 
 #endif
index ca6e05c98815d17e98d1599637337172fb98d9e3..829cd8bd1f4ed76ace3922a549d3a1b2aabbce51 100644 (file)
@@ -197,5 +197,14 @@ namespace TrilinosWrappers
 } // namespace TrilinosWrappers
 
 DEAL_II_NAMESPACE_CLOSE
+
+#else
+
+// Make sure the scripts that create the C++20 module input files have
+// something to latch on if the preprocessor #ifdef above would
+// otherwise lead to an empty content of the file.
+DEAL_II_NAMESPACE_OPEN
+DEAL_II_NAMESPACE_CLOSE
+
 #endif // DEAL_II_WITH_TRILINOS
 #endif // dealii_trilinos_index_access_h
index 54e66a909042252c9397f963b1299b976f868798..9c6d6444e8d16a122ea97bf368fa8b0a86e53199 100644 (file)
@@ -307,5 +307,13 @@ namespace TrilinosWrappers
 
 DEAL_II_NAMESPACE_CLOSE
 
+#else
+
+// Make sure the scripts that create the C++20 module input files have
+// something to latch on if the preprocessor #ifdef above would
+// otherwise lead to an empty content of the file.
+DEAL_II_NAMESPACE_OPEN
+DEAL_II_NAMESPACE_CLOSE
+
 #endif // DEAL_II_WITH_TRILINOS
 #endif
index 03344d0378156fe92172f9e05ba39a23bd6f5cd7..a6135df50c96116a4b18224f70e36e7010c27cce 100644 (file)
@@ -507,6 +507,14 @@ struct is_serial_vector<TrilinosWrappers::MPI::BlockVector> : std::false_type
 
 DEAL_II_NAMESPACE_CLOSE
 
+#else
+
+// Make sure the scripts that create the C++20 module input files have
+// something to latch on if the preprocessor #ifdef above would
+// otherwise lead to an empty content of the file.
+DEAL_II_NAMESPACE_OPEN
+DEAL_II_NAMESPACE_CLOSE
+
 #endif // DEAL_II_WITH_TRILINOS
 
 #endif
index 9e55ce883077c71cd7395c825024b1dd7e3c1cc3..a405f1f5d8421a90fe78ca5416c736da7ad91b5c 100644 (file)
@@ -2179,6 +2179,14 @@ namespace TrilinosWrappers
 
 DEAL_II_NAMESPACE_CLOSE
 
+#else
+
+// Make sure the scripts that create the C++20 module input files have
+// something to latch on if the preprocessor #ifdef above would
+// otherwise lead to an empty content of the file.
+DEAL_II_NAMESPACE_OPEN
+DEAL_II_NAMESPACE_CLOSE
+
 #endif // DEAL_II_WITH_TRILINOS
 
 #endif
index ce27cac78a178cf1f91ad4420c57fa542efdb6a0..34148600f9fe8dbf89bfe8b15ff1209d74f5fcab 100644 (file)
@@ -1393,6 +1393,14 @@ namespace TrilinosWrappers
 
 DEAL_II_NAMESPACE_CLOSE
 
+#else
+
+// Make sure the scripts that create the C++20 module input files have
+// something to latch on if the preprocessor #ifdef above would
+// otherwise lead to an empty content of the file.
+DEAL_II_NAMESPACE_OPEN
+DEAL_II_NAMESPACE_CLOSE
+
 #endif // DEAL_II_WITH_TRILINOS
 
 #endif
index b4dbf2321328c356e5f0170e0cb569b486424995..2105ad8fb2f18bd266816fff0e4516d3bbd269e6 100644 (file)
@@ -3335,6 +3335,14 @@ namespace TrilinosWrappers
 DEAL_II_NAMESPACE_CLOSE
 
 
+#  else
+
+// Make sure the scripts that create the C++20 module input files have
+// something to latch on if the preprocessor #ifdef above would
+// otherwise lead to an empty content of the file.
+DEAL_II_NAMESPACE_OPEN
+DEAL_II_NAMESPACE_CLOSE
+
 #  endif // DEAL_II_WITH_TRILINOS
 
 
index 96225f98e72cbb481a51deaf081c7ca721afdd22..648dd8a2749f2500be1431ee72f0aed5b8558f53 100644 (file)
@@ -1326,6 +1326,14 @@ namespace TrilinosWrappers
 DEAL_II_NAMESPACE_CLOSE
 
 
+#else
+
+// Make sure the scripts that create the C++20 module input files have
+// something to latch on if the preprocessor #ifdef above would
+// otherwise lead to an empty content of the file.
+DEAL_II_NAMESPACE_OPEN
+DEAL_II_NAMESPACE_CLOSE
+
 #endif // DEAL_II_WITH_TRILINOS
 
 #endif
index c1b9683ec3f89218a5fcd8cdb2fcd1bbea86f906..72f274555074b9e5acdb5cfa6b8358e7b92f94b3 100644 (file)
@@ -457,6 +457,14 @@ namespace LinearAlgebra
 
 DEAL_II_NAMESPACE_CLOSE
 
+#else
+
+// Make sure the scripts that create the C++20 module input files have
+// something to latch on if the preprocessor #ifdef above would
+// otherwise lead to an empty content of the file.
+DEAL_II_NAMESPACE_OPEN
+DEAL_II_NAMESPACE_CLOSE
+
 #endif // DEAL_II_TRILINOS_WITH_TPETRA
 
 #endif // dealii_tpetra_trilinos_block_sparse_matrix_h
index c1a32f66b5c58ba4872ddff893a1447ae0b7acbf..77808bc4cd9290fdc106d99ddd6e71d7aaa6980c 100644 (file)
@@ -337,6 +337,14 @@ namespace LinearAlgebra
 
 DEAL_II_NAMESPACE_CLOSE
 
+#else
+
+// Make sure the scripts that create the C++20 module input files have
+// something to latch on if the preprocessor #ifdef above would
+// otherwise lead to an empty content of the file.
+DEAL_II_NAMESPACE_OPEN
+DEAL_II_NAMESPACE_CLOSE
+
 #endif // DEAL_II_TRILINOS_WITH_TPETRA
 
 #endif // dealii_tpetra_trilinos_block_sparse_matrix_templates_h
index cc09a41de90533c23085724f754c2877b49f2969..e8f9f76fddaf12fe02e28481a9ea472c3d1d3bb8 100644 (file)
@@ -250,6 +250,14 @@ namespace LinearAlgebra
 
 DEAL_II_NAMESPACE_CLOSE
 
+#else
+
+// Make sure the scripts that create the C++20 module input files have
+// something to latch on if the preprocessor #ifdef above would
+// otherwise lead to an empty content of the file.
+DEAL_II_NAMESPACE_OPEN
+DEAL_II_NAMESPACE_CLOSE
+
 #endif // DEAL_II_TRILINOS_WITH_TPETRA
 
 #endif // dealii_trilinos_tpetra_block_vector_h
index 55448d33e8fe0b9e9223d013045783c4717fb462..a9115f3f5b2702632dc820f6774da77fbdb6195a 100644 (file)
@@ -231,6 +231,14 @@ namespace LinearAlgebra
 
 DEAL_II_NAMESPACE_CLOSE
 
+#else
+
+// Make sure the scripts that create the C++20 module input files have
+// something to latch on if the preprocessor #ifdef above would
+// otherwise lead to an empty content of the file.
+DEAL_II_NAMESPACE_OPEN
+DEAL_II_NAMESPACE_CLOSE
+
 #endif // DEAL_II_TRILINOS_WITH_TPETRA
 
 #endif // dealii_trilinos_tpetra_block_vector_templates_h
index 4c0e3512d42564165292138974452bd09344aced..0e3565ad692e46256a5aa81b67b6443c5dee6af9 100644 (file)
@@ -134,6 +134,14 @@ namespace LinearAlgebra
 
 DEAL_II_NAMESPACE_CLOSE
 
+#else
+
+// Make sure the scripts that create the C++20 module input files have
+// something to latch on if the preprocessor #ifdef above would
+// otherwise lead to an empty content of the file.
+DEAL_II_NAMESPACE_OPEN
+DEAL_II_NAMESPACE_CLOSE
+
 #endif
 
 #endif
index 76b3aa5f3a29018fe63fe092dde0854cb1130a60..3f9db5a2979508f725417d4cc7ced0efc122582e 100644 (file)
@@ -1324,6 +1324,14 @@ namespace LinearAlgebra
 
 DEAL_II_NAMESPACE_CLOSE
 
+#else
+
+// Make sure the scripts that create the C++20 module input files have
+// something to latch on if the preprocessor #ifdef above would
+// otherwise lead to an empty content of the file.
+DEAL_II_NAMESPACE_OPEN
+DEAL_II_NAMESPACE_CLOSE
+
 #endif // DEAL_II_TRILINOS_WITH_TPETRA
 
 #endif
index 0900f95f9fdc882755d3d368ca4f538627cdfd01..7ca067da76f2716e3ab2edb3d9e88afdf8006318 100644 (file)
@@ -812,6 +812,14 @@ namespace LinearAlgebra
 DEAL_II_NAMESPACE_CLOSE
 
 #  endif // DEAL_II_TRILINOS_WITH_IFPACK2
-#endif   // DEAL_II_TRILINOS_WITH_TPETRA
+#else
+
+// Make sure the scripts that create the C++20 module input files have
+// something to latch on if the preprocessor #ifdef above would
+// otherwise lead to an empty content of the file.
+DEAL_II_NAMESPACE_OPEN
+DEAL_II_NAMESPACE_CLOSE
+
+#endif // DEAL_II_TRILINOS_WITH_TPETRA
 
 #endif
index 0b96bb7f9b972973cd2e5e9d9317ce79ef96f126..eba22b6c2c33382d8be6f5c26e1a7e517715ca6d 100644 (file)
@@ -312,6 +312,14 @@ namespace LinearAlgebra
 DEAL_II_NAMESPACE_CLOSE
 
 #  endif // DEAL_II_TRILINOS_WITH_AMESOS2
-#endif   // DEAL_II_TRILINOS_WITH_TPETRA
+#else
+
+// Make sure the scripts that create the C++20 module input files have
+// something to latch on if the preprocessor #ifdef above would
+// otherwise lead to an empty content of the file.
+DEAL_II_NAMESPACE_OPEN
+DEAL_II_NAMESPACE_CLOSE
+
+#endif // DEAL_II_TRILINOS_WITH_TPETRA
 
 #endif
index ddca9270ae680d00c83cbe9c64ccf2b5070785ff..acd1085969bffa5d28419abb5177031eace0c647 100644 (file)
@@ -213,6 +213,14 @@ namespace LinearAlgebra
 DEAL_II_NAMESPACE_CLOSE
 
 #  endif // DEAL_II_TRILINOS_WITH_AMESOS2
-#endif   // DEAL_II_TRILINOS_WITH_TPETRA
+#else
+
+// Make sure the scripts that create the C++20 module input files have
+// something to latch on if the preprocessor #ifdef above would
+// otherwise lead to an empty content of the file.
+DEAL_II_NAMESPACE_OPEN
+DEAL_II_NAMESPACE_CLOSE
+
+#endif // DEAL_II_TRILINOS_WITH_TPETRA
 
 #endif
index a8587ec021b55863d779cecdf8eb46786cc8177c..29efe7a55e620405fde9d6ba4f90995a388430cf 100644 (file)
@@ -2340,6 +2340,14 @@ namespace LinearAlgebra
 
 DEAL_II_NAMESPACE_CLOSE
 
+#else
+
+// Make sure the scripts that create the C++20 module input files have
+// something to latch on if the preprocessor #ifdef above would
+// otherwise lead to an empty content of the file.
+DEAL_II_NAMESPACE_OPEN
+DEAL_II_NAMESPACE_CLOSE
+
 #endif // DEAL_II_TRILINOS_WITH_TPETRA
 
 #endif // dealii_trilinos_tpetra_sparse_matrix_h
index 23cae8d196870413a6327f11b1b0d541dc4dec77..8e0993f5d1d80d8e2b702ceb9ab0711d326a76ff 100644 (file)
@@ -1618,6 +1618,14 @@ namespace LinearAlgebra
 
 DEAL_II_NAMESPACE_CLOSE
 
+#else
+
+// Make sure the scripts that create the C++20 module input files have
+// something to latch on if the preprocessor #ifdef above would
+// otherwise lead to an empty content of the file.
+DEAL_II_NAMESPACE_OPEN
+DEAL_II_NAMESPACE_CLOSE
+
 #endif // DEAL_II_TRILINOS_WITH_TPETRA
 
 #endif // dealii_trilinos_tpetra_sparse_matrix_templates_h
index 8de6def2147c27ede8a9935c15f65f9b3ef8fa03..b661d7e95b95a3730135a1b00beb604b1558eec3 100644 (file)
@@ -1376,6 +1376,14 @@ namespace LinearAlgebra
 DEAL_II_NAMESPACE_CLOSE
 
 
+#else
+
+// Make sure the scripts that create the C++20 module input files have
+// something to latch on if the preprocessor #ifdef above would
+// otherwise lead to an empty content of the file.
+DEAL_II_NAMESPACE_OPEN
+DEAL_II_NAMESPACE_CLOSE
+
 #endif // DEAL_II_TRILINOS_WITH_TPETRA
 
 #endif
index 56de3400661a1bfaf325d2b53b088b84780bb2b9..81b1e5eba51aa06f32f9e9e6daf04820c1e5d501 100644 (file)
@@ -177,6 +177,15 @@ namespace LinearAlgebra
   }   // namespace TpetraWrappers
 } // namespace LinearAlgebra
 DEAL_II_NAMESPACE_CLOSE
+
+#else
+
+// Make sure the scripts that create the C++20 module input files have
+// something to latch on if the preprocessor #ifdef above would
+// otherwise lead to an empty content of the file.
+DEAL_II_NAMESPACE_OPEN
+DEAL_II_NAMESPACE_CLOSE
+
 #endif
 
 #endif
index 96e9676114ff44a71976d616a44676408d75824c..354935afee3393179b9ff5df55eb04acc02fbada 100644 (file)
@@ -1551,6 +1551,14 @@ struct is_serial_vector<
 
 DEAL_II_NAMESPACE_CLOSE
 
+#else
+
+// Make sure the scripts that create the C++20 module input files have
+// something to latch on if the preprocessor #ifdef above would
+// otherwise lead to an empty content of the file.
+DEAL_II_NAMESPACE_OPEN
+DEAL_II_NAMESPACE_CLOSE
+
 #endif
 
 #endif
index 1d30fd42659f9a60f8c0d9c1ac9b5dd3d0f6d5a0..24069edcaf2639f8e6e3e834acbb36d52ea7040b 100644 (file)
@@ -1281,6 +1281,14 @@ namespace LinearAlgebra
 
 DEAL_II_NAMESPACE_CLOSE
 
+#else
+
+// Make sure the scripts that create the C++20 module input files have
+// something to latch on if the preprocessor #ifdef above would
+// otherwise lead to an empty content of the file.
+DEAL_II_NAMESPACE_OPEN
+DEAL_II_NAMESPACE_CLOSE
+
 #endif
 
 #endif
index 39e7983a509d925d760b4bfb1ab7fe9e01e99864..88242a8bbe9787eb05f7140bdf9f147fc700ae5f 100644 (file)
@@ -2327,6 +2327,14 @@ struct is_serial_vector<TrilinosWrappers::MPI::Vector> : std::false_type
 
 DEAL_II_NAMESPACE_CLOSE
 
+#else
+
+// Make sure the scripts that create the C++20 module input files have
+// something to latch on if the preprocessor #ifdef above would
+// otherwise lead to an empty content of the file.
+DEAL_II_NAMESPACE_OPEN
+DEAL_II_NAMESPACE_CLOSE
+
 #endif
 
 #endif
index 6c1d1cd99081360fd70400a7b10965b6fa7c6734..7b420bee15919410f29e62573f20071057eb712e 100644 (file)
@@ -422,5 +422,13 @@ namespace OpenCASCADE
 DEAL_II_NAMESPACE_CLOSE
 
 
+#else
+
+// Make sure the scripts that create the C++20 module input files have
+// something to latch on if the preprocessor #ifdef above would
+// otherwise lead to an empty content of the file.
+DEAL_II_NAMESPACE_OPEN
+DEAL_II_NAMESPACE_CLOSE
+
 #endif // DEAL_II_WITH_OPENCASCADE
 #endif // dealii_occ_manifold_lib_h
index 9d0a8e00ef0111a36490dea4517677d74df9a451..e1a0779d10abc002719ef2a46dcd2da0aa492e56 100644 (file)
@@ -466,6 +466,14 @@ namespace OpenCASCADE
 
 DEAL_II_NAMESPACE_CLOSE
 
+#else
+
+// Make sure the scripts that create the C++20 module input files have
+// something to latch on if the preprocessor #ifdef above would
+// otherwise lead to an empty content of the file.
+DEAL_II_NAMESPACE_OPEN
+DEAL_II_NAMESPACE_CLOSE
+
 #endif // DEAL_II_WITH_OPENCASCADE
 
 #endif
index 2d50a3fbe145231665f8c3e83156cc06461886a2..e29aa069c906f29b47ee02ca6b683cb29b757557 100644 (file)
@@ -506,6 +506,14 @@ namespace Rol
 DEAL_II_NAMESPACE_CLOSE
 
 
+#else
+
+// Make sure the scripts that create the C++20 module input files have
+// something to latch on if the preprocessor #ifdef above would
+// otherwise lead to an empty content of the file.
+DEAL_II_NAMESPACE_OPEN
+DEAL_II_NAMESPACE_CLOSE
+
 #endif // DEAL_II_TRILINOS_WITH_ROL
 
 #endif // dealii_optimization_rol_vector_adaptor_h
index 194a252f518c0575d1e875268a7f016654cdeca4..ecab67311f65ff502cc39637e49fdae2d36ba3dc 100644 (file)
@@ -1185,6 +1185,15 @@ namespace SUNDIALS
 } // namespace SUNDIALS
 
 DEAL_II_NAMESPACE_CLOSE
+
+#else
+
+// Make sure the scripts that create the C++20 module input files have
+// something to latch on if the preprocessor #ifdef above would
+// otherwise lead to an empty content of the file.
+DEAL_II_NAMESPACE_OPEN
+DEAL_II_NAMESPACE_CLOSE
+
 #endif
 
 
index a313acdcad446f9636a60f0eb4d769dac4e62fa2..2deb5d6e97496134b00ea5bb69f036fcf764597d 100644 (file)
@@ -1143,6 +1143,14 @@ namespace SUNDIALS
 
 DEAL_II_NAMESPACE_CLOSE
 
+#else
+
+// Make sure the scripts that create the C++20 module input files have
+// something to latch on if the preprocessor #ifdef above would
+// otherwise lead to an empty content of the file.
+DEAL_II_NAMESPACE_OPEN
+DEAL_II_NAMESPACE_CLOSE
+
 #endif // DEAL_II_WITH_SUNDIALS
 
 #endif
index 2b2a0e6d905886ee685a4d885db4d54ae76cd9da..062801ca436ce6a079e84972d3de96c9772337a7 100644 (file)
@@ -772,6 +772,14 @@ namespace SUNDIALS
 
 DEAL_II_NAMESPACE_CLOSE
 
+#else
+
+// Make sure the scripts that create the C++20 module input files have
+// something to latch on if the preprocessor #ifdef above would
+// otherwise lead to an empty content of the file.
+DEAL_II_NAMESPACE_OPEN
+DEAL_II_NAMESPACE_CLOSE
+
 #endif
 
 #endif
index 1e221feb178fc2f2dcc6ff4835e0254cda7c126b..80704e9d8d628a65d54e7393c069a4dfddea80a6 100644 (file)
@@ -232,6 +232,15 @@ namespace SUNDIALS
   } // namespace internal
 } // namespace SUNDIALS
 
+
+DEAL_II_NAMESPACE_CLOSE
+
+#else
+
+// Make sure the scripts that create the C++20 module input files have
+// something to latch on if the preprocessor #ifdef above would
+// otherwise lead to an empty content of the file.
+DEAL_II_NAMESPACE_OPEN
 DEAL_II_NAMESPACE_CLOSE
 
 #endif
index 8fe20deecce55f9f0680f1ddfb47a107d5ba1c53..ace23415f7bcb32fe1fd73e6fd1358aba9cc0205 100644 (file)
@@ -1385,5 +1385,13 @@ namespace SUNDIALS
 
 DEAL_II_NAMESPACE_CLOSE
 
+#else
+
+// Make sure the scripts that create the C++20 module input files have
+// something to latch on if the preprocessor #ifdef above would
+// otherwise lead to an empty content of the file.
+DEAL_II_NAMESPACE_OPEN
+DEAL_II_NAMESPACE_CLOSE
+
 #endif
 #endif
index e53eef835432abc80500cf6a30ef89680a737633..32333694e6f4dbbe264e58c1dcde103130464f66 100644 (file)
@@ -38,5 +38,13 @@ namespace SUNDIALS
 
 DEAL_II_NAMESPACE_CLOSE
 
+#else
+
+// Make sure the scripts that create the C++20 module input files have
+// something to latch on if the preprocessor #ifdef above would
+// otherwise lead to an empty content of the file.
+DEAL_II_NAMESPACE_OPEN
+DEAL_II_NAMESPACE_CLOSE
+
 #endif // DEAL_II_WITH_SUNDIALS
 #endif // dealii_sundials_types_h
index 2e23dc9f69aa023b9629931e0dbac2031c242aab..64596c8b5603f23e5b5ee9d1b3fbdebddc7f21da 100644 (file)
@@ -255,5 +255,13 @@ namespace SUNDIALS
 
 DEAL_II_NAMESPACE_CLOSE
 
+#else
+
+// Make sure the scripts that create the C++20 module input files have
+// something to latch on if the preprocessor #ifdef above would
+// otherwise lead to an empty content of the file.
+DEAL_II_NAMESPACE_OPEN
+DEAL_II_NAMESPACE_CLOSE
+
 #endif
 #endif
index 1b7f42c96a3e4a9d33851508588cb7bd49597795..fbdda15316db1b7b3eee1805b6f589d1b0dfa641 100644 (file)
@@ -100,6 +100,14 @@ namespace SUNDIALS
 
 DEAL_II_NAMESPACE_CLOSE
 
+#else
+
+// Make sure the scripts that create the C++20 module input files have
+// something to latch on if the preprocessor #ifdef above would
+// otherwise lead to an empty content of the file.
+DEAL_II_NAMESPACE_OPEN
+DEAL_II_NAMESPACE_CLOSE
+
 #endif // DEAL_II_WITH_SUNDIALS
 
 #endif
index 4d48824cc76c192c54541826d1c8e18ab7ff7b30..ca6b1ba99ae872a278c2d05cb8086f74aace6d65 100644 (file)
@@ -410,6 +410,14 @@ namespace TrilinosWrappers
 
 DEAL_II_NAMESPACE_CLOSE
 
+#else
+
+// Make sure the scripts that create the C++20 module input files have
+// something to latch on if the preprocessor #ifdef above would
+// otherwise lead to an empty content of the file.
+DEAL_II_NAMESPACE_OPEN
+DEAL_II_NAMESPACE_CLOSE
+
 #endif
 
 #endif
index 8a8e076106c4410939f005b7810638861dcd31fb..7ccd9126771871cebdecf14c2757123fc8640d51 100644 (file)
@@ -1265,6 +1265,14 @@ namespace TrilinosWrappers
 
 DEAL_II_NAMESPACE_CLOSE
 
+#else
+
+// Make sure the scripts that create the C++20 module input files have
+// something to latch on if the preprocessor #ifdef above would
+// otherwise lead to an empty content of the file.
+DEAL_II_NAMESPACE_OPEN
+DEAL_II_NAMESPACE_CLOSE
+
 #endif
 
 #endif
index d1307e4bb0029b82dda124403499f1e2f5dbb2ce..8f25331fb409b781989d21cba5ed81e24271ae44 100644 (file)
@@ -76,5 +76,13 @@ namespace VTKWrappers
 
 DEAL_II_NAMESPACE_CLOSE
 
+#else
+
+// Make sure the scripts that create the C++20 module input files have
+// something to latch on if the preprocessor #ifdef above would
+// otherwise lead to an empty content of the file.
+DEAL_II_NAMESPACE_OPEN
+DEAL_II_NAMESPACE_CLOSE
+
 #endif
 #endif

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.