From 0f1670800920862ecf3b9c3733d689ca2eeb3342 Mon Sep 17 00:00:00 2001 From: Marc Fehling Date: Fri, 28 Nov 2025 10:14:56 +0100 Subject: [PATCH] Bump deal.II version requirement to 9.6.0. --- .github/workflows/linux.yml | 2 +- CeresFE/CMakeLists.txt | 2 +- Crystal_Growth_Phase_Field_Model/CMakeLists.txt | 2 +- Distributed_LDG_Method/CMakeLists.txt | 2 +- Distributed_Moving_Laser_Heating/CMakeLists.txt | 2 +- ElastoplasticTorsion/CMakeLists.txt | 2 +- Heat_Eqn_Parallel/CMakeLists.txt | 2 +- .../CMakeLists.txt | 2 +- MCMC-Laplace/CMakeLists.txt | 2 +- Maxwell-Eigenvalue-hp-Refinement/CMakeLists.txt | 2 +- Maxwell-Eigenvalue-hp-Refinement/maxwell-hp.cc | 16 ++-------------- .../CMakeLists.txt | 2 +- NavierStokes_TRBDF2_DG/CMakeLists.txt | 2 +- Nonlinear_PoroViscoelasticity/CMakeLists.txt | 2 +- .../nonlinear-poro-viscoelasticity.cc | 4 ---- Phase_field_fracture_model_in_3D/CMakeLists.txt | 2 +- .../CMakeLists.txt | 2 +- .../CMakeLists.txt | 2 +- .../viscoelastic_strip_with_hole.cc | 4 ---- Swift-Hohenberg-Solver/CMakeLists.txt | 2 +- TravelingWaves/CMakeLists.txt | 2 +- advection_reaction_estimator/CMakeLists.txt | 2 +- cdr/CMakeLists.txt | 2 +- coupled_laplace_problem/CMakeLists.txt | 2 +- goal_oriented_elastoplasticity/CMakeLists.txt | 2 +- information_based_mesh_refinement/CMakeLists.txt | 2 +- .../CMakeLists.txt | 2 +- parallel_in_time/CMakeLists.txt | 2 +- time_dependent_navier_stokes/CMakeLists.txt | 2 +- two_phase_flow/CMakeLists.txt | 2 +- two_phase_flow/LevelSetSolver.cc | 4 ---- two_phase_flow/MultiPhase.cc | 4 ---- two_phase_flow/NavierStokesSolver.cc | 8 -------- two_phase_flow/TestLevelSet.cc | 8 -------- two_phase_flow/TestNavierStokes.cc | 4 ---- 35 files changed, 29 insertions(+), 77 deletions(-) diff --git a/.github/workflows/linux.yml b/.github/workflows/linux.yml index 8fcb9be8..8322d2ef 100644 --- a/.github/workflows/linux.yml +++ b/.github/workflows/linux.yml @@ -23,7 +23,7 @@ jobs: fail-fast: false matrix: build_type: ["Debug"] - dealii_version: ["master", "v9.7.1", "v9.6.0", "v9.5.0"] + dealii_version: ["master", "v9.7.1", "v9.6.0"] ubuntu_version: ["jammy"] include: - build_type: "Debug" diff --git a/CeresFE/CMakeLists.txt b/CeresFE/CMakeLists.txt index 56d803d4..fd151347 100644 --- a/CeresFE/CMakeLists.txt +++ b/CeresFE/CMakeLists.txt @@ -4,7 +4,7 @@ CMAKE_MINIMUM_REQUIRED(VERSION 3.13.4) -FIND_PACKAGE(deal.II 9.5.0 +FIND_PACKAGE(deal.II 9.6.0 HINTS ${deal.II_DIR} ${DEAL_II_DIR} ../ ../../ $ENV{DEAL_II_DIR} ) diff --git a/Crystal_Growth_Phase_Field_Model/CMakeLists.txt b/Crystal_Growth_Phase_Field_Model/CMakeLists.txt index 0491fd08..23b57b01 100644 --- a/Crystal_Growth_Phase_Field_Model/CMakeLists.txt +++ b/Crystal_Growth_Phase_Field_Model/CMakeLists.txt @@ -17,7 +17,7 @@ SET(TARGET_SRC get_random_number.cpp ) -FIND_PACKAGE(deal.II 9.5.0 QUIET +FIND_PACKAGE(deal.II 9.6.0 QUIET HINTS ${deal.II_DIR} ${DEAL_II_DIR} ../ ../../ $ENV{DEAL_II_DIR} ) IF(NOT ${deal.II_FOUND}) diff --git a/Distributed_LDG_Method/CMakeLists.txt b/Distributed_LDG_Method/CMakeLists.txt index e630fd04..e0249ba3 100644 --- a/Distributed_LDG_Method/CMakeLists.txt +++ b/Distributed_LDG_Method/CMakeLists.txt @@ -18,7 +18,7 @@ SET(CLEAN_UP_FILES *.vtu *.pvtu *.visit) CMAKE_MINIMUM_REQUIRED(VERSION 3.13.4) -FIND_PACKAGE(deal.II 9.5.0 +FIND_PACKAGE(deal.II 9.6.0 HINTS ${deal.II_DIR} ${DEAL_II_DIR} ../ ../../ $ENV{DEAL_II_DIR} ) IF(NOT ${deal.II_FOUND}) diff --git a/Distributed_Moving_Laser_Heating/CMakeLists.txt b/Distributed_Moving_Laser_Heating/CMakeLists.txt index 100396f6..de732a2e 100644 --- a/Distributed_Moving_Laser_Heating/CMakeLists.txt +++ b/Distributed_Moving_Laser_Heating/CMakeLists.txt @@ -23,7 +23,7 @@ SET(TARGET_SRC CMAKE_MINIMUM_REQUIRED(VERSION 3.13.4) -FIND_PACKAGE(deal.II 9.5.0 QUIET +FIND_PACKAGE(deal.II 9.6.0 QUIET HINTS ${deal.II_DIR} ${DEAL_II_DIR} ../ ../../ $ENV{DEAL_II_DIR} ) IF(NOT ${deal.II_FOUND}) diff --git a/ElastoplasticTorsion/CMakeLists.txt b/ElastoplasticTorsion/CMakeLists.txt index 0622d5d5..059c5ac9 100644 --- a/ElastoplasticTorsion/CMakeLists.txt +++ b/ElastoplasticTorsion/CMakeLists.txt @@ -24,7 +24,7 @@ SET(TARGET_SRC CMAKE_MINIMUM_REQUIRED(VERSION 3.13.4) -FIND_PACKAGE(deal.II 9.5.0 +FIND_PACKAGE(deal.II 9.6.0 HINTS ${deal.II_DIR} ${DEAL_II_DIR} ../ ../../ $ENV{DEAL_II_DIR} ) IF(NOT ${deal.II_FOUND}) diff --git a/Heat_Eqn_Parallel/CMakeLists.txt b/Heat_Eqn_Parallel/CMakeLists.txt index 6c787b56..498214be 100644 --- a/Heat_Eqn_Parallel/CMakeLists.txt +++ b/Heat_Eqn_Parallel/CMakeLists.txt @@ -23,7 +23,7 @@ SET(TARGET_SRC CMAKE_MINIMUM_REQUIRED(VERSION 3.13.4) -FIND_PACKAGE(deal.II 9.5.0 +FIND_PACKAGE(deal.II 9.6.0 HINTS ${deal.II_DIR} ${DEAL_II_DIR} ../ ../../ $ENV{DEAL_II_DIR} ) IF(NOT ${deal.II_FOUND}) diff --git a/Linear_Elastic_Active_Skeletal_Muscle_Model/CMakeLists.txt b/Linear_Elastic_Active_Skeletal_Muscle_Model/CMakeLists.txt index b0b832b8..2682a08f 100644 --- a/Linear_Elastic_Active_Skeletal_Muscle_Model/CMakeLists.txt +++ b/Linear_Elastic_Active_Skeletal_Muscle_Model/CMakeLists.txt @@ -23,7 +23,7 @@ SET(TARGET_SRC CMAKE_MINIMUM_REQUIRED(VERSION 3.13.4) -FIND_PACKAGE(deal.II 9.5.0 +FIND_PACKAGE(deal.II 9.6.0 HINTS ${deal.II_DIR} ${DEAL_II_DIR} ../ ../../ $ENV{DEAL_II_DIR} ) IF(NOT ${deal.II_FOUND}) diff --git a/MCMC-Laplace/CMakeLists.txt b/MCMC-Laplace/CMakeLists.txt index f8bf8fd8..fc34f8d3 100644 --- a/MCMC-Laplace/CMakeLists.txt +++ b/MCMC-Laplace/CMakeLists.txt @@ -4,7 +4,7 @@ CMAKE_MINIMUM_REQUIRED(VERSION 3.13.4) -FIND_PACKAGE(deal.II 9.5.0 +FIND_PACKAGE(deal.II 9.6.0 HINTS ${deal.II_DIR} ${DEAL_II_DIR} ../ ../../ $ENV{DEAL_II_DIR} ) diff --git a/Maxwell-Eigenvalue-hp-Refinement/CMakeLists.txt b/Maxwell-Eigenvalue-hp-Refinement/CMakeLists.txt index e53edea1..ccaa2c29 100644 --- a/Maxwell-Eigenvalue-hp-Refinement/CMakeLists.txt +++ b/Maxwell-Eigenvalue-hp-Refinement/CMakeLists.txt @@ -10,7 +10,7 @@ SET(TARGET_SRC CMAKE_MINIMUM_REQUIRED(VERSION 3.13.4) -FIND_PACKAGE(deal.II 9.5.0 +FIND_PACKAGE(deal.II 9.6.0 HINTS ${deal.II_DIR} ${DEAL_II_DIR} ../ ../../ $ENV{DEAL_II_DIR} ) IF(NOT ${deal.II_FOUND}) diff --git a/Maxwell-Eigenvalue-hp-Refinement/maxwell-hp.cc b/Maxwell-Eigenvalue-hp-Refinement/maxwell-hp.cc index c47a08e9..28f9607b 100644 --- a/Maxwell-Eigenvalue-hp-Refinement/maxwell-hp.cc +++ b/Maxwell-Eigenvalue-hp-Refinement/maxwell-hp.cc @@ -1673,12 +1673,8 @@ namespace ErrorIndicators void prune_eigenpairs(const double &TOL); -#if DEAL_II_VERSION_GTE(9, 6, 0) - std::vector *> eigenfunction_ptrs; -#else - std::vector eigenfunction_ptrs; -#endif - std::vector eigenvalue_ptrs; + std::vector *> eigenfunction_ptrs; + std::vector eigenvalue_ptrs; std::vector>> errors; }; @@ -1808,7 +1804,6 @@ namespace ErrorIndicators estimated_error_per_cell[i] = errors[i].get(); } -#if DEAL_II_VERSION_GTE(9, 6, 0) const auto solution_view = make_array_view(eigenfunction_ptrs); auto error_view = make_array_view(estimated_error_per_cell); KellyErrorEstimator::estimate(this->dof_handler, @@ -1816,13 +1811,6 @@ namespace ErrorIndicators {}, solution_view, error_view); -#else - KellyErrorEstimator::estimate(this->dof_handler, - *this->face_quadrature_collection, - {}, - eigenfunction_ptrs, - estimated_error_per_cell); -#endif for (auto &error_vec : errors) { diff --git a/MultipointFluxMixedFiniteElementMethods/CMakeLists.txt b/MultipointFluxMixedFiniteElementMethods/CMakeLists.txt index 2371e7f3..6ef403ac 100644 --- a/MultipointFluxMixedFiniteElementMethods/CMakeLists.txt +++ b/MultipointFluxMixedFiniteElementMethods/CMakeLists.txt @@ -24,7 +24,7 @@ SET(TARGET_SRC CMAKE_MINIMUM_REQUIRED(VERSION 3.13.4) -FIND_PACKAGE(deal.II 9.5.0 +FIND_PACKAGE(deal.II 9.6.0 HINTS ${deal.II_DIR} ${DEAL_II_DIR} ../ ../../ $ENV{DEAL_II_DIR} ) IF(NOT ${deal.II_FOUND}) diff --git a/NavierStokes_TRBDF2_DG/CMakeLists.txt b/NavierStokes_TRBDF2_DG/CMakeLists.txt index 50f256df..b575328e 100644 --- a/NavierStokes_TRBDF2_DG/CMakeLists.txt +++ b/NavierStokes_TRBDF2_DG/CMakeLists.txt @@ -23,7 +23,7 @@ SET(TARGET_SRC CMAKE_MINIMUM_REQUIRED(VERSION 3.13.4) -FIND_PACKAGE(deal.II 9.5.0 +FIND_PACKAGE(deal.II 9.6.0 HINTS ${deal.II_DIR} ${DEAL_II_DIR} ../ ../../ $ENV{DEAL_II_DIR} ) IF(NOT ${deal.II_FOUND}) diff --git a/Nonlinear_PoroViscoelasticity/CMakeLists.txt b/Nonlinear_PoroViscoelasticity/CMakeLists.txt index 84db5811..415df194 100644 --- a/Nonlinear_PoroViscoelasticity/CMakeLists.txt +++ b/Nonlinear_PoroViscoelasticity/CMakeLists.txt @@ -13,7 +13,7 @@ SET(TARGET_SRC #Search for required deal.II version CMAKE_MINIMUM_REQUIRED(VERSION 3.13.4) -FIND_PACKAGE(deal.II 9.5.0 +FIND_PACKAGE(deal.II 9.6.0 HINTS ${deal.II_DIR} ${DEAL_II_DIR} ../ ../../ $ENV{DEAL_II_DIR} ) IF(NOT ${deal.II_FOUND}) diff --git a/Nonlinear_PoroViscoelasticity/nonlinear-poro-viscoelasticity.cc b/Nonlinear_PoroViscoelasticity/nonlinear-poro-viscoelasticity.cc index e91026e4..7990b2bb 100644 --- a/Nonlinear_PoroViscoelasticity/nonlinear-poro-viscoelasticity.cc +++ b/Nonlinear_PoroViscoelasticity/nonlinear-poro-viscoelasticity.cc @@ -1970,11 +1970,7 @@ namespace NonLinearPoroViscoElasticity if (apply_dirichlet_bc) { constraints.clear(); -#if DEAL_II_VERSION_GTE(9, 6, 0) constraints.reinit(locally_owned_dofs, locally_relevant_dofs); -#else - constraints.reinit(locally_relevant_dofs); -#endif make_dirichlet_constraints(constraints); } else diff --git a/Phase_field_fracture_model_in_3D/CMakeLists.txt b/Phase_field_fracture_model_in_3D/CMakeLists.txt index c827be07..12ef8dd6 100644 --- a/Phase_field_fracture_model_in_3D/CMakeLists.txt +++ b/Phase_field_fracture_model_in_3D/CMakeLists.txt @@ -23,7 +23,7 @@ SET(TARGET_SRC CMAKE_MINIMUM_REQUIRED(VERSION 3.13.4) -FIND_PACKAGE(deal.II 9.5.0 +FIND_PACKAGE(deal.II 9.6.0 HINTS ${deal.II_DIR} ${DEAL_II_DIR} ../ ../../ $ENV{DEAL_II_DIR} ) IF(NOT ${deal.II_FOUND}) diff --git a/Quasi_static_Finite_strain_Compressible_Elasticity/CMakeLists.txt b/Quasi_static_Finite_strain_Compressible_Elasticity/CMakeLists.txt index c71c2a9e..17eab8c8 100644 --- a/Quasi_static_Finite_strain_Compressible_Elasticity/CMakeLists.txt +++ b/Quasi_static_Finite_strain_Compressible_Elasticity/CMakeLists.txt @@ -20,7 +20,7 @@ SET(CLEAN_UP_FILES CMAKE_MINIMUM_REQUIRED(VERSION 3.13.4) -FIND_PACKAGE(deal.II 9.5.0 +FIND_PACKAGE(deal.II 9.6.0 HINTS ${deal.II_DIR} ${DEAL_II_DIR} ../ ../../ $ENV{DEAL_II_DIR} ) IF(NOT ${deal.II_FOUND}) diff --git a/Quasi_static_Finite_strain_Quasi_incompressible_ViscoElasticity/CMakeLists.txt b/Quasi_static_Finite_strain_Quasi_incompressible_ViscoElasticity/CMakeLists.txt index 99c52572..f08d6840 100644 --- a/Quasi_static_Finite_strain_Quasi_incompressible_ViscoElasticity/CMakeLists.txt +++ b/Quasi_static_Finite_strain_Quasi_incompressible_ViscoElasticity/CMakeLists.txt @@ -19,7 +19,7 @@ SET(CLEAN_UP_FILES CMAKE_MINIMUM_REQUIRED(VERSION 3.13.4) -FIND_PACKAGE(deal.II 9.5.0 +FIND_PACKAGE(deal.II 9.6.0 HINTS ${deal.II_DIR} ${DEAL_II_DIR} ../ ../../ $ENV{DEAL_II_DIR} ) IF(NOT ${deal.II_FOUND}) diff --git a/Quasi_static_Finite_strain_Quasi_incompressible_ViscoElasticity/viscoelastic_strip_with_hole.cc b/Quasi_static_Finite_strain_Quasi_incompressible_ViscoElasticity/viscoelastic_strip_with_hole.cc index 07ab3fca..154ca9d5 100644 --- a/Quasi_static_Finite_strain_Quasi_incompressible_ViscoElasticity/viscoelastic_strip_with_hole.cc +++ b/Quasi_static_Finite_strain_Quasi_incompressible_ViscoElasticity/viscoelastic_strip_with_hole.cc @@ -1832,12 +1832,8 @@ namespace ViscoElasStripHole if (it_nr > 1) return; constraints.clear(); -#if DEAL_II_VERSION_GTE(9, 6, 0) constraints.reinit (locally_owned_dofs, locally_relevant_dofs); -#else - constraints.reinit (locally_relevant_dofs); -#endif const bool apply_dirichlet_bc = (it_nr == 0); const FEValuesExtractors::Scalar x_displacement(0); diff --git a/Swift-Hohenberg-Solver/CMakeLists.txt b/Swift-Hohenberg-Solver/CMakeLists.txt index 422ab2b2..df15d18c 100644 --- a/Swift-Hohenberg-Solver/CMakeLists.txt +++ b/Swift-Hohenberg-Solver/CMakeLists.txt @@ -23,7 +23,7 @@ SET(TARGET_SRC CMAKE_MINIMUM_REQUIRED(VERSION 3.13.4) -FIND_PACKAGE(deal.II 9.5.0 +FIND_PACKAGE(deal.II 9.6.0 HINTS ${deal.II_DIR} ${DEAL_II_DIR} ../ ../../ $ENV{DEAL_II_DIR} ) IF(NOT ${deal.II_FOUND}) diff --git a/TravelingWaves/CMakeLists.txt b/TravelingWaves/CMakeLists.txt index dfc346e5..92c832c7 100644 --- a/TravelingWaves/CMakeLists.txt +++ b/TravelingWaves/CMakeLists.txt @@ -11,7 +11,7 @@ SET(TARGET_SRC CMAKE_MINIMUM_REQUIRED(VERSION 3.13.4) -FIND_PACKAGE(deal.II 9.5.0 +FIND_PACKAGE(deal.II 9.6.0 HINTS ${deal.II_DIR} ${DEAL_II_DIR} ../ ../../ $ENV{DEAL_II_DIR} ) IF(NOT ${deal.II_FOUND}) diff --git a/advection_reaction_estimator/CMakeLists.txt b/advection_reaction_estimator/CMakeLists.txt index 87b01806..e0d36a13 100644 --- a/advection_reaction_estimator/CMakeLists.txt +++ b/advection_reaction_estimator/CMakeLists.txt @@ -12,7 +12,7 @@ PROJECT(${TARGET} CXX) CMAKE_MINIMUM_REQUIRED(VERSION 3.13.4) -FIND_PACKAGE(deal.II 9.5.0 +FIND_PACKAGE(deal.II 9.6.0 HINTS ${deal.II_DIR} ${DEAL_II_DIR} ../ ../../ $ENV{DEAL_II_DIR} ) IF(NOT ${deal.II_FOUND}) diff --git a/cdr/CMakeLists.txt b/cdr/CMakeLists.txt index 843b4ccc..1caf299b 100644 --- a/cdr/CMakeLists.txt +++ b/cdr/CMakeLists.txt @@ -1,6 +1,6 @@ CMAKE_MINIMUM_REQUIRED(VERSION 3.13.4) -FIND_PACKAGE(deal.II 9.5.0 +FIND_PACKAGE(deal.II 9.6.0 HINTS ${deal.II_DIR} ${DEAL_II_DIR} ../ ../../ $ENV{DEAL_II_DIR}) IF(NOT ${deal.II_FOUND}) diff --git a/coupled_laplace_problem/CMakeLists.txt b/coupled_laplace_problem/CMakeLists.txt index 99883faa..3ae1cbbc 100644 --- a/coupled_laplace_problem/CMakeLists.txt +++ b/coupled_laplace_problem/CMakeLists.txt @@ -23,7 +23,7 @@ SET(TARGET_SRC CMAKE_MINIMUM_REQUIRED(VERSION 3.13.4) -FIND_PACKAGE(deal.II 9.5.0 +FIND_PACKAGE(deal.II 9.6.0 HINTS ${deal.II_DIR} ${DEAL_II_DIR} ../ ../../ $ENV{DEAL_II_DIR} ) IF(NOT ${deal.II_FOUND}) diff --git a/goal_oriented_elastoplasticity/CMakeLists.txt b/goal_oriented_elastoplasticity/CMakeLists.txt index aead4549..542d272e 100644 --- a/goal_oriented_elastoplasticity/CMakeLists.txt +++ b/goal_oriented_elastoplasticity/CMakeLists.txt @@ -18,7 +18,7 @@ SET(CLEAN_UP_FILES *.vtu *.pvtu *.visit) CMAKE_MINIMUM_REQUIRED(VERSION 3.13.4) -FIND_PACKAGE(deal.II 9.5.0 +FIND_PACKAGE(deal.II 9.6.0 HINTS ${deal.II_DIR} ${DEAL_II_DIR} ../ ../../ $ENV{DEAL_II_DIR} ) IF(NOT ${deal.II_FOUND}) diff --git a/information_based_mesh_refinement/CMakeLists.txt b/information_based_mesh_refinement/CMakeLists.txt index 951014e6..c8028307 100644 --- a/information_based_mesh_refinement/CMakeLists.txt +++ b/information_based_mesh_refinement/CMakeLists.txt @@ -23,7 +23,7 @@ SET(TARGET_SRC CMAKE_MINIMUM_REQUIRED(VERSION 3.13.4) -FIND_PACKAGE(deal.II 9.5.0 +FIND_PACKAGE(deal.II 9.6.0 HINTS ${deal.II_DIR} ${DEAL_II_DIR} ../ ../../ $ENV{DEAL_II_DIR} ) IF(NOT ${deal.II_FOUND}) diff --git a/nonlinear-heat_transfer_with_AD_NOX/CMakeLists.txt b/nonlinear-heat_transfer_with_AD_NOX/CMakeLists.txt index dc5825d3..3d9af0c2 100644 --- a/nonlinear-heat_transfer_with_AD_NOX/CMakeLists.txt +++ b/nonlinear-heat_transfer_with_AD_NOX/CMakeLists.txt @@ -1,6 +1,6 @@ CMAKE_MINIMUM_REQUIRED(VERSION 3.13.4) set(CMAKE_CXX_STANDARD_REQUIRED True) -FIND_PACKAGE(deal.II 9.5.0 QUIET +FIND_PACKAGE(deal.II 9.6.0 QUIET HINTS ${deal.II_DIR} ${DEAL_II_DIR} ../ ../../ $ENV{DEAL_II_DIR} ) IF(NOT ${deal.II_FOUND}) diff --git a/parallel_in_time/CMakeLists.txt b/parallel_in_time/CMakeLists.txt index adb33969..0e80ee94 100644 --- a/parallel_in_time/CMakeLists.txt +++ b/parallel_in_time/CMakeLists.txt @@ -5,7 +5,7 @@ PROJECT("parallel_in_time") # # setup deal.II # -FIND_PACKAGE(deal.II 9.5.0 +FIND_PACKAGE(deal.II 9.6.0 HINTS ${deal.II_DIR} ${DEAL_II_DIR} ../ ../../ $ENV{DEAL_II_DIR} ) IF(NOT ${deal.II_FOUND}) diff --git a/time_dependent_navier_stokes/CMakeLists.txt b/time_dependent_navier_stokes/CMakeLists.txt index 820a1cba..fbf6d20b 100644 --- a/time_dependent_navier_stokes/CMakeLists.txt +++ b/time_dependent_navier_stokes/CMakeLists.txt @@ -23,7 +23,7 @@ SET(TARGET_SRC CMAKE_MINIMUM_REQUIRED(VERSION 3.13.4) -FIND_PACKAGE(deal.II 9.5.0 +FIND_PACKAGE(deal.II 9.6.0 HINTS ${deal.II_DIR} ${DEAL_II_DIR} ../ ../../ $ENV{DEAL_II_DIR} ) IF(NOT ${deal.II_FOUND}) diff --git a/two_phase_flow/CMakeLists.txt b/two_phase_flow/CMakeLists.txt index 822f7c1e..278444d3 100644 --- a/two_phase_flow/CMakeLists.txt +++ b/two_phase_flow/CMakeLists.txt @@ -28,7 +28,7 @@ SET(TARGET_SRC CMAKE_MINIMUM_REQUIRED(VERSION 3.13.4) -FIND_PACKAGE(deal.II 9.5.0 +FIND_PACKAGE(deal.II 9.6.0 HINTS ${deal.II_DIR} ${DEAL_II_DIR} ../ ../../ $ENV{DEAL_II_DIR} ) IF(NOT ${deal.II_FOUND}) diff --git a/two_phase_flow/LevelSetSolver.cc b/two_phase_flow/LevelSetSolver.cc index 28527278..c180e907 100644 --- a/two_phase_flow/LevelSetSolver.cc +++ b/two_phase_flow/LevelSetSolver.cc @@ -444,11 +444,7 @@ void LevelSetSolver::setup() // INIT CONSTRAINTS // ////////////////////// constraints.clear (); -#if DEAL_II_VERSION_GTE(9, 6, 0) constraints.reinit (locally_owned_dofs_LS, locally_relevant_dofs_LS); -#else - constraints.reinit (locally_relevant_dofs_LS); -#endif DoFTools::make_hanging_node_constraints (dof_handler_LS, constraints); constraints.close (); ///////////////////////// diff --git a/two_phase_flow/MultiPhase.cc b/two_phase_flow/MultiPhase.cc index 9cdb95fd..452b27c1 100644 --- a/two_phase_flow/MultiPhase.cc +++ b/two_phase_flow/MultiPhase.cc @@ -266,11 +266,7 @@ template void MultiPhase::init_constraints() { constraints.clear (); -#if DEAL_II_VERSION_GTE(9, 6, 0) constraints.reinit (locally_owned_dofs_LS, locally_relevant_dofs_LS); -#else - constraints.reinit (locally_relevant_dofs_LS); -#endif DoFTools::make_hanging_node_constraints (dof_handler_LS, constraints); constraints.close (); } diff --git a/two_phase_flow/NavierStokesSolver.cc b/two_phase_flow/NavierStokesSolver.cc index f5387d5f..88ea5e72 100644 --- a/two_phase_flow/NavierStokesSolver.cc +++ b/two_phase_flow/NavierStokesSolver.cc @@ -607,20 +607,12 @@ void NavierStokesSolver::init_constraints() { //grl constraints constraints.clear(); -#if DEAL_II_VERSION_GTE(9, 6, 0) constraints.reinit(locally_owned_dofs_U, locally_relevant_dofs_U); -#else - constraints.reinit(locally_relevant_dofs_U); -#endif DoFTools::make_hanging_node_constraints(dof_handler_U,constraints); constraints.close(); //constraints for dpsi constraints_psi.clear(); -#if DEAL_II_VERSION_GTE(9, 6, 0) constraints_psi.reinit(locally_owned_dofs_P, locally_relevant_dofs_P); -#else - constraints_psi.reinit(locally_relevant_dofs_P); -#endif DoFTools::make_hanging_node_constraints(dof_handler_P,constraints_psi); //if (constraints_psi.can_store_line(0)) //constraints_psi.add_line(0); //constraint u0 = 0 diff --git a/two_phase_flow/TestLevelSet.cc b/two_phase_flow/TestLevelSet.cc index 6c6ee0e8..77959890 100644 --- a/two_phase_flow/TestLevelSet.cc +++ b/two_phase_flow/TestLevelSet.cc @@ -394,19 +394,11 @@ template void TestLevelSet::init_constraints() { constraints.clear (); -#if DEAL_II_VERSION_GTE(9, 6, 0) constraints.reinit (locally_owned_dofs_LS, locally_relevant_dofs_LS); -#else - constraints.reinit (locally_relevant_dofs_LS); -#endif DoFTools::make_hanging_node_constraints (dof_handler_LS, constraints); constraints.close (); constraints_disp_field.clear (); -#if DEAL_II_VERSION_GTE(9, 6, 0) constraints_disp_field.reinit (locally_owned_dofs_LS, locally_relevant_dofs_LS); -#else - constraints_disp_field.reinit (locally_relevant_dofs_LS); -#endif DoFTools::make_hanging_node_constraints (dof_handler_LS, constraints_disp_field); constraints_disp_field.close (); } diff --git a/two_phase_flow/TestNavierStokes.cc b/two_phase_flow/TestNavierStokes.cc index 35d94fb8..49df1eae 100644 --- a/two_phase_flow/TestNavierStokes.cc +++ b/two_phase_flow/TestNavierStokes.cc @@ -262,11 +262,7 @@ template void TestNavierStokes::init_constraints() { constraints.clear (); -#if DEAL_II_VERSION_GTE(9, 6, 0) constraints.reinit (locally_owned_dofs_LS, locally_relevant_dofs_LS); -#else - constraints.reinit (locally_relevant_dofs_LS); -#endif DoFTools::make_hanging_node_constraints (dof_handler_LS, constraints); constraints.close (); }