From 9aaab35e7111fa45b44f79455bc94cf364d348a5 Mon Sep 17 00:00:00 2001 From: Matthias Maier Date: Mon, 5 May 2025 13:51:52 -0500 Subject: [PATCH] CMake: remove empty CMakeLists.txt files that serve no purpose --- include/deal.II/CMakeLists.txt | 25 ------------------- include/deal.II/algorithms/CMakeLists.txt | 13 ---------- include/deal.II/arborx/CMakeLists.txt | 13 ---------- include/deal.II/base/CMakeLists.txt | 7 ------ include/deal.II/base/std_cxx17/CMakeLists.txt | 13 ---------- include/deal.II/base/std_cxx20/CMakeLists.txt | 13 ---------- include/deal.II/boost_adaptors/CMakeLists.txt | 13 ---------- include/deal.II/cgal/CMakeLists.txt | 13 ---------- .../deal.II/differentiation/CMakeLists.txt | 21 ---------------- .../deal.II/differentiation/ad/CMakeLists.txt | 13 ---------- .../deal.II/differentiation/sd/CMakeLists.txt | 13 ---------- include/deal.II/distributed/CMakeLists.txt | 13 ---------- include/deal.II/dofs/CMakeLists.txt | 13 ---------- include/deal.II/fe/CMakeLists.txt | 13 ---------- include/deal.II/gmsh/CMakeLists.txt | 13 ---------- include/deal.II/grid/CMakeLists.txt | 13 ---------- include/deal.II/hp/CMakeLists.txt | 13 ---------- include/deal.II/integrators/CMakeLists.txt | 13 ---------- include/deal.II/lac/CMakeLists.txt | 13 ---------- include/deal.II/matrix_free/CMakeLists.txt | 13 ---------- include/deal.II/meshworker/CMakeLists.txt | 13 ---------- include/deal.II/multigrid/CMakeLists.txt | 13 ---------- include/deal.II/non_matching/CMakeLists.txt | 13 ---------- include/deal.II/numerics/CMakeLists.txt | 13 ---------- include/deal.II/opencascade/CMakeLists.txt | 13 ---------- include/deal.II/optimization/CMakeLists.txt | 19 -------------- .../deal.II/optimization/rol/CMakeLists.txt | 13 ---------- include/deal.II/particles/CMakeLists.txt | 13 ---------- include/deal.II/physics/CMakeLists.txt | 18 ------------- .../deal.II/physics/elasticity/CMakeLists.txt | 13 ---------- include/deal.II/sundials/CMakeLists.txt | 13 ---------- include/deal.II/trilinos/CMakeLists.txt | 13 ---------- include/deal.II/vtk/CMakeLists.txt | 13 ---------- 33 files changed, 454 deletions(-) delete mode 100644 include/deal.II/algorithms/CMakeLists.txt delete mode 100644 include/deal.II/arborx/CMakeLists.txt delete mode 100644 include/deal.II/base/std_cxx17/CMakeLists.txt delete mode 100644 include/deal.II/base/std_cxx20/CMakeLists.txt delete mode 100644 include/deal.II/boost_adaptors/CMakeLists.txt delete mode 100644 include/deal.II/cgal/CMakeLists.txt delete mode 100644 include/deal.II/differentiation/CMakeLists.txt delete mode 100644 include/deal.II/differentiation/ad/CMakeLists.txt delete mode 100644 include/deal.II/differentiation/sd/CMakeLists.txt delete mode 100644 include/deal.II/distributed/CMakeLists.txt delete mode 100644 include/deal.II/dofs/CMakeLists.txt delete mode 100644 include/deal.II/fe/CMakeLists.txt delete mode 100644 include/deal.II/gmsh/CMakeLists.txt delete mode 100644 include/deal.II/grid/CMakeLists.txt delete mode 100644 include/deal.II/hp/CMakeLists.txt delete mode 100644 include/deal.II/integrators/CMakeLists.txt delete mode 100644 include/deal.II/lac/CMakeLists.txt delete mode 100644 include/deal.II/matrix_free/CMakeLists.txt delete mode 100644 include/deal.II/meshworker/CMakeLists.txt delete mode 100644 include/deal.II/multigrid/CMakeLists.txt delete mode 100644 include/deal.II/non_matching/CMakeLists.txt delete mode 100644 include/deal.II/numerics/CMakeLists.txt delete mode 100644 include/deal.II/opencascade/CMakeLists.txt delete mode 100644 include/deal.II/optimization/CMakeLists.txt delete mode 100644 include/deal.II/optimization/rol/CMakeLists.txt delete mode 100644 include/deal.II/particles/CMakeLists.txt delete mode 100644 include/deal.II/physics/CMakeLists.txt delete mode 100644 include/deal.II/physics/elasticity/CMakeLists.txt delete mode 100644 include/deal.II/sundials/CMakeLists.txt delete mode 100644 include/deal.II/trilinos/CMakeLists.txt delete mode 100644 include/deal.II/vtk/CMakeLists.txt diff --git a/include/deal.II/CMakeLists.txt b/include/deal.II/CMakeLists.txt index ad6ef754bc..03bcefa958 100644 --- a/include/deal.II/CMakeLists.txt +++ b/include/deal.II/CMakeLists.txt @@ -16,29 +16,4 @@ # # 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 index 40b8629a24..0000000000 --- a/include/deal.II/algorithms/CMakeLists.txt +++ /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 index 40b8629a24..0000000000 --- a/include/deal.II/arborx/CMakeLists.txt +++ /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/CMakeLists.txt b/include/deal.II/base/CMakeLists.txt index 0b7a8809a0..c98b417982 100644 --- a/include/deal.II/base/CMakeLists.txt +++ b/include/deal.II/base/CMakeLists.txt @@ -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 index 40b8629a24..0000000000 --- a/include/deal.II/base/std_cxx17/CMakeLists.txt +++ /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 index 40b8629a24..0000000000 --- a/include/deal.II/base/std_cxx20/CMakeLists.txt +++ /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 index 40b8629a24..0000000000 --- a/include/deal.II/boost_adaptors/CMakeLists.txt +++ /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 index 40b8629a24..0000000000 --- a/include/deal.II/cgal/CMakeLists.txt +++ /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 index d1f22bd92e..0000000000 --- a/include/deal.II/differentiation/CMakeLists.txt +++ /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 index 40b8629a24..0000000000 --- a/include/deal.II/differentiation/ad/CMakeLists.txt +++ /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 index 40b8629a24..0000000000 --- a/include/deal.II/differentiation/sd/CMakeLists.txt +++ /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 index 40b8629a24..0000000000 --- a/include/deal.II/distributed/CMakeLists.txt +++ /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 index 40b8629a24..0000000000 --- a/include/deal.II/dofs/CMakeLists.txt +++ /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 index 40b8629a24..0000000000 --- a/include/deal.II/fe/CMakeLists.txt +++ /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 index 40b8629a24..0000000000 --- a/include/deal.II/gmsh/CMakeLists.txt +++ /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 index 40b8629a24..0000000000 --- a/include/deal.II/grid/CMakeLists.txt +++ /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 index 40b8629a24..0000000000 --- a/include/deal.II/hp/CMakeLists.txt +++ /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 index 40b8629a24..0000000000 --- a/include/deal.II/integrators/CMakeLists.txt +++ /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 index 40b8629a24..0000000000 --- a/include/deal.II/lac/CMakeLists.txt +++ /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 index 40b8629a24..0000000000 --- a/include/deal.II/matrix_free/CMakeLists.txt +++ /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 index 40b8629a24..0000000000 --- a/include/deal.II/meshworker/CMakeLists.txt +++ /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 index 40b8629a24..0000000000 --- a/include/deal.II/multigrid/CMakeLists.txt +++ /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 index 40b8629a24..0000000000 --- a/include/deal.II/non_matching/CMakeLists.txt +++ /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 index 40b8629a24..0000000000 --- a/include/deal.II/numerics/CMakeLists.txt +++ /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 index 40b8629a24..0000000000 --- a/include/deal.II/opencascade/CMakeLists.txt +++ /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 index 5693a1c000..0000000000 --- a/include/deal.II/optimization/CMakeLists.txt +++ /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 index 40b8629a24..0000000000 --- a/include/deal.II/optimization/rol/CMakeLists.txt +++ /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 index 40b8629a24..0000000000 --- a/include/deal.II/particles/CMakeLists.txt +++ /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 index 5e8579a710..0000000000 --- a/include/deal.II/physics/CMakeLists.txt +++ /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 index 40b8629a24..0000000000 --- a/include/deal.II/physics/elasticity/CMakeLists.txt +++ /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 index 40b8629a24..0000000000 --- a/include/deal.II/sundials/CMakeLists.txt +++ /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 index 40b8629a24..0000000000 --- a/include/deal.II/trilinos/CMakeLists.txt +++ /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 index 40b8629a24..0000000000 --- a/include/deal.II/vtk/CMakeLists.txt +++ /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. -## -## ------------------------------------------------------------------------ -- 2.39.5