]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Push configuration of header subdirectories down to these subdirectories.
authorWolfgang Bangerth <bangerth@colostate.edu>
Fri, 31 Jan 2025 03:54:17 +0000 (20:54 -0700)
committerWolfgang Bangerth <bangerth@colostate.edu>
Mon, 7 Apr 2025 15:10:20 +0000 (09:10 -0600)
34 files changed:
include/CMakeLists.txt
include/deal.II/CMakeLists.txt [new file with mode: 0644]
include/deal.II/algorithms/CMakeLists.txt [new file with mode: 0644]
include/deal.II/arborx/CMakeLists.txt [new file with mode: 0644]
include/deal.II/base/CMakeLists.txt [new file with mode: 0644]
include/deal.II/base/std_cxx17/CMakeLists.txt [new file with mode: 0644]
include/deal.II/base/std_cxx20/CMakeLists.txt [new file with mode: 0644]
include/deal.II/boost_adaptors/CMakeLists.txt [new file with mode: 0644]
include/deal.II/cgal/CMakeLists.txt [new file with mode: 0644]
include/deal.II/differentiation/CMakeLists.txt [new file with mode: 0644]
include/deal.II/differentiation/ad/CMakeLists.txt [new file with mode: 0644]
include/deal.II/differentiation/sd/CMakeLists.txt [new file with mode: 0644]
include/deal.II/distributed/CMakeLists.txt [new file with mode: 0644]
include/deal.II/dofs/CMakeLists.txt [new file with mode: 0644]
include/deal.II/fe/CMakeLists.txt [new file with mode: 0644]
include/deal.II/gmsh/CMakeLists.txt [new file with mode: 0644]
include/deal.II/grid/CMakeLists.txt [new file with mode: 0644]
include/deal.II/hp/CMakeLists.txt [new file with mode: 0644]
include/deal.II/integrators/CMakeLists.txt [new file with mode: 0644]
include/deal.II/lac/CMakeLists.txt [new file with mode: 0644]
include/deal.II/matrix_free/CMakeLists.txt [new file with mode: 0644]
include/deal.II/meshworker/CMakeLists.txt [new file with mode: 0644]
include/deal.II/multigrid/CMakeLists.txt [new file with mode: 0644]
include/deal.II/non_matching/CMakeLists.txt [new file with mode: 0644]
include/deal.II/numerics/CMakeLists.txt [new file with mode: 0644]
include/deal.II/opencascade/CMakeLists.txt [new file with mode: 0644]
include/deal.II/optimization/CMakeLists.txt [new file with mode: 0644]
include/deal.II/optimization/rol/CMakeLists.txt [new file with mode: 0644]
include/deal.II/particles/CMakeLists.txt [new file with mode: 0644]
include/deal.II/physics/CMakeLists.txt [new file with mode: 0644]
include/deal.II/physics/elasticity/CMakeLists.txt [new file with mode: 0644]
include/deal.II/sundials/CMakeLists.txt [new file with mode: 0644]
include/deal.II/trilinos/CMakeLists.txt [new file with mode: 0644]
include/deal.II/vtk/CMakeLists.txt [new file with mode: 0644]

index 59d027d590a10cc43e3a3041f462c4cdf01ae3cd..66188a8a5b40b5cb0f3748e7dc7b43f8b99df03d 100644 (file)
 ##
 ## ------------------------------------------------------------------------
 
+
 #
-# Configure config.h and revision.h
+# Recurse into the sub-directories:
 #
-configure_file(
-  ${CMAKE_CURRENT_SOURCE_DIR}/deal.II/base/config.h.in
-  ${CMAKE_CURRENT_BINARY_DIR}/deal.II/base/config.h
-  )
-configure_file(
-  ${CMAKE_CURRENT_SOURCE_DIR}/deal.II/base/revision.h.in
-  ${CMAKE_CURRENT_BINARY_DIR}/deal.II/base/revision.h
-  )
+add_subdirectory(deal.II)
 
 #
-# Add a rule for how to install the header files:
+# Add a rule for how to install the header files that are part of the source tree:
 #
