]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Indent Python scripts. 18489/head
authorWolfgang Bangerth <bangerth@colostate.edu>
Tue, 27 May 2025 14:58:11 +0000 (08:58 -0600)
committerWolfgang Bangerth <bangerth@colostate.edu>
Tue, 27 May 2025 14:58:11 +0000 (08:58 -0600)
contrib/utilities/convert_header_file_to_interface_module_unit.py
contrib/utilities/convert_source_file_to_implementation_module_unit.py
contrib/utilities/convert_to_module_units_common.py

index f20286f1a8045f8f9dfd1ccf5e6c470644137e96..d4e2d252500bfc51e791bbce206590d99c924241 100644 (file)
@@ -29,7 +29,7 @@ import re
 import convert_to_module_units_common as header_to_partition_maps
 
 
-header_file                = sys.argv[1]
+header_file = sys.argv[1]
 interface_module_unit_file = sys.argv[2]
 
 assert header_file, "No input file name given."
@@ -45,7 +45,6 @@ lines = input.readlines()
 input.close()
 
 
-
 # Regular expressions that match the preprocessor defines that we use
 # to open and close the deal.II namespace. We allow for whitespace
 # before and after, but nothing else in these regular
@@ -77,7 +76,7 @@ output.write("module;\n")
 output.write("#include <deal.II/macros.h>\n\n")
 
 # Then go through the lines of the input file again:
-for line in lines :
+for line in lines:
 
     # If this was an '#include' directive for a deal.II header, or an
     # external project that we wrap, then just ignore/remove this
@@ -92,11 +91,12 @@ for line in lines :
     # specifically marked with a comment. But we do not allow this
     # in interface units (header files) and so error out if someone
     # tries this.
-    if (header_to_partition_maps.match_dealii_includes.match(line) or
-        header_to_partition_maps.matches_external_header_include(line)) :
-        if "Do not convert for module purposes" in line :
+    if header_to_partition_maps.match_dealii_includes.match(
+        line
+    ) or header_to_partition_maps.matches_external_header_include(line):
+        if "Do not convert for module purposes" in line:
             raise "It is not allowed to escape the conversion of include statements in header files."
-        else :
+        else:
             pass
 
     # If this line contained the text DEAL_II_NAMESPACE_OPEN, then
@@ -112,13 +112,15 @@ for line in lines :
     # header files by not only importing partitions, but re-exporting
     # them as well via the 'export import :interface_partition;'
     # statement.
-    elif match_dealii_open.match(line) :
-        output.write("\nexport module dealii : " + interface_module_partition_name + ";\n\n")
+    elif match_dealii_open.match(line):
+        output.write(
+            "\nexport module dealii : " + interface_module_partition_name + ";\n\n"
+        )
 
-        for external_project in used_external_projects :
+        for external_project in used_external_projects:
             output.write("import :interface_partition_" + external_project + ";\n")
 
-        for inc in dealii_include_list :
+        for inc in dealii_include_list:
             module_partition = "interface_partition_" + inc.replace("/", "_")
             output.write("import :" + module_partition + ";\n")
 
@@ -127,10 +129,10 @@ for line in lines :
 
     # If this line contained the text DEAL_II_NAMESPACE_CLODE, then
     # close the previous 'export {' statement:
-    elif match_dealii_close.match(line) :
+    elif match_dealii_close.match(line):
         output.write(line)  # Copy the previous line
         output.write("\n} // close previous 'export' statement\n\n")
 
     # Otherwise just copy the previous line:
-    else :
+    else:
         output.write(line)
index 8e95a89c177223315084656eb5778c4cc67d3df4..3c11c5041088156d829333a828c0572894fa398a 100644 (file)
@@ -30,14 +30,16 @@ import re
 import convert_to_module_units_common as header_to_partition_maps
 
 
