Skip to content
Merged
Show file tree
Hide file tree
Changes from all commits
Commits
File filter

Filter by extension

Filter by extension


Conversations
Failed to load comments.
Loading
Jump to
Jump to file
Failed to load files.
Loading
Diff view
Diff view
2 changes: 1 addition & 1 deletion .github/workflows/linux.yml
Original file line number Diff line number Diff line change
Expand Up @@ -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"
Expand Down
2 changes: 1 addition & 1 deletion CeresFE/CMakeLists.txt
Original file line number Diff line number Diff line change
Expand Up @@ -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}
)

Expand Down
2 changes: 1 addition & 1 deletion Crystal_Growth_Phase_Field_Model/CMakeLists.txt
Original file line number Diff line number Diff line change
Expand Up @@ -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})
Expand Down
2 changes: 1 addition & 1 deletion Distributed_LDG_Method/CMakeLists.txt
Original file line number Diff line number Diff line change
Expand Up @@ -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})
Expand Down
2 changes: 1 addition & 1 deletion Distributed_Moving_Laser_Heating/CMakeLists.txt
Original file line number Diff line number Diff line change
Expand Up @@ -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})
Expand Down
2 changes: 1 addition & 1 deletion ElastoplasticTorsion/CMakeLists.txt
Original file line number Diff line number Diff line change
Expand Up @@ -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})
Expand Down
2 changes: 1 addition & 1 deletion Heat_Eqn_Parallel/CMakeLists.txt
Original file line number Diff line number Diff line change
Expand Up @@ -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})
Expand Down
2 changes: 1 addition & 1 deletion Linear_Elastic_Active_Skeletal_Muscle_Model/CMakeLists.txt
Original file line number Diff line number Diff line change
Expand Up @@ -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})
Expand Down
2 changes: 1 addition & 1 deletion MCMC-Laplace/CMakeLists.txt
Original file line number Diff line number Diff line change
Expand Up @@ -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}
)

Expand Down
2 changes: 1 addition & 1 deletion Maxwell-Eigenvalue-hp-Refinement/CMakeLists.txt
Original file line number Diff line number Diff line change
Expand Up @@ -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})
Expand Down
16 changes: 2 additions & 14 deletions Maxwell-Eigenvalue-hp-Refinement/maxwell-hp.cc
Original file line number Diff line number Diff line change
Expand Up @@ -1673,12 +1673,8 @@ namespace ErrorIndicators
void
prune_eigenpairs(const double &TOL);

#if DEAL_II_VERSION_GTE(9, 6, 0)
std::vector<const ReadVector<PetscScalar> *> eigenfunction_ptrs;
#else
std::vector<const PETScWrappers::MPI::Vector *> eigenfunction_ptrs;
#endif
std::vector<const double *> eigenvalue_ptrs;
std::vector<const ReadVector<PetscScalar> *> eigenfunction_ptrs;
std::vector<const double *> eigenvalue_ptrs;

std::vector<std::shared_ptr<Vector<float>>> errors;
};
Expand Down Expand Up @@ -1808,21 +1804,13 @@ 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<dim>::estimate(this->dof_handler,
*this->face_quadrature_collection,
{},
solution_view,
error_view);
#else
KellyErrorEstimator<dim>::estimate(this->dof_handler,
*this->face_quadrature_collection,
{},
eigenfunction_ptrs,
estimated_error_per_cell);
#endif

