]> https://gitweb.dealii.org/ - dealii.git/commitdiff
CMake: remove empty CMakeLists.txt files that serve no purpose
authorMatthias Maier <tamiko@43-1.org>
Mon, 5 May 2025 18:51:52 +0000 (13:51 -0500)
committerMatthias Maier <tamiko@43-1.org>
Mon, 5 May 2025 18:52:43 +0000 (13:52 -0500)
33 files changed:
include/deal.II/CMakeLists.txt
include/deal.II/algorithms/CMakeLists.txt [deleted file]
include/deal.II/arborx/CMakeLists.txt [deleted file]
include/deal.II/base/CMakeLists.txt
include/deal.II/base/std_cxx17/CMakeLists.txt [deleted file]
include/deal.II/base/std_cxx20/CMakeLists.txt [deleted file]
include/deal.II/boost_adaptors/CMakeLists.txt [deleted file]
include/deal.II/cgal/CMakeLists.txt [deleted file]
include/deal.II/differentiation/CMakeLists.txt [deleted file]
include/deal.II/differentiation/ad/CMakeLists.txt [deleted file]
include/deal.II/differentiation/sd/CMakeLists.txt [deleted file]
include/deal.II/distributed/CMakeLists.txt [deleted file]
include/deal.II/dofs/CMakeLists.txt [deleted file]
include/deal.II/fe/CMakeLists.txt [deleted file]
include/deal.II/gmsh/CMakeLists.txt [deleted file]
include/deal.II/grid/CMakeLists.txt [deleted file]
include/deal.II/hp/CMakeLists.txt [deleted file]
include/deal.II/integrators/CMakeLists.txt [deleted file]
include/deal.II/lac/CMakeLists.txt [deleted file]
include/deal.II/matrix_free/CMakeLists.txt [deleted file]
include/deal.II/meshworker/CMakeLists.txt [deleted file]
include/deal.II/multigrid/CMakeLists.txt [deleted file]
include/deal.II/non_matching/CMakeLists.txt [deleted file]
include/deal.II/numerics/CMakeLists.txt [deleted file]
include/deal.II/opencascade/CMakeLists.txt [deleted file]
include/deal.II/optimization/CMakeLists.txt [deleted file]
include/deal.II/optimization/rol/CMakeLists.txt [deleted file]
include/deal.II/particles/CMakeLists.txt [deleted file]
include/deal.II/physics/CMakeLists.txt [deleted file]
include/deal.II/physics/elasticity/CMakeLists.txt [deleted file]
include/deal.II/sundials/CMakeLists.txt [deleted file]
include/deal.II/trilinos/CMakeLists.txt [deleted file]
include/deal.II/vtk/CMakeLists.txt [deleted file]

index ad6ef754bce4ae379f4797725a4e331a8c69f111..03bcefa9582a6aa388364c3519d1375baa1299ac 100644 (file)
 #
 # Recurse into the sub-directories:
 #
-add_subdirectory(algorithms)
-add_subdirectory(arborx)
 add_subdirectory(base)