-source_file                = sys.argv[1]
+source_file = sys.argv[1]
 implementation_module_unit_file = sys.argv[2]
 
 assert source_file, "No input file name given."
 assert implementation_module_unit_file, "No output file name given."
 
 m = re.search(r".*source/(.*).cc", source_file)
-implementation_module_partition_name = "implementation_partition_" + m.group(1).replace("/", "_")
+implementation_module_partition_name = "implementation_partition_" + m.group(1).replace(
+    "/", "_"
+)
 
 
 # Read the entire source file into memory:
@@ -71,7 +73,7 @@ output.write("#include <deal.II/macros.h>\n\n")
 
 
 # Then go through the lines of the input file again:
-for line in lines :
+for line in lines:
 
     # If this was an '#include' directive for a deal.II header, or an
     # external project that we wrap, then just ignore/remove this
@@ -84,29 +86,32 @@ for line in lines :
     # dozens or hundreds of (transitive) includes. As a consequence,
     # we do allow #includes in specific circumstances, when they are
     # specifically marked with a comment.
-    if (header_to_partition_maps.match_dealii_includes.match(line) or
-        header_to_partition_maps.matches_external_header_include(line)) :
-        if "Do not convert for module purposes" in line :
+    if header_to_partition_maps.match_dealii_includes.match(
+        line
+    ) or header_to_partition_maps.matches_external_header_include(line):
+        if "Do not convert for module purposes" in line:
             output.write(line)
-        else :
+        else:
             pass
 
     # If this line contained the text DEAL_II_NAMESPACE_OPEN, then
     # prefix this text by the implementation module unit start, the import
     # statements that correspond to the previously '#include'd header
     # files, but importantly no 'export {' statement:
-    elif match_dealii_open.match(line) :
-        output.write("module dealii : " + implementation_module_partition_name + ";\n\n")
+    elif match_dealii_open.match(line):
+        output.write(
+            "module dealii : " + implementation_module_partition_name + ";\n\n"
+        )
 
-        for external_project in used_external_projects :
+        for external_project in used_external_projects:
             output.write("import :interface_partition_" + external_project + ";\n")
 
-        for inc in dealii_include_list :
+        for inc in dealii_include_list:
             module_partition = "interface_partition_" + inc.replace("/", "_")
             output.write("import :" + module_partition + ";\n")
         output.write("\n")
         output.write(line)  # Copy the previous line
 
     # Otherwise just copy the previous line:
-    else :
+    else:
         output.write(line)
index d385640af853fa6354fc26766950c1590548c133..264bb10f687964b142e9aead8eeffa26343df96d 100644 (file)
@@ -26,291 +26,314 @@ import re
 # deal.II and all other external dependencies we use.. The list of C++
 # headers is from
 # https://stackoverflow.com/questions/2027991/list-of-standard-header-files-in-c-and-c