for (auto &error_vec : errors)
{
Expand Down
2 changes: 1 addition & 1 deletion MultipointFluxMixedFiniteElementMethods/CMakeLists.txt
Original file line number Diff line number Diff line change
Expand Up @@ -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})
Expand Down
2 changes: 1 addition & 1 deletion NavierStokes_TRBDF2_DG/CMakeLists.txt
Original file line number Diff line number Diff line change
Expand Up @@ -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})
Expand Down
2 changes: 1 addition & 1 deletion Nonlinear_PoroViscoelasticity/CMakeLists.txt
Original file line number Diff line number Diff line change
Expand Up @@ -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})
Expand Down
Original file line number Diff line number Diff line change
Expand Up @@ -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
Expand Down
2 changes: 1 addition & 1 deletion Phase_field_fracture_model_in_3D/CMakeLists.txt
Original file line number Diff line number Diff line change
Expand Up @@ -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})
Expand Down
Original file line number Diff line number Diff line change
Expand Up @@ -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})
Expand Down
Original file line number Diff line number Diff line change
Expand Up @@ -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})
Expand Down
Original file line number Diff line number Diff line change
Expand Up @@ -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);
Expand Down
2 changes: 1 addition & 1 deletion Swift-Hohenberg-Solver/CMakeLists.txt
Original file line number Diff line number Diff line change
Expand Up @@ -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})
Expand Down
2 changes: 1 addition & 1 deletion TravelingWaves/CMakeLists.txt
Original file line number Diff line number Diff line change
Expand Up @@ -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})
Expand Down
2 changes: 1 addition & 1 deletion advection_reaction_estimator/CMakeLists.txt
Original file line number Diff line number Diff line change
Expand Up @@ -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})
Expand Down
2 changes: 1 addition & 1 deletion cdr/CMakeLists.txt
Original file line number Diff line number Diff line change
@@ -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})
Expand Down
2 changes: 1 addition & 1 deletion coupled_laplace_problem/CMakeLists.txt
Original file line number Diff line number Diff line change
Expand Up @@ -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})
Expand Down
2 changes: 1 addition & 1 deletion goal_oriented_elastoplasticity/CMakeLists.txt
Original file line number Diff line number Diff line change
Expand Up @@ -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})
Expand Down
2 changes: 1 addition & 1 deletion information_based_mesh_refinement/CMakeLists.txt
Original file line number Diff line number Diff line change
Expand Up @@ -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})
Expand Down
2 changes: 1 addition & 1 deletion nonlinear-heat_transfer_with_AD_NOX/CMakeLists.txt
Original file line number Diff line number Diff line change
@@ -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})
Expand Down
2 changes: 1 addition & 1 deletion parallel_in_time/CMakeLists.txt
Original file line number Diff line number Diff line change
Expand Up @@ -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})
Expand Down
2 changes: 1 addition & 1 deletion time_dependent_navier_stokes/CMakeLists.txt
Original file line number Diff line number Diff line change
Expand Up @@ -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})
Expand Down
2 changes: 1 addition & 1 deletion two_phase_flow/CMakeLists.txt
Original file line number Diff line number Diff line change
Expand Up @@ -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})
Expand Down
4 changes: 0 additions & 4 deletions two_phase_flow/LevelSetSolver.cc
Original file line number Diff line number Diff line change
Expand Up @@ -444,11 +444,7 @@ void LevelSetSolver<dim>::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 ();
/////////////////////////
Expand Down
4 changes: 0 additions & 4 deletions two_phase_flow/MultiPhase.cc
Original file line number Diff line number Diff line change
Expand Up @@ -266,11 +266,7 @@ template <int dim>
void MultiPhase<dim>::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 ();
}
Expand Down
8 changes: 0 additions & 8 deletions two_phase_flow/NavierStokesSolver.cc
Original file line number Diff line number Diff line change
Expand Up @@ -607,20 +607,12 @@ void NavierStokesSolver<dim>::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
Expand Down
8 changes: 0 additions & 8 deletions two_phase_flow/TestLevelSet.cc
Original file line number Diff line number Diff line change
Expand Up @@ -394,19 +394,11 @@ template <int dim>
void TestLevelSet<dim>::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 ();
}
Expand Down
4 changes: 0 additions & 4 deletions two_phase_flow/TestNavierStokes.cc
Original file line number Diff line number Diff line change
Expand Up @@ -262,11 +262,7 @@ template <int dim>
void TestNavierStokes<dim>::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 ();
}
Expand Down