-add_subdirectory(boost_adaptors)
-add_subdirectory(cgal)
-add_subdirectory(differentiation)
-add_subdirectory(distributed)
-add_subdirectory(dofs)
-add_subdirectory(fe)
-add_subdirectory(gmsh)
-add_subdirectory(grid)
-add_subdirectory(hp)
-add_subdirectory(integrators)
-add_subdirectory(lac)
-add_subdirectory(matrix_free)
-add_subdirectory(meshworker)
-add_subdirectory(multigrid)
-add_subdirectory(non_matching)
-add_subdirectory(numerics)
-add_subdirectory(opencascade)
-add_subdirectory(optimization)
-add_subdirectory(particles)
-add_subdirectory(physics)
-add_subdirectory(sundials)
-add_subdirectory(trilinos)
-add_subdirectory(vtk)
diff --git a/include/deal.II/algorithms/CMakeLists.txt b/include/deal.II/algorithms/CMakeLists.txt
deleted file mode 100644 (file)
index 40b8629..0000000
+++ /dev/null
@@ -1,13 +0,0 @@
-## ------------------------------------------------------------------------
-##
-## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2012 - 2022 by the deal.II authors
-##
-## This file is part of the deal.II library.
-##
-## Part of the source code is dual licensed under Apache-2.0 WITH
-## LLVM-exception OR LGPL-2.1-or-later. Detailed license information
-## governing the source code and code contributions can be found in
-## LICENSE.md and CONTRIBUTING.md at the top level directory of deal.II.
-##
-## ------------------------------------------------------------------------
diff --git a/include/deal.II/arborx/CMakeLists.txt b/include/deal.II/arborx/CMakeLists.txt
deleted file mode 100644 (file)
index 40b8629..0000000
+++ /dev/null
@@ -1,13 +0,0 @@
-## ------------------------------------------------------------------------
-##
-## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2012 - 2022 by the deal.II authors
-##
-## This file is part of the deal.II library.
-##
-## Part of the source code is dual licensed under Apache-2.0 WITH
-## LLVM-exception OR LGPL-2.1-or-later. Detailed license information
-## governing the source code and code contributions can be found in
-## LICENSE.md and CONTRIBUTING.md at the top level directory of deal.II.
-##
-## ------------------------------------------------------------------------
index 0b7a8809a012d06c1bc9dd3a92e2840c36ac4461..c98b41798268597e1ac17fae8c690f55e29b1dbd 100644 (file)
@@ -24,10 +24,3 @@ configure_file(
   ${CMAKE_CURRENT_SOURCE_DIR}/revision.h.in
   ${CMAKE_CURRENT_BINARY_DIR}/revision.h
   )