-dealii_includes = [ "deal.II/(.*).h" ]
-
-adolc_includes  = [ "adolc/.*" ]
-
-boost_includes  = [ "boost/.*" ]
-
-cgal_includes  = [ "CGAL/.*" ]
-
-hdf5_includes  = [ "hdf5.h" ]
-
-kokkos_includes = [ "Kokkos.*" ]
-
-metis_includes = [ "metis.h" ]
-
-mpi_includes = [ "mpi.h" ]
-
-mumps_includes = [ "mumps_.*.h" ]
-
-muparser_includes = [ "muParser.h" ]
-
-opencascade_includes = [ "Adaptor3d_Curve.hxx",
-                         "Adaptor3d_HCurve.hxx",
-                         "BRep.*.hxx",
-                         "Geom.*.hxx",
-                         "Handle.*.hxx",
-                         "IGESControl.*.hxx",
-                         "IFSelect_ReturnStatus.hxx",
-                         "IntCurve.*.hxx",
-                         "Poly_Triangulation.hxx",
-                         "ShapeAnalysis.*.hxx",
-                         "Standard_Transient.hxx",
-                         "STEPControl.*.hxx",
-                         "StlAPI.*.hxx",
-                         "TCol.*.hxx",
-                         "Top.*.hxx",
-                         "TopoDS.*.hxx",
-                         "gp_.*.hxx" ]
-
-p4est_includes  = [ "p4est.*",
-                    "p8est.*",
-                    "sc_containers.h" ]
-
-slepc_includes = [ "slepc.*.h" ]
-
-petsc_includes  = [ "petscconf.h",
-                    "petscdm.h",
-                    "petscerror.h",
-                    "petscis.h",
-                    "petscistypes.h",
-                    "petscksp.h",
-                    "petscmat.h",
-                    "petscpc.h",
-                    "petscsf.h",
-                    "petscsnes.h",
-                    "petscsys.h",
-                    "petscts.h",
-                    "petscvec.h",
-                    "petsc/.*.h" ]
-
-std_includes    = [ "assert.h",
-                    "limits.h",
-                    "signal.h",
-                    "stdlib.h",
-                    "ctype.h",
-                    "locale.h",
-                    "stdarg.h",
-                    "string.h",
-                    "errno.h",
-                    "math.h",
-                    "stddef.h",
-                    "time.h",
-                    "float.h",
-                    "setjmp.h",
-                    "stdio.h",
-                    "algorithm",
-                    "format",
-                    "new",
-                    "stdexcept",
-                    "any",
-                    "forward_list",
-                    "numbers",
-                    "stdfloat",
-                    "array",
-                    "fstream",
-                    "numeric",
-                    "stop_token",
-                    "atomic",
-                    "functional",
-                    "optional",
-                    "streambuf",
-                    "barrier",
-                    "future",
-                    "ostream",
-                    "string",
-                    "bit",
-                    "generator",
-                    "print",
-                    "string_view",
-                    "bitset",
-                    "initializer_list",
-#                    "queue",   # excluded for now due to https://github.com/llvm/llvm-project/issues/138558
-                    "strstream",
-                    "charconv",
-                    "iomanip",
-#                    "random",   # excluded for now due to https://github.com/llvm/llvm-project/issues/138558
-                    "syncstream",
-                    "chrono",
-                    "ios",
-                    "ranges",
-                    "system_error",
-                    "codecvt",
-                    "iosfwd",
-                    "ratio",
-                    "thread",
-                    "compare",
-                    "iostream",
-                    "regex",
-                    "tuple",
-                    "complex",
-                    "istream",
-                    "scoped_allocator",
-                    "type_traits",
-                    "concepts",
-                    "iterator",
-                    "semaphore",
-                    "typeindex",
-                    "condition_variable",
-                    "latch",
-                    "set",
-                    "typeinfo",
-                    "coroutine",
-                    "limits",
-                    "shared_mutex",
-                    "unordered_map",
-                    "deque",
-                    "list",
-                    "source_location",
-                    "unordered_set",
-                    "exception",
-                    "locale",
-                    "span",
-                    "utility",
-                    "execution",
-                    "map",
-                    "spanstream",
-                    "valarray",
-                    "expected",
-                    "mdspan",
-                    "sstream",
-                    "variant",
-                    "filesystem",
-                    "memory",
-#                    "stack",   # excluded for now due to https://github.com/llvm/llvm-project/issues/138558
-                    "vector",
-                    "flat_map",
-                    "memory_resource",
-                    "stacktrace",
-                    "version",
-                    "flat_set",
-                    "mutex",
-                    "cassert",
-                    "cfenv",
-                    "climits",
-                    "csetjmp",
-                    "cstddef",
-                    "cstdlib",
-                    "cuchar",
-                    "cctype",
-                    "cfloat",
-                    "clocale",
-                    "csignal",
-                    "cstdint",
-                    "cstring",
-                    "cwchar",
-                    "cerrno",
-                    "cinttypes",
-                    "cmath",
-                    "cstdarg",
-                    "cstdio",
-                    "ctime",
-                    "cwctype" ]
-
-sundials_includes = [ "arkode/arkode.*",
-                      "ida/ida.h",
-                      "idas/idas.h",
-                      "kinsol/kinsol.*",
-                      "nvector/nvector_parallel.h",
-                      "nvector/nvector_serial.h",
-                      "sundials/sundials_.*",
-                      "sunlinsol/sunlinsol_.*",
-                      "sunmatrix/sunmatrix_.*",
-                      "sunnonlinsol/sunnonlinsol_.*" ]
-
-taskflow_includes = [ "taskflow/.*" ]
-
-tbb_includes = [ "tbb/.*" ]
-
-trilinos_includes = [ "Amesos.*",
-                      "AztecOO.h",
-                      "Belos.*",
-                      "Epetra.*",
-                      "Ifpack2.*",
-                      "NOX.*",
-                      "Rol.*",
-                      "ROL.*",
-                      "Sacado.*",
-                      "Teuchos.*",
-                      "Tpetra.*",
-                      "zoltan_cpp.h",
-                      "exodusII.h" ]
-
-umfpack_includes = [ "umfpack.h" ]
-
-vtk_includes = [ "vtk.*" ]
-
-zlib_includes = [ "zlib.h" ]
+dealii_includes = ["deal.II/(.*).h"]
+
+adolc_includes = ["adolc/.*"]
+
+boost_includes = ["boost/.*"]
+
+cgal_includes = ["CGAL/.*"]
+
+hdf5_includes = ["hdf5.h"]
+
+kokkos_includes = ["Kokkos.*"]
+
+metis_includes = ["metis.h"]
+
+mpi_includes = ["mpi.h"]
+
+mumps_includes = ["mumps_.*.h"]
+
+muparser_includes = ["muParser.h"]
+
+opencascade_includes = [
+    "Adaptor3d_Curve.hxx",
+    "Adaptor3d_HCurve.hxx",
+    "BRep.*.hxx",
+    "Geom.*.hxx",
+    "Handle.*.hxx",
+    "IGESControl.*.hxx",
+    "IFSelect_ReturnStatus.hxx",
+    "IntCurve.*.hxx",
+    "Poly_Triangulation.hxx",
+    "ShapeAnalysis.*.hxx",
+    "Standard_Transient.hxx",
+    "STEPControl.*.hxx",
+    "StlAPI.*.hxx",
+    "TCol.*.hxx",
+    "Top.*.hxx",
+    "TopoDS.*.hxx",
+    "gp_.*.hxx",
+]
+
+p4est_includes = ["p4est.*", "p8est.*", "sc_containers.h"]
+
+slepc_includes = ["slepc.*.h"]
+
+petsc_includes = [
+    "petscconf.h",
+    "petscdm.h",
+    "petscerror.h",
+    "petscis.h",
+    "petscistypes.h",
+    "petscksp.h",
+    "petscmat.h",
+    "petscpc.h",
+    "petscsf.h",
+    "petscsnes.h",
+    "petscsys.h",
+    "petscts.h",
+    "petscvec.h",
+    "petsc/.*.h",
+]
+
+std_includes = [
+    "assert.h",
+    "limits.h",
+    "signal.h",
+    "stdlib.h",
+    "ctype.h",
+    "locale.h",
+    "stdarg.h",
+    "string.h",
+    "errno.h",
+    "math.h",
+    "stddef.h",
+    "time.h",
+    "float.h",
+    "setjmp.h",
+    "stdio.h",
+    "algorithm",
+    "format",
+    "new",
+    "stdexcept",
+    "any",
+    "forward_list",
+    "numbers",
+    "stdfloat",
+    "array",
+    "fstream",
+    "numeric",
+    "stop_token",
+    "atomic",
+    "functional",
+    "optional",
+    "streambuf",
+    "barrier",
+    "future",
+    "ostream",
+    "string",
+    "bit",
+    "generator",
+    "print",
+    "string_view",
+    "bitset",
+    "initializer_list",
+    #                    "queue",   # excluded for now due to https://github.com/llvm/llvm-project/issues/138558
+    "strstream",
+    "charconv",
+    "iomanip",
+    #                    "random",   # excluded for now due to https://github.com/llvm/llvm-project/issues/138558
+    "syncstream",
+    "chrono",
+    "ios",
+    "ranges",
+    "system_error",
+    "codecvt",
+    "iosfwd",
+    "ratio",
+    "thread",
+    "compare",
+    "iostream",
+    "regex",
+    "tuple",
+    "complex",
+    "istream",
+    "scoped_allocator",
+    "type_traits",
+    "concepts",
+    "iterator",
+    "semaphore",
+    "typeindex",
+    "condition_variable",
+    "latch",
+    "set",
+    "typeinfo",
+    "coroutine",
+    "limits",
+    "shared_mutex",
+    "unordered_map",
+    "deque",
+    "list",
+    "source_location",
+    "unordered_set",
+    "exception",
+    "locale",
+    "span",
+    "utility",
+    "execution",
+    "map",
+    "spanstream",
+    "valarray",
+    "expected",
+    "mdspan",
+    "sstream",
+    "variant",
+    "filesystem",
+    "memory",
+    #                    "stack",   # excluded for now due to https://github.com/llvm/llvm-project/issues/138558
+    "vector",
+    "flat_map",
+    "memory_resource",
+    "stacktrace",
+    "version",
+    "flat_set",
+    "mutex",
+    "cassert",
+    "cfenv",
+    "climits",
+    "csetjmp",
+    "cstddef",
+    "cstdlib",
+    "cuchar",
+    "cctype",
+    "cfloat",
+    "clocale",
+    "csignal",
+    "cstdint",
+    "cstring",
+    "cwchar",
+    "cerrno",
+    "cinttypes",
+    "cmath",
+    "cstdarg",
+    "cstdio",
+    "ctime",
+    "cwctype",
+]
+
+sundials_includes = [
+    "arkode/arkode.*",
+    "ida/ida.h",
+    "idas/idas.h",
+    "kinsol/kinsol.*",
+    "nvector/nvector_parallel.h",
+    "nvector/nvector_serial.h",
+    "sundials/sundials_.*",
+    "sunlinsol/sunlinsol_.*",
+    "sunmatrix/sunmatrix_.*",
+    "sunnonlinsol/sunnonlinsol_.*",
+]
+
+taskflow_includes = ["taskflow/.*"]
+
+tbb_includes = ["tbb/.*"]
+
+trilinos_includes = [
+    "Amesos.*",
+    "AztecOO.h",
+    "Belos.*",
+    "Epetra.*",
+    "Ifpack2.*",
+    "NOX.*",
+    "Rol.*",
+    "ROL.*",
+    "Sacado.*",
+    "Teuchos.*",
+    "Tpetra.*",
+    "zoltan_cpp.h",
+    "exodusII.h",
+]
+
+umfpack_includes = ["umfpack.h"]
+
+vtk_includes = ["vtk.*"]
+
+zlib_includes = ["zlib.h"]
 
 # Define regexs to match header #includes for each of the categories above