-install(DIRECTORY deal.II
+install(DIRECTORY ${CMAKE_CURRENT_SOURCE_DIR}/deal.II
   DESTINATION ${DEAL_II_INCLUDE_RELDIR}
   COMPONENT library
   FILES_MATCHING PATTERN "*.h"
diff --git a/include/deal.II/CMakeLists.txt b/include/deal.II/CMakeLists.txt
new file mode 100644 (file)
index 0000000..241b32f
--- /dev/null
@@ -0,0 +1,45 @@
+## ------------------------------------------------------------------------
+##
+## 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(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
new file mode 100644 (file)
index 0000000..55bba27
--- /dev/null
@@ -0,0 +1,16 @@
+## ------------------------------------------------------------------------
+##
+## 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
new file mode 100644 (file)
index 0000000..55bba27
--- /dev/null
@@ -0,0 +1,16 @@
+## ------------------------------------------------------------------------
+##
+## 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
new file mode 100644 (file)
index 0000000..0b7a880
--- /dev/null
@@ -0,0 +1,33 @@
+## ------------------------------------------------------------------------
+##
+## 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.
+##
+## ------------------------------------------------------------------------
+
+
+#
+# Configure config.h and revision.h
+#
+configure_file(
+  ${CMAKE_CURRENT_SOURCE_DIR}/config.h.in
+  ${CMAKE_CURRENT_BINARY_DIR}/config.h
+  )
+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
new file mode 100644 (file)
index 0000000..55bba27
--- /dev/null
@@ -0,0 +1,16 @@
+## ------------------------------------------------------------------------
+##
+## 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
new file mode 100644 (file)
index 0000000..55bba27
--- /dev/null
@@ -0,0 +1,16 @@
+## ------------------------------------------------------------------------
+##
+## 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
new file mode 100644 (file)
index 0000000..55bba27
--- /dev/null
@@ -0,0 +1,16 @@
+## ------------------------------------------------------------------------
+##
+## 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
new file mode 100644 (file)
index 0000000..55bba27
--- /dev/null
@@ -0,0 +1,16 @@
+## ------------------------------------------------------------------------
+##
+## 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
new file mode 100644 (file)
index 0000000..f96d447
--- /dev/null
@@ -0,0 +1,23 @@
+## ------------------------------------------------------------------------
+##
+## 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
new file mode 100644 (file)
index 0000000..55bba27
--- /dev/null
@@ -0,0 +1,16 @@
+## ------------------------------------------------------------------------
+##
+## 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
new file mode 100644 (file)
index 0000000..55bba27
--- /dev/null
@@ -0,0 +1,16 @@
+## ------------------------------------------------------------------------
+##
+## 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
new file mode 100644 (file)
index 0000000..55bba27
--- /dev/null
@@ -0,0 +1,16 @@
+## ------------------------------------------------------------------------
+##
+## 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
new file mode 100644 (file)
index 0000000..55bba27
--- /dev/null
@@ -0,0 +1,16 @@
+## ------------------------------------------------------------------------
+##
+## 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
new file mode 100644 (file)
index 0000000..55bba27
--- /dev/null
@@ -0,0 +1,16 @@
+## ------------------------------------------------------------------------
+##
+## 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
new file mode 100644 (file)
index 0000000..55bba27
--- /dev/null
@@ -0,0 +1,16 @@
+## ------------------------------------------------------------------------
+##
+## 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
new file mode 100644 (file)
index 0000000..55bba27
--- /dev/null
@@ -0,0 +1,16 @@
+## ------------------------------------------------------------------------
+##
+## 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
new file mode 100644 (file)
index 0000000..55bba27
--- /dev/null
@@ -0,0 +1,16 @@
+## ------------------------------------------------------------------------
+##
+## 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
new file mode 100644 (file)
index 0000000..55bba27
--- /dev/null
@@ -0,0 +1,16 @@
+## ------------------------------------------------------------------------
+##
+## 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
new file mode 100644 (file)
index 0000000..55bba27
--- /dev/null
@@ -0,0 +1,16 @@
+## ------------------------------------------------------------------------
+##
+## 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
new file mode 100644 (file)
index 0000000..55bba27
--- /dev/null
@@ -0,0 +1,16 @@
+## ------------------------------------------------------------------------
+##
+## 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
new file mode 100644 (file)
index 0000000..55bba27
--- /dev/null
@@ -0,0 +1,16 @@
+## ------------------------------------------------------------------------
+##
+## 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
new file mode 100644 (file)
index 0000000..55bba27
--- /dev/null
@@ -0,0 +1,16 @@
+## ------------------------------------------------------------------------
+##
+## 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
new file mode 100644 (file)
index 0000000..55bba27
--- /dev/null
@@ -0,0 +1,16 @@
+## ------------------------------------------------------------------------
+##
+## 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
new file mode 100644 (file)
index 0000000..55bba27
--- /dev/null
@@ -0,0 +1,16 @@
+## ------------------------------------------------------------------------
+##
+## 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
new file mode 100644 (file)
index 0000000..55bba27
--- /dev/null
@@ -0,0 +1,16 @@
+## ------------------------------------------------------------------------
+##
+## 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
new file mode 100644 (file)
index 0000000..5693a1c
--- /dev/null
@@ -0,0 +1,19 @@
+## ------------------------------------------------------------------------
+##
+## 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
new file mode 100644 (file)
index 0000000..55bba27
--- /dev/null
@@ -0,0 +1,16 @@
+## ------------------------------------------------------------------------
+##
+## 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
new file mode 100644 (file)
index 0000000..55bba27
--- /dev/null
@@ -0,0 +1,16 @@
+## ------------------------------------------------------------------------
+##
+## 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
new file mode 100644 (file)
index 0000000..74d92d4
--- /dev/null
@@ -0,0 +1,21 @@
+## ------------------------------------------------------------------------
+##
+## 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
new file mode 100644 (file)
index 0000000..55bba27
--- /dev/null
@@ -0,0 +1,16 @@
+## ------------------------------------------------------------------------
+##
+## 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
new file mode 100644 (file)
index 0000000..55bba27
--- /dev/null
@@ -0,0 +1,16 @@
+## ------------------------------------------------------------------------
+##
+## 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
new file mode 100644 (file)
index 0000000..55bba27
--- /dev/null
@@ -0,0 +1,16 @@
+## ------------------------------------------------------------------------
+##
+## 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
new file mode 100644 (file)
index 0000000..fbd19e4
--- /dev/null
@@ -0,0 +1,15 @@
+## ------------------------------------------------------------------------
+##
+## 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.