-
-
-#
-# Recurse into the sub-directories:
-#
-add_subdirectory(std_cxx17)
-add_subdirectory(std_cxx20)
diff --git a/include/deal.II/base/std_cxx17/CMakeLists.txt b/include/deal.II/base/std_cxx17/CMakeLists.txt
deleted file mode 100644 (file)
index 40b8629..0000000
+++ /dev/null
@@ -1,13 +0,0 @@
-## ------------------------------------------------------------------------
-##
-## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2012 - 2022 by the deal.II authors
-##
-## This file is part of the deal.II library.
-##
-## Part of the source code is dual licensed under Apache-2.0 WITH
-## LLVM-exception OR LGPL-2.1-or-later. Detailed license information
-## governing the source code and code contributions can be found in
-## LICENSE.md and CONTRIBUTING.md at the top level directory of deal.II.
-##
-## ------------------------------------------------------------------------
diff --git a/include/deal.II/base/std_cxx20/CMakeLists.txt b/include/deal.II/base/std_cxx20/CMakeLists.txt
deleted file mode 100644 (file)
index 40b8629..0000000
+++ /dev/null
@@ -1,13 +0,0 @@
-## ------------------------------------------------------------------------
-##
-## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2012 - 2022 by the deal.II authors
-##
-## This file is part of the deal.II library.
-##
-## Part of the source code is dual licensed under Apache-2.0 WITH
-## LLVM-exception OR LGPL-2.1-or-later. Detailed license information
-## governing the source code and code contributions can be found in
-## LICENSE.md and CONTRIBUTING.md at the top level directory of deal.II.
-##
-## ------------------------------------------------------------------------
diff --git a/include/deal.II/boost_adaptors/CMakeLists.txt b/include/deal.II/boost_adaptors/CMakeLists.txt
deleted file mode 100644 (file)
index 40b8629..0000000
+++ /dev/null
@@ -1,13 +0,0 @@
-## ------------------------------------------------------------------------
-##
-## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2012 - 2022 by the deal.II authors
-##
-## This file is part of the deal.II library.
-##
-## Part of the source code is dual licensed under Apache-2.0 WITH
-## LLVM-exception OR LGPL-2.1-or-later. Detailed license information
-## governing the source code and code contributions can be found in
-## LICENSE.md and CONTRIBUTING.md at the top level directory of deal.II.
-##
-## ------------------------------------------------------------------------
diff --git a/include/deal.II/cgal/CMakeLists.txt b/include/deal.II/cgal/CMakeLists.txt
deleted file mode 100644 (file)
index 40b8629..0000000
+++ /dev/null
@@ -1,13 +0,0 @@
-## ------------------------------------------------------------------------
-##
-## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2012 - 2022 by the deal.II authors
-##
-## This file is part of the deal.II library.
-##
-## Part of the source code is dual licensed under Apache-2.0 WITH
-## LLVM-exception OR LGPL-2.1-or-later. Detailed license information
-## governing the source code and code contributions can be found in
-## LICENSE.md and CONTRIBUTING.md at the top level directory of deal.II.
-##
-## ------------------------------------------------------------------------
diff --git a/include/deal.II/differentiation/CMakeLists.txt b/include/deal.II/differentiation/CMakeLists.txt
deleted file mode 100644 (file)
index d1f22bd..0000000
+++ /dev/null
@@ -1,21 +0,0 @@
-## ------------------------------------------------------------------------
-##
-## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2012 - 2022 by the deal.II authors
-##
-## This file is part of the deal.II library.
-##
-## Part of the source code is dual licensed under Apache-2.0 WITH
-## LLVM-exception OR LGPL-2.1-or-later. Detailed license information
-## governing the source code and code contributions can be found in
-## LICENSE.md and CONTRIBUTING.md at the top level directory of deal.II.
-##
-## ------------------------------------------------------------------------
-
-
-
-#
-# Recurse into the sub-directories:
-#
-add_subdirectory(ad)
-add_subdirectory(sd)
diff --git a/include/deal.II/differentiation/ad/CMakeLists.txt b/include/deal.II/differentiation/ad/CMakeLists.txt
deleted file mode 100644 (file)
index 40b8629..0000000
+++ /dev/null
@@ -1,13 +0,0 @@
-## ------------------------------------------------------------------------
-##
-## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2012 - 2022 by the deal.II authors
-##
-## This file is part of the deal.II library.
-##
-## Part of the source code is dual licensed under Apache-2.0 WITH
-## LLVM-exception OR LGPL-2.1-or-later. Detailed license information
-## governing the source code and code contributions can be found in
-## LICENSE.md and CONTRIBUTING.md at the top level directory of deal.II.
-##
-## ------------------------------------------------------------------------
diff --git a/include/deal.II/differentiation/sd/CMakeLists.txt b/include/deal.II/differentiation/sd/CMakeLists.txt
deleted file mode 100644 (file)
index 40b8629..0000000
+++ /dev/null
@@ -1,13 +0,0 @@
-## ------------------------------------------------------------------------
-##
-## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2012 - 2022 by the deal.II authors
-##
-## This file is part of the deal.II library.
-##
-## Part of the source code is dual licensed under Apache-2.0 WITH
-## LLVM-exception OR LGPL-2.1-or-later. Detailed license information
-## governing the source code and code contributions can be found in
-## LICENSE.md and CONTRIBUTING.md at the top level directory of deal.II.
-##
-## ------------------------------------------------------------------------
diff --git a/include/deal.II/distributed/CMakeLists.txt b/include/deal.II/distributed/CMakeLists.txt
deleted file mode 100644 (file)
index 40b8629..0000000
+++ /dev/null
@@ -1,13 +0,0 @@
-## ------------------------------------------------------------------------
-##
-## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2012 - 2022 by the deal.II authors
-##
-## This file is part of the deal.II library.
-##
-## Part of the source code is dual licensed under Apache-2.0 WITH
-## LLVM-exception OR LGPL-2.1-or-later. Detailed license information
-## governing the source code and code contributions can be found in
-## LICENSE.md and CONTRIBUTING.md at the top level directory of deal.II.
-##
-## ------------------------------------------------------------------------
diff --git a/include/deal.II/dofs/CMakeLists.txt b/include/deal.II/dofs/CMakeLists.txt
deleted file mode 100644 (file)
index 40b8629..0000000
+++ /dev/null
@@ -1,13 +0,0 @@
-## ------------------------------------------------------------------------
-##
-## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2012 - 2022 by the deal.II authors
-##
-## This file is part of the deal.II library.
-##
-## Part of the source code is dual licensed under Apache-2.0 WITH
-## LLVM-exception OR LGPL-2.1-or-later. Detailed license information
-## governing the source code and code contributions can be found in
-## LICENSE.md and CONTRIBUTING.md at the top level directory of deal.II.
-##
-## ------------------------------------------------------------------------
diff --git a/include/deal.II/fe/CMakeLists.txt b/include/deal.II/fe/CMakeLists.txt
deleted file mode 100644 (file)
index 40b8629..0000000
+++ /dev/null
@@ -1,13 +0,0 @@
-## ------------------------------------------------------------------------
-##
-## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2012 - 2022 by the deal.II authors
-##
-## This file is part of the deal.II library.
-##
-## Part of the source code is dual licensed under Apache-2.0 WITH
-## LLVM-exception OR LGPL-2.1-or-later. Detailed license information
-## governing the source code and code contributions can be found in
-## LICENSE.md and CONTRIBUTING.md at the top level directory of deal.II.
-##
-## ------------------------------------------------------------------------
diff --git a/include/deal.II/gmsh/CMakeLists.txt b/include/deal.II/gmsh/CMakeLists.txt
deleted file mode 100644 (file)
index 40b8629..0000000
+++ /dev/null
@@ -1,13 +0,0 @@
-## ------------------------------------------------------------------------
-##
-## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2012 - 2022 by the deal.II authors
-##
-## This file is part of the deal.II library.
-##
-## Part of the source code is dual licensed under Apache-2.0 WITH
-## LLVM-exception OR LGPL-2.1-or-later. Detailed license information
-## governing the source code and code contributions can be found in
-## LICENSE.md and CONTRIBUTING.md at the top level directory of deal.II.
-##
-## ------------------------------------------------------------------------
diff --git a/include/deal.II/grid/CMakeLists.txt b/include/deal.II/grid/CMakeLists.txt
deleted file mode 100644 (file)
index 40b8629..0000000
+++ /dev/null
@@ -1,13 +0,0 @@
-## ------------------------------------------------------------------------
-##
-## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2012 - 2022 by the deal.II authors
-##
-## This file is part of the deal.II library.
-##
-## Part of the source code is dual licensed under Apache-2.0 WITH
-## LLVM-exception OR LGPL-2.1-or-later. Detailed license information
-## governing the source code and code contributions can be found in
-## LICENSE.md and CONTRIBUTING.md at the top level directory of deal.II.
-##
-## ------------------------------------------------------------------------
diff --git a/include/deal.II/hp/CMakeLists.txt b/include/deal.II/hp/CMakeLists.txt
deleted file mode 100644 (file)
index 40b8629..0000000
+++ /dev/null
@@ -1,13 +0,0 @@
-## ------------------------------------------------------------------------
-##
-## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2012 - 2022 by the deal.II authors
-##
-## This file is part of the deal.II library.
-##
-## Part of the source code is dual licensed under Apache-2.0 WITH
-## LLVM-exception OR LGPL-2.1-or-later. Detailed license information
-## governing the source code and code contributions can be found in
-## LICENSE.md and CONTRIBUTING.md at the top level directory of deal.II.
-##
-## ------------------------------------------------------------------------
diff --git a/include/deal.II/integrators/CMakeLists.txt b/include/deal.II/integrators/CMakeLists.txt
deleted file mode 100644 (file)
index 40b8629..0000000
+++ /dev/null
@@ -1,13 +0,0 @@
-## ------------------------------------------------------------------------
-##
-## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2012 - 2022 by the deal.II authors
-##
-## This file is part of the deal.II library.
-##
-## Part of the source code is dual licensed under Apache-2.0 WITH
-## LLVM-exception OR LGPL-2.1-or-later. Detailed license information
-## governing the source code and code contributions can be found in
-## LICENSE.md and CONTRIBUTING.md at the top level directory of deal.II.
-##
-## ------------------------------------------------------------------------
diff --git a/include/deal.II/lac/CMakeLists.txt b/include/deal.II/lac/CMakeLists.txt
deleted file mode 100644 (file)
index 40b8629..0000000
+++ /dev/null
@@ -1,13 +0,0 @@
-## ------------------------------------------------------------------------
-##
-## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2012 - 2022 by the deal.II authors
-##
-## This file is part of the deal.II library.
-##
-## Part of the source code is dual licensed under Apache-2.0 WITH
-## LLVM-exception OR LGPL-2.1-or-later. Detailed license information
-## governing the source code and code contributions can be found in
-## LICENSE.md and CONTRIBUTING.md at the top level directory of deal.II.
-##
-## ------------------------------------------------------------------------
diff --git a/include/deal.II/matrix_free/CMakeLists.txt b/include/deal.II/matrix_free/CMakeLists.txt
deleted file mode 100644 (file)
index 40b8629..0000000
+++ /dev/null
@@ -1,13 +0,0 @@
-## ------------------------------------------------------------------------
-##
-## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2012 - 2022 by the deal.II authors
-##
-## This file is part of the deal.II library.
-##
-## Part of the source code is dual licensed under Apache-2.0 WITH
-## LLVM-exception OR LGPL-2.1-or-later. Detailed license information
-## governing the source code and code contributions can be found in
-## LICENSE.md and CONTRIBUTING.md at the top level directory of deal.II.
-##
-## ------------------------------------------------------------------------
diff --git a/include/deal.II/meshworker/CMakeLists.txt b/include/deal.II/meshworker/CMakeLists.txt
deleted file mode 100644 (file)
index 40b8629..0000000
+++ /dev/null
@@ -1,13 +0,0 @@
-## ------------------------------------------------------------------------
-##
-## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2012 - 2022 by the deal.II authors
-##
-## This file is part of the deal.II library.
-##
-## Part of the source code is dual licensed under Apache-2.0 WITH
-## LLVM-exception OR LGPL-2.1-or-later. Detailed license information
-## governing the source code and code contributions can be found in
-## LICENSE.md and CONTRIBUTING.md at the top level directory of deal.II.
-##
-## ------------------------------------------------------------------------
diff --git a/include/deal.II/multigrid/CMakeLists.txt b/include/deal.II/multigrid/CMakeLists.txt
deleted file mode 100644 (file)
index 40b8629..0000000
+++ /dev/null
@@ -1,13 +0,0 @@
-## ------------------------------------------------------------------------
-##
-## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2012 - 2022 by the deal.II authors
-##
-## This file is part of the deal.II library.
-##
-## Part of the source code is dual licensed under Apache-2.0 WITH
-## LLVM-exception OR LGPL-2.1-or-later. Detailed license information
-## governing the source code and code contributions can be found in
-## LICENSE.md and CONTRIBUTING.md at the top level directory of deal.II.
-##
-## ------------------------------------------------------------------------
diff --git a/include/deal.II/non_matching/CMakeLists.txt b/include/deal.II/non_matching/CMakeLists.txt
deleted file mode 100644 (file)
index 40b8629..0000000
+++ /dev/null
@@ -1,13 +0,0 @@
-## ------------------------------------------------------------------------
-##
-## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2012 - 2022 by the deal.II authors
-##
-## This file is part of the deal.II library.
-##
-## Part of the source code is dual licensed under Apache-2.0 WITH
-## LLVM-exception OR LGPL-2.1-or-later. Detailed license information
-## governing the source code and code contributions can be found in
-## LICENSE.md and CONTRIBUTING.md at the top level directory of deal.II.
-##
-## ------------------------------------------------------------------------
diff --git a/include/deal.II/numerics/CMakeLists.txt b/include/deal.II/numerics/CMakeLists.txt
deleted file mode 100644 (file)
index 40b8629..0000000
+++ /dev/null
@@ -1,13 +0,0 @@
-## ------------------------------------------------------------------------
-##
-## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2012 - 2022 by the deal.II authors
-##
-## This file is part of the deal.II library.
-##
-## Part of the source code is dual licensed under Apache-2.0 WITH
-## LLVM-exception OR LGPL-2.1-or-later. Detailed license information
-## governing the source code and code contributions can be found in
-## LICENSE.md and CONTRIBUTING.md at the top level directory of deal.II.
-##
-## ------------------------------------------------------------------------
diff --git a/include/deal.II/opencascade/CMakeLists.txt b/include/deal.II/opencascade/CMakeLists.txt
deleted file mode 100644 (file)
index 40b8629..0000000
+++ /dev/null
@@ -1,13 +0,0 @@
-## ------------------------------------------------------------------------
-##
-## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2012 - 2022 by the deal.II authors
-##
-## This file is part of the deal.II library.
-##
-## Part of the source code is dual licensed under Apache-2.0 WITH
-## LLVM-exception OR LGPL-2.1-or-later. Detailed license information
-## governing the source code and code contributions can be found in
-## LICENSE.md and CONTRIBUTING.md at the top level directory of deal.II.
-##
-## ------------------------------------------------------------------------
diff --git a/include/deal.II/optimization/CMakeLists.txt b/include/deal.II/optimization/CMakeLists.txt
deleted file mode 100644 (file)
index 5693a1c..0000000
+++ /dev/null
@@ -1,19 +0,0 @@
-## ------------------------------------------------------------------------
-##
-## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2012 - 2022 by the deal.II authors
-##
-## This file is part of the deal.II library.
-##
-## Part of the source code is dual licensed under Apache-2.0 WITH
-## LLVM-exception OR LGPL-2.1-or-later. Detailed license information
-## governing the source code and code contributions can be found in
-## LICENSE.md and CONTRIBUTING.md at the top level directory of deal.II.
-##
-## ------------------------------------------------------------------------
-
-
-#
-# Recurse into the sub-directories:
-#
-add_subdirectory(rol)
diff --git a/include/deal.II/optimization/rol/CMakeLists.txt b/include/deal.II/optimization/rol/CMakeLists.txt
deleted file mode 100644 (file)
index 40b8629..0000000
+++ /dev/null
@@ -1,13 +0,0 @@
-## ------------------------------------------------------------------------
-##
-## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2012 - 2022 by the deal.II authors
-##
-## This file is part of the deal.II library.
-##
-## Part of the source code is dual licensed under Apache-2.0 WITH
-## LLVM-exception OR LGPL-2.1-or-later. Detailed license information
-## governing the source code and code contributions can be found in
-## LICENSE.md and CONTRIBUTING.md at the top level directory of deal.II.
-##
-## ------------------------------------------------------------------------
diff --git a/include/deal.II/particles/CMakeLists.txt b/include/deal.II/particles/CMakeLists.txt
deleted file mode 100644 (file)
index 40b8629..0000000
+++ /dev/null
@@ -1,13 +0,0 @@
-## ------------------------------------------------------------------------
-##
-## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2012 - 2022 by the deal.II authors
-##
-## This file is part of the deal.II library.
-##
-## Part of the source code is dual licensed under Apache-2.0 WITH
-## LLVM-exception OR LGPL-2.1-or-later. Detailed license information
-## governing the source code and code contributions can be found in
-## LICENSE.md and CONTRIBUTING.md at the top level directory of deal.II.
-##
-## ------------------------------------------------------------------------
diff --git a/include/deal.II/physics/CMakeLists.txt b/include/deal.II/physics/CMakeLists.txt
deleted file mode 100644 (file)
index 5e8579a..0000000
+++ /dev/null
@@ -1,18 +0,0 @@
-## ------------------------------------------------------------------------
-##
-## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2012 - 2022 by the deal.II authors
-##
-## This file is part of the deal.II library.
-##
-## Part of the source code is dual licensed under Apache-2.0 WITH
-## LLVM-exception OR LGPL-2.1-or-later. Detailed license information
-## governing the source code and code contributions can be found in
-## LICENSE.md and CONTRIBUTING.md at the top level directory of deal.II.
-##
-## ------------------------------------------------------------------------
-
-#
-# Recurse into the sub-directories:
-#
-add_subdirectory(elasticity)
diff --git a/include/deal.II/physics/elasticity/CMakeLists.txt b/include/deal.II/physics/elasticity/CMakeLists.txt
deleted file mode 100644 (file)
index 40b8629..0000000
+++ /dev/null
@@ -1,13 +0,0 @@
-## ------------------------------------------------------------------------
-##
-## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2012 - 2022 by the deal.II authors
-##
-## This file is part of the deal.II library.
-##
-## Part of the source code is dual licensed under Apache-2.0 WITH
-## LLVM-exception OR LGPL-2.1-or-later. Detailed license information
-## governing the source code and code contributions can be found in
-## LICENSE.md and CONTRIBUTING.md at the top level directory of deal.II.
-##
-## ------------------------------------------------------------------------
diff --git a/include/deal.II/sundials/CMakeLists.txt b/include/deal.II/sundials/CMakeLists.txt
deleted file mode 100644 (file)
index 40b8629..0000000
+++ /dev/null
@@ -1,13 +0,0 @@
-## ------------------------------------------------------------------------
-##
-## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2012 - 2022 by the deal.II authors
-##
-## This file is part of the deal.II library.
-##
-## Part of the source code is dual licensed under Apache-2.0 WITH
-## LLVM-exception OR LGPL-2.1-or-later. Detailed license information
-## governing the source code and code contributions can be found in
-## LICENSE.md and CONTRIBUTING.md at the top level directory of deal.II.
-##
-## ------------------------------------------------------------------------
diff --git a/include/deal.II/trilinos/CMakeLists.txt b/include/deal.II/trilinos/CMakeLists.txt
deleted file mode 100644 (file)
index 40b8629..0000000
+++ /dev/null
@@ -1,13 +0,0 @@
-## ------------------------------------------------------------------------
-##
-## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2012 - 2022 by the deal.II authors
-##
-## This file is part of the deal.II library.
-##
-## Part of the source code is dual licensed under Apache-2.0 WITH
-## LLVM-exception OR LGPL-2.1-or-later. Detailed license information
-## governing the source code and code contributions can be found in
-## LICENSE.md and CONTRIBUTING.md at the top level directory of deal.II.
-##
-## ------------------------------------------------------------------------
diff --git a/include/deal.II/vtk/CMakeLists.txt b/include/deal.II/vtk/CMakeLists.txt
deleted file mode 100644 (file)
index 40b8629..0000000
+++ /dev/null
@@ -1,13 +0,0 @@
-## ------------------------------------------------------------------------
-##
-## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2012 - 2022 by the deal.II authors
-##
-## This file is part of the deal.II library.
-##
-## Part of the source code is dual licensed under Apache-2.0 WITH
-## LLVM-exception OR LGPL-2.1-or-later. Detailed license information
-## governing the source code and code contributions can be found in
-## LICENSE.md and CONTRIBUTING.md at the top level directory of deal.II.
-##
-## ------------------------------------------------------------------------

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.