-match_dealii_includes      = re.compile("# *include *<" + "|".join(dealii_includes) + ">")
-
-match_adolc_includes       = re.compile("# *include *<(" + "|".join(adolc_includes)      + ")>")
-match_boost_includes       = re.compile("# *include *<(" + "|".join(boost_includes)      + ")>")
-match_cgal_includes        = re.compile("# *include *<(" + "|".join(cgal_includes)       + ")>")
-match_hdf5_includes        = re.compile("# *include *<(" + "|".join(hdf5_includes)       + ")>")
-match_kokkos_includes      = re.compile("# *include *<(" + "|".join(kokkos_includes)     + ")>")
-match_metis_includes       = re.compile("# *include *<(" + "|".join(metis_includes)      + ")>")
-match_mpi_includes         = re.compile("# *include *<(" + "|".join(mpi_includes)        + ")>")
-match_mumps_includes       = re.compile("# *include *<(" + "|".join(mumps_includes)        + ")>")
-match_muparser_includes    = re.compile("# *include *<(" + "|".join(muparser_includes)        + ")>")
-match_opencascade_includes = re.compile("# *include *<(" + "|".join(opencascade_includes)+ ")>")
-match_p4est_includes       = re.compile("# *include *<(" + "|".join(p4est_includes)      + ")>")
-match_petsc_includes       = re.compile("# *include *<(" + "|".join(petsc_includes)      + ")>")
-match_slepc_includes       = re.compile("# *include *<(" + "|".join(slepc_includes)      + ")>")
-match_std_includes         = re.compile("# *include *<(" + "|".join(std_includes)        + ")>")
-match_sundials_includes    = re.compile("# *include *<(" + "|".join(sundials_includes)   + ")>")
-match_taskflow_includes    = re.compile("# *include *<(" + "|".join(taskflow_includes)        + ")>")
-match_tbb_includes         = re.compile("# *include *<(" + "|".join(tbb_includes)        + ")>")
-match_trilinos_includes    = re.compile("# *include *<(" + "|".join(trilinos_includes)   + ")>")
-match_umfpack_includes     = re.compile("# *include *<(" + "|".join(umfpack_includes)    + ")>")
-match_vtk_includes         = re.compile("# *include *<(" + "|".join(vtk_includes)        + ")>")
-match_zlib_includes        = re.compile("# *include *<(" + "|".join(zlib_includes)       + ")>")
-
-external_package_headers_regex_map = { "adolc"       : match_adolc_includes,
-                                       "boost"       : match_boost_includes,
-                                       "cgal"        : match_cgal_includes,
-                                       "hdf5"        : match_hdf5_includes,
-                                       "kokkos"      : match_kokkos_includes,
-                                       "metis"       : match_metis_includes,
-                                       "mpi"         : match_mpi_includes,
-                                       "mumps"       : match_mumps_includes,
-                                       "muparser"    : match_muparser_includes,
-                                       "opencascade" : match_opencascade_includes,
-                                       "p4est"       : match_p4est_includes,
-                                       "petsc"       : match_petsc_includes,
-                                       "slepc"       : match_slepc_includes,
-                                       "std"         : match_std_includes,
-                                       "sundials"    : match_sundials_includes,
-                                       "taskflow"    : match_taskflow_includes,
-                                       "tbb"         : match_tbb_includes,
-                                       "trilinos"    : match_trilinos_includes,
-                                       "umfpack"     : match_umfpack_includes,
-                                       "vtk"         : match_vtk_includes,
-                                       "zlib"        : match_zlib_includes }
+match_dealii_includes = re.compile("# *include *<" + "|".join(dealii_includes) + ">")
+
+match_adolc_includes = re.compile("# *include *<(" + "|".join(adolc_includes) + ")>")
+match_boost_includes = re.compile("# *include *<(" + "|".join(boost_includes) + ")>")
+match_cgal_includes = re.compile("# *include *<(" + "|".join(cgal_includes) + ")>")
+match_hdf5_includes = re.compile("# *include *<(" + "|".join(hdf5_includes) + ")>")
+match_kokkos_includes = re.compile("# *include *<(" + "|".join(kokkos_includes) + ")>")
+match_metis_includes = re.compile("# *include *<(" + "|".join(metis_includes) + ")>")
+match_mpi_includes = re.compile("# *include *<(" + "|".join(mpi_includes) + ")>")
+match_mumps_includes = re.compile("# *include *<(" + "|".join(mumps_includes) + ")>")
+match_muparser_includes = re.compile(
+    "# *include *<(" + "|".join(muparser_includes) + ")>"
+)
+match_opencascade_includes = re.compile(
+    "# *include *<(" + "|".join(opencascade_includes) + ")>"
+)
+match_p4est_includes = re.compile("# *include *<(" + "|".join(p4est_includes) + ")>")
+match_petsc_includes = re.compile("# *include *<(" + "|".join(petsc_includes) + ")>")
+match_slepc_includes = re.compile("# *include *<(" + "|".join(slepc_includes) + ")>")
+match_std_includes = re.compile("# *include *<(" + "|".join(std_includes) + ")>")
+match_sundials_includes = re.compile(
+    "# *include *<(" + "|".join(sundials_includes) + ")>"
+)
+match_taskflow_includes = re.compile(
+    "# *include *<(" + "|".join(taskflow_includes) + ")>"
+)
+match_tbb_includes = re.compile("# *include *<(" + "|".join(tbb_includes) + ")>")
+match_trilinos_includes = re.compile(
+    "# *include *<(" + "|".join(trilinos_includes) + ")>"
+)
+match_umfpack_includes = re.compile(
+    "# *include *<(" + "|".join(umfpack_includes) + ")>"
+)
+match_vtk_includes = re.compile("# *include *<(" + "|".join(vtk_includes) + ")>")
+match_zlib_includes = re.compile("# *include *<(" + "|".join(zlib_includes) + ")>")
+
+external_package_headers_regex_map = {
+    "adolc": match_adolc_includes,
+    "boost": match_boost_includes,
+    "cgal": match_cgal_includes,
+    "hdf5": match_hdf5_includes,
+    "kokkos": match_kokkos_includes,
+    "metis": match_metis_includes,
+    "mpi": match_mpi_includes,
+    "mumps": match_mumps_includes,
+    "muparser": match_muparser_includes,
+    "opencascade": match_opencascade_includes,
+    "p4est": match_p4est_includes,
+    "petsc": match_petsc_includes,
+    "slepc": match_slepc_includes,
+    "std": match_std_includes,
+    "sundials": match_sundials_includes,
+    "taskflow": match_taskflow_includes,
+    "tbb": match_tbb_includes,
+    "trilinos": match_trilinos_includes,
+    "umfpack": match_umfpack_includes,
+    "vtk": match_vtk_includes,
+    "zlib": match_zlib_includes,
+}
 
 
 # A function that given a list of strings (specifically: the
 # individual lines of a file) returns the list of deal.II header files
 # that are being #included, excluding "config.h" and "exception_macros.h".
-def get_dealii_includes(lines) :
+def get_dealii_includes(lines):
     dealii_include_list = []
-    for line in lines :
+    for line in lines:
         m = match_dealii_includes.match(line)
-        if m :
-            if (m.group(1) != "base/config") and (m.group(1) != "base/exception_macros") :
+        if m:
+            if (m.group(1) != "base/config") and (
+                m.group(1) != "base/exception_macros"
+            ):
                 dealii_include_list.append(m.group(1))
     return dealii_include_list
 
 
-
 # Return whether a line in a header or source file matches an #include
 # statement for any of the recognized external projects that we wrap
 # in module partitions:
-def matches_external_header_include(line) :
-    for package,regex in external_package_headers_regex_map.items() :
-        if regex.match(line) :
+def matches_external_header_include(line):
+    for package, regex in external_package_headers_regex_map.items():
+        if regex.match(line):
             return True
     return False
 
@@ -320,13 +343,13 @@ def matches_external_header_include(line) :
 # we wrap in module partitions are actually being used by this one
 # file (as indicated by this file #including any of the corresponding
 # header files of that external project).
-def get_used_external_projects(lines) :
+def get_used_external_projects(lines):
     used_external_projects = set()
     my_external_package_headers_regex_map = external_package_headers_regex_map.copy()
-    
-    for line in lines :
-        for package, regex in my_external_package_headers_regex_map.items() :
-            if regex.match(line) :
+
+    for line in lines:
+        for package, regex in my_external_package_headers_regex_map.items():
+            if regex.match(line):
                 # The current line matches an external package's
                 # headers. Once we have determined that a file uses an
                 # external package, we no longer need to test for that and

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.