Closed bangerth closed 1 year ago
Here is the rest:
/home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:1447:23: warning: ‘void dealii::FEEvaluation<dim, fe_degree, n_q_points_1d, n_components_, Number, VectorizedArrayType>::evaluate(bool, bool, bool) [with int dim = 2; int fe_degree = 2; int n_q_points_1d = 3; int n_components_ = 2; Number = double; VectorizedArrayType = dealii::VectorizedArray<double, 2>]’ is deprecated [-Wdeprecated-declarations]
1447 | phi.evaluate(true, true);
| ~~~~~~~~~~~~^~~~~~~~~~~~
In file included from /raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/operators.h:30,
from /home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:47:
/raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/fe_evaluation.h:7746:1: note: declared here
7746 | FEEvaluation<dim,
| ^~~~~~~~~~~~~~~~~
7747 | fe_degree,
| ~~~~~~~~~~
7748 | n_q_points_1d,
| ~~~~~~~~~~~~~~
7749 | n_components_,
| ~~~~~~~~~~~~~~
7750 | Number,
| ~~~~~~~
7751 | VectorizedArrayType>::evaluate(const bool evaluate_values,
| ~~~~~~~~~~~~~~~~~~~~
/home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:1459:24: warning: ‘void dealii::FEEvaluation<dim, fe_degree, n_q_points_1d, n_components_, Number, VectorizedArrayType>::integrate(bool, bool) [with int dim = 2; int fe_degree = 2; int n_q_points_1d = 3; int n_components_ = 2; Number = double; VectorizedArrayType = dealii::VectorizedArray<double, 2>]’ is deprecated [-Wdeprecated-declarations]
1459 | phi.integrate(true, true);
| ~~~~~~~~~~~~~^~~~~~~~~~~~
In file included from /raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/operators.h:30,
from /home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:47:
/raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/fe_evaluation.h:8016:1: note: declared here
8016 | FEEvaluation<dim,
| ^~~~~~~~~~~~~~~~~
8017 | fe_degree,
| ~~~~~~~~~~
8018 | n_q_points_1d,
| ~~~~~~~~~~~~~~
8019 | n_components_,
| ~~~~~~~~~~~~~~
8020 | Number,
| ~~~~~~~
8021 | VectorizedArrayType>::integrate(const bool integrate_values,
| ~~~~~~~~~~~~~~~~~~~~
/home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:1479:37: warning: ‘void dealii::FEEvaluation<dim, fe_degree, n_q_points_1d, n_components_, Number, VectorizedArrayType>::gather_evaluate(const VectorType&, bool, bool, bool) [with VectorType = dealii::LinearAlgebra::distributed::Vector<double>; int dim = 2; int fe_degree = 2; int n_q_points_1d = 3; int n_components_ = 2; Number = double; VectorizedArrayType = dealii::VectorizedArray<double, 2>]’ is deprecated [-Wdeprecated-declarations]
1479 | phi_int_extr.gather_evaluate(u_extr, true, false);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~
In file included from /raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/operators.h:30,
from /home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:47:
/raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/fe_evaluation.h:7883:1: note: declared here
7883 | FEEvaluation<
| ^~~~~~~~~~~~~
7884 | dim,
| ~~~~
7885 | fe_degree,
| ~~~~~~~~~~
7886 | n_q_points_1d,
| ~~~~~~~~~~~~~~
7887 | n_components_,
| ~~~~~~~~~~~~~~
7888 | Number,
| ~~~~~~~
7889 | VectorizedArrayType>::gather_evaluate(const VectorType &input_vector,
| ~~~~~~~~~~~~~~~~~~~~
/home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:1487:23: warning: ‘void dealii::FEEvaluation<dim, fe_degree, n_q_points_1d, n_components_, Number, VectorizedArrayType>::evaluate(bool, bool, bool) [with int dim = 2; int fe_degree = 2; int n_q_points_1d = 3; int n_components_ = 2; Number = double; VectorizedArrayType = dealii::VectorizedArray<double, 2>]’ is deprecated [-Wdeprecated-declarations]
1487 | phi.evaluate(true, true);
| ~~~~~~~~~~~~^~~~~~~~~~~~
In file included from /raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/operators.h:30,
from /home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:47:
/raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/fe_evaluation.h:7746:1: note: declared here
7746 | FEEvaluation<dim,
| ^~~~~~~~~~~~~~~~~
7747 | fe_degree,
| ~~~~~~~~~~
7748 | n_q_points_1d,
| ~~~~~~~~~~~~~~
7749 | n_components_,
| ~~~~~~~~~~~~~~
7750 | Number,
| ~~~~~~~
7751 | VectorizedArrayType>::evaluate(const bool evaluate_values,
| ~~~~~~~~~~~~~~~~~~~~
/home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:1499:24: warning: ‘void dealii::FEEvaluation<dim, fe_degree, n_q_points_1d, n_components_, Number, VectorizedArrayType>::integrate(bool, bool) [with int dim = 2; int fe_degree = 2; int n_q_points_1d = 3; int n_components_ = 2; Number = double; VectorizedArrayType = dealii::VectorizedArray<double, 2>]’ is deprecated [-Wdeprecated-declarations]
1499 | phi.integrate(true, true);
| ~~~~~~~~~~~~~^~~~~~~~~~~~
In file included from /raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/operators.h:30,
from /home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:47:
/raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/fe_evaluation.h:8016:1: note: declared here
8016 | FEEvaluation<dim,
| ^~~~~~~~~~~~~~~~~
8017 | fe_degree,
| ~~~~~~~~~~
8018 | n_q_points_1d,
| ~~~~~~~~~~~~~~
8019 | n_components_,
| ~~~~~~~~~~~~~~
8020 | Number,
| ~~~~~~~
8021 | VectorizedArrayType>::integrate(const bool integrate_values,
| ~~~~~~~~~~~~~~~~~~~~
/home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc: In instantiation of ‘void NS_TRBDF2::NavierStokesProjectionOperator<dim, fe_degree_p, fe_degree_v, n_q_points_1d_p, n_q_points_1d_v, Vec>::assemble_diagonal_face_term_velocity(const dealii::MatrixFree<dim, typename Vec::value_type>&, Vec&, const unsigned int&, const std::pair<unsigned int, unsigned int>&) const [with int dim = 2; int fe_degree_p = 1; int fe_degree_v = 2; int n_q_points_1d_p = 2; int n_q_points_1d_v = 3; Vec = dealii::LinearAlgebra::distributed::Vector<double>; typename Vec::value_type = double]’:
/home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:2022:17: required from ‘NS_TRBDF2::NavierStokesProjectionOperator<2, 1, 2, 2, 3, dealii::LinearAlgebra::distributed::Vector<double> >::compute_diagonal()::<lambda(const auto:88&, auto:89&, const auto:90&, const auto:91&)> [with auto:88 = dealii::MatrixFree<2, double, dealii::VectorizedArray<double, 2> >; auto:89 = dealii::LinearAlgebra::distributed::Vector<double>; auto:90 = unsigned int; auto:91 = std::pair<unsigned int, unsigned int>]’
/scratch/local/gcc-11.2.0/include/c++/11.2.0/type_traits:2466:26: required by substitution of ‘template<class _Fn, class ... _Args> static std::__result_of_success<decltype (declval<_Fn>()((declval<_Args>)()...)), std::__invoke_other> std::__result_of_other_impl::_S_test(int) [with _Fn = NS_TRBDF2::NavierStokesProjectionOperator<2, 1, 2, 2, 3, dealii::LinearAlgebra::distributed::Vector<double> >::compute_diagonal()::<lambda(const auto:88&, auto:89&, const auto:90&, const auto:91&)>&; _Args = {const dealii::MatrixFree<2, double, dealii::VectorizedArray<double, 2> >&, dealii::LinearAlgebra::distributed::Vector<double, dealii::MemorySpace::Host>&, const unsigned int&, const std::pair<unsigned int, unsigned int>&}]’
/scratch/local/gcc-11.2.0/include/c++/11.2.0/type_traits:2477:55: required from ‘struct std::__result_of_impl<false, false, NS_TRBDF2::NavierStokesProjectionOperator<2, 1, 2, 2, 3, dealii::LinearAlgebra::distributed::Vector<double> >::compute_diagonal()::<lambda(const auto:88&, auto:89&, const auto:90&, const auto:91&)>&, const dealii::MatrixFree<2, double, dealii::VectorizedArray<double, 2> >&, dealii::LinearAlgebra::distributed::Vector<double, dealii::MemorySpace::Host>&, const unsigned int&, const std::pair<unsigned int, unsigned int>&>’
/scratch/local/gcc-11.2.0/include/c++/11.2.0/bits/std_function.h:334:9: recursively required by substitution of ‘template<class _Result, class _Ret> struct std::__is_invocable_impl<_Result, _Ret, true, std::__void_t<typename _CTp::type> > [with _Result = std::__invoke_result<NS_TRBDF2::NavierStokesProjectionOperator<2, 1, 2, 2, 3, dealii::LinearAlgebra::distributed::Vector<double> >::compute_diagonal()::<lambda(const auto:88&, auto:89&, const auto:90&, const auto:91&)>&, const dealii::MatrixFree<2, double, dealii::VectorizedArray<double, 2> >&, dealii::LinearAlgebra::distributed::Vector<double, dealii::MemorySpace::Host>&, const unsigned int&, const std::pair<unsigned int, unsigned int>&>; _Ret = void]’
/scratch/local/gcc-11.2.0/include/c++/11.2.0/bits/std_function.h:334:9: required from ‘struct std::function<void(const dealii::MatrixFree<2, double, dealii::VectorizedArray<double, 2> >&, dealii::LinearAlgebra::distributed::Vector<double>&, const unsigned int&, const std::pair<unsigned int, unsigned int>&)>::_Callable<NS_TRBDF2::NavierStokesProjectionOperator<2, 1, 2, 2, 3, dealii::LinearAlgebra::distributed::Vector<double> >::compute_diagonal()::<lambda(const auto:88&, auto:89&, const auto:90&, const auto:91&)>, std::__invoke_result<NS_TRBDF2::NavierStokesProjectionOperator<2, 1, 2, 2, 3, dealii::LinearAlgebra::distributed::Vector<double> >::compute_diagonal()::<lambda(const auto:88&, auto:89&, const auto:90&, const auto:91&)>&, const dealii::MatrixFree<2, double, dealii::VectorizedArray<double, 2> >&, dealii::LinearAlgebra::distributed::Vector<double, dealii::MemorySpace::Host>&, const unsigned int&, const std::pair<unsigned int, unsigned int>&> >’
/scratch/local/gcc-11.2.0/include/c++/11.2.0/bits/std_function.h:344:8: required by substitution of ‘template<class _Res, class ... _ArgTypes> template<class _Cond, class _Tp> using _Requires = typename std::enable_if<_Cond::value, _Tp>::type [with _Cond = std::function<void(const dealii::MatrixFree<2, double, dealii::VectorizedArray<double, 2> >&, dealii::LinearAlgebra::distributed::Vector<double>&, const unsigned int&, const std::pair<unsigned int, unsigned int>&)>::_Callable<NS_TRBDF2::NavierStokesProjectionOperator<2, 1, 2, 2, 3, dealii::LinearAlgebra::distributed::Vector<double> >::compute_diagonal()::<lambda(const auto:88&, auto:89&, const auto:90&, const auto:91&)>, std::__invoke_result<NS_TRBDF2::NavierStokesProjectionOperator<2, 1, 2, 2, 3, dealii::LinearAlgebra::distributed::Vector<double> >::compute_diagonal()::<lambda(const auto:88&, auto:89&, const auto:90&, const auto:91&)>&, const dealii::MatrixFree<2, double, dealii::VectorizedArray<double, 2> >&, dealii::LinearAlgebra::distributed::Vector<double, dealii::MemorySpace::Host>&, const unsigned int&, const std::pair<unsigned int, unsigned int>&> >; _Tp = void; _Res = void; _ArgTypes = {const dealii::MatrixFree<2, double, dealii::VectorizedArray<double, 2> >&, dealii::LinearAlgebra::distributed::Vector<double, dealii::MemorySpace::Host>&, const unsigned int&, const std::pair<unsigned int, unsigned int>&}]’
/scratch/local/gcc-11.2.0/include/c++/11.2.0/bits/std_function.h:413:9: required by substitution of ‘template<class _Functor, class, class> std::function<void(const dealii::MatrixFree<2, double, dealii::VectorizedArray<double, 2> >&, dealii::LinearAlgebra::distributed::Vector<double>&, const unsigned int&, const std::pair<unsigned int, unsigned int>&)>::function(_Functor) [with _Functor = NS_TRBDF2::NavierStokesProjectionOperator<2, 1, 2, 2, 3, dealii::LinearAlgebra::distributed::Vector<double> >::compute_diagonal()::<lambda(const auto:88&, auto:89&, const auto:90&, const auto:91&)>; <template-parameter-1-2> = void; <template-parameter-1-3> = void]’
/home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:2016:7: required from ‘void NS_TRBDF2::NavierStokesProjectionOperator<dim, fe_degree_p, fe_degree_v, n_q_points_1d_p, n_q_points_1d_v, Vec>::compute_diagonal() [with int dim = 2; int fe_degree_p = 1; int fe_degree_v = 2; int n_q_points_1d_p = 2; int n_q_points_1d_v = 3; Vec = dealii::LinearAlgebra::distributed::Vector<double>]’
/home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:2450:42: required from ‘void NS_TRBDF2::NavierStokesProjection<dim>::diffusion_step() [with int dim = 2]’
/home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:2940:7: required from ‘void NS_TRBDF2::NavierStokesProjection<dim>::run(bool, unsigned int) [with int dim = 2]’
/home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:3035:13: required from here
/home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:1537:39: warning: ‘void dealii::FEFaceEvaluation<dim, fe_degree, n_q_points_1d, n_components_, Number, VectorizedArrayType>::gather_evaluate(const VectorType&, bool, bool) [with VectorType = dealii::LinearAlgebra::distributed::Vector<double>; int dim = 2; int fe_degree = 2; int n_q_points_1d = 3; int n_components_ = 2; Number = double; VectorizedArrayType = dealii::VectorizedArray<double, 2>]’ is deprecated [-Wdeprecated-declarations]
1537 | phi_old_extr_p.gather_evaluate(u_extr, true, false);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~
In file included from /raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/operators.h:30,
from /home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:47:
/raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/fe_evaluation.h:8880:1: note: declared here
8880 | FEFaceEvaluation<
| ^~~~~~~~~~~~~~~~~
8881 | dim,
| ~~~~
8882 | fe_degree,
| ~~~~~~~~~~
8883 | n_q_points_1d,
| ~~~~~~~~~~~~~~
8884 | n_components_,
| ~~~~~~~~~~~~~~
8885 | Number,
| ~~~~~~~
8886 | VectorizedArrayType>::gather_evaluate(const VectorType &input_vector,
| ~~~~~~~~~~~~~~~~~~~~
/home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:1539:39: warning: ‘void dealii::FEFaceEvaluation<dim, fe_degree, n_q_points_1d, n_components_, Number, VectorizedArrayType>::gather_evaluate(const VectorType&, bool, bool) [with VectorType = dealii::LinearAlgebra::distributed::Vector<double>; int dim = 2; int fe_degree = 2; int n_q_points_1d = 3; int n_components_ = 2; Number = double; VectorizedArrayType = dealii::VectorizedArray<double, 2>]’ is deprecated [-Wdeprecated-declarations]
1539 | phi_old_extr_m.gather_evaluate(u_extr, true, false);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~
In file included from /raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/operators.h:30,
from /home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:47:
/raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/fe_evaluation.h:8880:1: note: declared here
8880 | FEFaceEvaluation<
| ^~~~~~~~~~~~~~~~~
8881 | dim,
| ~~~~
8882 | fe_degree,
| ~~~~~~~~~~
8883 | n_q_points_1d,
| ~~~~~~~~~~~~~~
8884 | n_components_,
| ~~~~~~~~~~~~~~
8885 | Number,
| ~~~~~~~
8886 | VectorizedArrayType>::gather_evaluate(const VectorType &input_vector,
| ~~~~~~~~~~~~~~~~~~~~
/home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:1553:25: warning: ‘void dealii::FEFaceEvaluation<dim, fe_degree, n_q_points_1d, n_components_, Number, VectorizedArrayType>::evaluate(bool, bool) [with int dim = 2; int fe_degree = 2; int n_q_points_1d = 3; int n_components_ = 2; Number = double; VectorizedArrayType = dealii::VectorizedArray<double, 2>]’ is deprecated [-Wdeprecated-declarations]
1553 | phi_p.evaluate(true, true);
| ~~~~~~~~~~~~~~^~~~~~~~~~~~
In file included from /raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/operators.h:30,
from /home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:47:
/raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/fe_evaluation.h:8599:1: note: declared here
8599 | FEFaceEvaluation<dim,
| ^~~~~~~~~~~~~~~~~~~~~
8600 | fe_degree,
| ~~~~~~~~~~
8601 | n_q_points_1d,
| ~~~~~~~~~~~~~~
8602 | n_components,
| ~~~~~~~~~~~~~
8603 | Number,
| ~~~~~~~
8604 | VectorizedArrayType>::evaluate(const bool evaluate_values,
| ~~~~~~~~~~~~~~~~~~~~
/home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:1555:25: warning: ‘void dealii::FEFaceEvaluation<dim, fe_degree, n_q_points_1d, n_components_, Number, VectorizedArrayType>::evaluate(bool, bool) [with int dim = 2; int fe_degree = 2; int n_q_points_1d = 3; int n_components_ = 2; Number = double; VectorizedArrayType = dealii::VectorizedArray<double, 2>]’ is deprecated [-Wdeprecated-declarations]
1555 | phi_m.evaluate(true, true);
| ~~~~~~~~~~~~~~^~~~~~~~~~~~
In file included from /raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/operators.h:30,
from /home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:47:
/raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/fe_evaluation.h:8599:1: note: declared here
8599 | FEFaceEvaluation<dim,
| ^~~~~~~~~~~~~~~~~~~~~
8600 | fe_degree,
| ~~~~~~~~~~
8601 | n_q_points_1d,
| ~~~~~~~~~~~~~~
8602 | n_components,
| ~~~~~~~~~~~~~
8603 | Number,
| ~~~~~~~
8604 | VectorizedArrayType>::evaluate(const bool evaluate_values,
| ~~~~~~~~~~~~~~~~~~~~
/home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:1574:26: warning: ‘void dealii::FEFaceEvaluation<dim, fe_degree, n_q_points_1d, n_components_, Number, VectorizedArrayType>::integrate(bool, bool) [with int dim = 2; int fe_degree = 2; int n_q_points_1d = 3; int n_components_ = 2; Number = double; VectorizedArrayType = dealii::VectorizedArray<double, 2>]’ is deprecated [-Wdeprecated-declarations]
1574 | phi_p.integrate(true, true);
| ~~~~~~~~~~~~~~~^~~~~~~~~~~~
In file included from /raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/operators.h:30,
from /home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:47:
/raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/fe_evaluation.h:8755:1: note: declared here
8755 | FEFaceEvaluation<dim,
| ^~~~~~~~~~~~~~~~~~~~~
8756 | fe_degree,
| ~~~~~~~~~~
8757 | n_q_points_1d,
| ~~~~~~~~~~~~~~
8758 | n_components,
| ~~~~~~~~~~~~~
8759 | Number,
| ~~~~~~~
8760 | VectorizedArrayType>::integrate(const bool integrate_values,
| ~~~~~~~~~~~~~~~~~~~~
/home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:1576:26: warning: ‘void dealii::FEFaceEvaluation<dim, fe_degree, n_q_points_1d, n_components_, Number, VectorizedArrayType>::integrate(bool, bool) [with int dim = 2; int fe_degree = 2; int n_q_points_1d = 3; int n_components_ = 2; Number = double; VectorizedArrayType = dealii::VectorizedArray<double, 2>]’ is deprecated [-Wdeprecated-declarations]
1576 | phi_m.integrate(true, true);
| ~~~~~~~~~~~~~~~^~~~~~~~~~~~
In file included from /raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/operators.h:30,
from /home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:47:
/raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/fe_evaluation.h:8755:1: note: declared here
8755 | FEFaceEvaluation<dim,
| ^~~~~~~~~~~~~~~~~~~~~
8756 | fe_degree,
| ~~~~~~~~~~
8757 | n_q_points_1d,
| ~~~~~~~~~~~~~~
8758 | n_components,
| ~~~~~~~~~~~~~
8759 | Number,
| ~~~~~~~
8760 | VectorizedArrayType>::integrate(const bool integrate_values,
| ~~~~~~~~~~~~~~~~~~~~
/home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:1603:35: warning: ‘void dealii::FEFaceEvaluation<dim, fe_degree, n_q_points_1d, n_components_, Number, VectorizedArrayType>::gather_evaluate(const VectorType&, bool, bool) [with VectorType = dealii::LinearAlgebra::distributed::Vector<double>; int dim = 2; int fe_degree = 2; int n_q_points_1d = 3; int n_components_ = 2; Number = double; VectorizedArrayType = dealii::VectorizedArray<double, 2>]’ is deprecated [-Wdeprecated-declarations]
1603 | phi_extr_p.gather_evaluate(u_extr, true, false);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~
In file included from /raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/operators.h:30,
from /home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:47:
/raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/fe_evaluation.h:8880:1: note: declared here
8880 | FEFaceEvaluation<
| ^~~~~~~~~~~~~~~~~
8881 | dim,
| ~~~~
8882 | fe_degree,
| ~~~~~~~~~~
8883 | n_q_points_1d,
| ~~~~~~~~~~~~~~
8884 | n_components_,
| ~~~~~~~~~~~~~~
8885 | Number,
| ~~~~~~~
8886 | VectorizedArrayType>::gather_evaluate(const VectorType &input_vector,
| ~~~~~~~~~~~~~~~~~~~~
/home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:1605:35: warning: ‘void dealii::FEFaceEvaluation<dim, fe_degree, n_q_points_1d, n_components_, Number, VectorizedArrayType>::gather_evaluate(const VectorType&, bool, bool) [with VectorType = dealii::LinearAlgebra::distributed::Vector<double>; int dim = 2; int fe_degree = 2; int n_q_points_1d = 3; int n_components_ = 2; Number = double; VectorizedArrayType = dealii::VectorizedArray<double, 2>]’ is deprecated [-Wdeprecated-declarations]
1605 | phi_extr_m.gather_evaluate(u_extr, true, false);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~
In file included from /raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/operators.h:30,
from /home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:47:
/raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/fe_evaluation.h:8880:1: note: declared here
8880 | FEFaceEvaluation<
| ^~~~~~~~~~~~~~~~~
8881 | dim,
| ~~~~
8882 | fe_degree,
| ~~~~~~~~~~
8883 | n_q_points_1d,
| ~~~~~~~~~~~~~~
8884 | n_components_,
| ~~~~~~~~~~~~~~
8885 | Number,
| ~~~~~~~
8886 | VectorizedArrayType>::gather_evaluate(const VectorType &input_vector,
| ~~~~~~~~~~~~~~~~~~~~
/home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:1619:25: warning: ‘void dealii::FEFaceEvaluation<dim, fe_degree, n_q_points_1d, n_components_, Number, VectorizedArrayType>::evaluate(bool, bool) [with int dim = 2; int fe_degree = 2; int n_q_points_1d = 3; int n_components_ = 2; Number = double; VectorizedArrayType = dealii::VectorizedArray<double, 2>]’ is deprecated [-Wdeprecated-declarations]
1619 | phi_p.evaluate(true, true);
| ~~~~~~~~~~~~~~^~~~~~~~~~~~
In file included from /raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/operators.h:30,
from /home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:47:
/raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/fe_evaluation.h:8599:1: note: declared here
8599 | FEFaceEvaluation<dim,
| ^~~~~~~~~~~~~~~~~~~~~
8600 | fe_degree,
| ~~~~~~~~~~
8601 | n_q_points_1d,
| ~~~~~~~~~~~~~~
8602 | n_components,
| ~~~~~~~~~~~~~
8603 | Number,
| ~~~~~~~
8604 | VectorizedArrayType>::evaluate(const bool evaluate_values,
| ~~~~~~~~~~~~~~~~~~~~
/home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:1621:25: warning: ‘void dealii::FEFaceEvaluation<dim, fe_degree, n_q_points_1d, n_components_, Number, VectorizedArrayType>::evaluate(bool, bool) [with int dim = 2; int fe_degree = 2; int n_q_points_1d = 3; int n_components_ = 2; Number = double; VectorizedArrayType = dealii::VectorizedArray<double, 2>]’ is deprecated [-Wdeprecated-declarations]
1621 | phi_m.evaluate(true, true);
| ~~~~~~~~~~~~~~^~~~~~~~~~~~
In file included from /raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/operators.h:30,
from /home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:47:
/raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/fe_evaluation.h:8599:1: note: declared here
8599 | FEFaceEvaluation<dim,
| ^~~~~~~~~~~~~~~~~~~~~
8600 | fe_degree,
| ~~~~~~~~~~
8601 | n_q_points_1d,
| ~~~~~~~~~~~~~~
8602 | n_components,
| ~~~~~~~~~~~~~
8603 | Number,
| ~~~~~~~
8604 | VectorizedArrayType>::evaluate(const bool evaluate_values,
| ~~~~~~~~~~~~~~~~~~~~
/home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:1640:26: warning: ‘void dealii::FEFaceEvaluation<dim, fe_degree, n_q_points_1d, n_components_, Number, VectorizedArrayType>::integrate(bool, bool) [with int dim = 2; int fe_degree = 2; int n_q_points_1d = 3; int n_components_ = 2; Number = double; VectorizedArrayType = dealii::VectorizedArray<double, 2>]’ is deprecated [-Wdeprecated-declarations]
1640 | phi_p.integrate(true, true);
| ~~~~~~~~~~~~~~~^~~~~~~~~~~~
In file included from /raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/operators.h:30,
from /home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:47:
/raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/fe_evaluation.h:8755:1: note: declared here
8755 | FEFaceEvaluation<dim,
| ^~~~~~~~~~~~~~~~~~~~~
8756 | fe_degree,
| ~~~~~~~~~~
8757 | n_q_points_1d,
| ~~~~~~~~~~~~~~
8758 | n_components,
| ~~~~~~~~~~~~~
8759 | Number,
| ~~~~~~~
8760 | VectorizedArrayType>::integrate(const bool integrate_values,
| ~~~~~~~~~~~~~~~~~~~~
/home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:1642:26: warning: ‘void dealii::FEFaceEvaluation<dim, fe_degree, n_q_points_1d, n_components_, Number, VectorizedArrayType>::integrate(bool, bool) [with int dim = 2; int fe_degree = 2; int n_q_points_1d = 3; int n_components_ = 2; Number = double; VectorizedArrayType = dealii::VectorizedArray<double, 2>]’ is deprecated [-Wdeprecated-declarations]
1642 | phi_m.integrate(true, true);
| ~~~~~~~~~~~~~~~^~~~~~~~~~~~
In file included from /raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/operators.h:30,
from /home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:47:
/raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/fe_evaluation.h:8755:1: note: declared here
8755 | FEFaceEvaluation<dim,
| ^~~~~~~~~~~~~~~~~~~~~
8756 | fe_degree,
| ~~~~~~~~~~
8757 | n_q_points_1d,
| ~~~~~~~~~~~~~~
8758 | n_components,
| ~~~~~~~~~~~~~
8759 | Number,
| ~~~~~~~
8760 | VectorizedArrayType>::integrate(const bool integrate_values,
| ~~~~~~~~~~~~~~~~~~~~
/home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc: In instantiation of ‘void NS_TRBDF2::NavierStokesProjectionOperator<dim, fe_degree_p, fe_degree_v, n_q_points_1d_p, n_q_points_1d_v, Vec>::assemble_diagonal_boundary_term_velocity(const dealii::MatrixFree<dim, typename Vec::value_type>&, Vec&, const unsigned int&, const std::pair<unsigned int, unsigned int>&) const [with int dim = 2; int fe_degree_p = 1; int fe_degree_v = 2; int n_q_points_1d_p = 2; int n_q_points_1d_v = 3; Vec = dealii::LinearAlgebra::distributed::Vector<double>; typename Vec::value_type = double]’:
/home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:2025:17: required from ‘NS_TRBDF2::NavierStokesProjectionOperator<2, 1, 2, 2, 3, dealii::LinearAlgebra::distributed::Vector<double> >::compute_diagonal()::<lambda(const auto:92&, auto:93&, const auto:94&, const auto:95&)> [with auto:92 = dealii::MatrixFree<2, double, dealii::VectorizedArray<double, 2> >; auto:93 = dealii::LinearAlgebra::distributed::Vector<double>; auto:94 = unsigned int; auto:95 = std::pair<unsigned int, unsigned int>]’
/scratch/local/gcc-11.2.0/include/c++/11.2.0/type_traits:2466:26: required by substitution of ‘template<class _Fn, class ... _Args> static std::__result_of_success<decltype (declval<_Fn>()((declval<_Args>)()...)), std::__invoke_other> std::__result_of_other_impl::_S_test(int) [with _Fn = NS_TRBDF2::NavierStokesProjectionOperator<2, 1, 2, 2, 3, dealii::LinearAlgebra::distributed::Vector<double> >::compute_diagonal()::<lambda(const auto:92&, auto:93&, const auto:94&, const auto:95&)>&; _Args = {const dealii::MatrixFree<2, double, dealii::VectorizedArray<double, 2> >&, dealii::LinearAlgebra::distributed::Vector<double, dealii::MemorySpace::Host>&, const unsigned int&, const std::pair<unsigned int, unsigned int>&}]’
/scratch/local/gcc-11.2.0/include/c++/11.2.0/type_traits:2477:55: required from ‘struct std::__result_of_impl<false, false, NS_TRBDF2::NavierStokesProjectionOperator<2, 1, 2, 2, 3, dealii::LinearAlgebra::distributed::Vector<double> >::compute_diagonal()::<lambda(const auto:92&, auto:93&, const auto:94&, const auto:95&)>&, const dealii::MatrixFree<2, double, dealii::VectorizedArray<double, 2> >&, dealii::LinearAlgebra::distributed::Vector<double, dealii::MemorySpace::Host>&, const unsigned int&, const std::pair<unsigned int, unsigned int>&>’
/scratch/local/gcc-11.2.0/include/c++/11.2.0/bits/std_function.h:334:9: recursively required by substitution of ‘template<class _Result, class _Ret> struct std::__is_invocable_impl<_Result, _Ret, true, std::__void_t<typename _CTp::type> > [with _Result = std::__invoke_result<NS_TRBDF2::NavierStokesProjectionOperator<2, 1, 2, 2, 3, dealii::LinearAlgebra::distributed::Vector<double> >::compute_diagonal()::<lambda(const auto:92&, auto:93&, const auto:94&, const auto:95&)>&, const dealii::MatrixFree<2, double, dealii::VectorizedArray<double, 2> >&, dealii::LinearAlgebra::distributed::Vector<double, dealii::MemorySpace::Host>&, const unsigned int&, const std::pair<unsigned int, unsigned int>&>; _Ret = void]’
/scratch/local/gcc-11.2.0/include/c++/11.2.0/bits/std_function.h:334:9: required from ‘struct std::function<void(const dealii::MatrixFree<2, double, dealii::VectorizedArray<double, 2> >&, dealii::LinearAlgebra::distributed::Vector<double>&, const unsigned int&, const std::pair<unsigned int, unsigned int>&)>::_Callable<NS_TRBDF2::NavierStokesProjectionOperator<2, 1, 2, 2, 3, dealii::LinearAlgebra::distributed::Vector<double> >::compute_diagonal()::<lambda(const auto:92&, auto:93&, const auto:94&, const auto:95&)>, std::__invoke_result<NS_TRBDF2::NavierStokesProjectionOperator<2, 1, 2, 2, 3, dealii::LinearAlgebra::distributed::Vector<double> >::compute_diagonal()::<lambda(const auto:92&, auto:93&, const auto:94&, const auto:95&)>&, const dealii::MatrixFree<2, double, dealii::VectorizedArray<double, 2> >&, dealii::LinearAlgebra::distributed::Vector<double, dealii::MemorySpace::Host>&, const unsigned int&, const std::pair<unsigned int, unsigned int>&> >’
/scratch/local/gcc-11.2.0/include/c++/11.2.0/bits/std_function.h:344:8: required by substitution of ‘template<class _Res, class ... _ArgTypes> template<class _Cond, class _Tp> using _Requires = typename std::enable_if<_Cond::value, _Tp>::type [with _Cond = std::function<void(const dealii::MatrixFree<2, double, dealii::VectorizedArray<double, 2> >&, dealii::LinearAlgebra::distributed::Vector<double>&, const unsigned int&, const std::pair<unsigned int, unsigned int>&)>::_Callable<NS_TRBDF2::NavierStokesProjectionOperator<2, 1, 2, 2, 3, dealii::LinearAlgebra::distributed::Vector<double> >::compute_diagonal()::<lambda(const auto:92&, auto:93&, const auto:94&, const auto:95&)>, std::__invoke_result<NS_TRBDF2::NavierStokesProjectionOperator<2, 1, 2, 2, 3, dealii::LinearAlgebra::distributed::Vector<double> >::compute_diagonal()::<lambda(const auto:92&, auto:93&, const auto:94&, const auto:95&)>&, const dealii::MatrixFree<2, double, dealii::VectorizedArray<double, 2> >&, dealii::LinearAlgebra::distributed::Vector<double, dealii::MemorySpace::Host>&, const unsigned int&, const std::pair<unsigned int, unsigned int>&> >; _Tp = void; _Res = void; _ArgTypes = {const dealii::MatrixFree<2, double, dealii::VectorizedArray<double, 2> >&, dealii::LinearAlgebra::distributed::Vector<double, dealii::MemorySpace::Host>&, const unsigned int&, const std::pair<unsigned int, unsigned int>&}]’
/scratch/local/gcc-11.2.0/include/c++/11.2.0/bits/std_function.h:413:9: required by substitution of ‘template<class _Functor, class, class> std::function<void(const dealii::MatrixFree<2, double, dealii::VectorizedArray<double, 2> >&, dealii::LinearAlgebra::distributed::Vector<double>&, const unsigned int&, const std::pair<unsigned int, unsigned int>&)>::function(_Functor) [with _Functor = NS_TRBDF2::NavierStokesProjectionOperator<2, 1, 2, 2, 3, dealii::LinearAlgebra::distributed::Vector<double> >::compute_diagonal()::<lambda(const auto:92&, auto:93&, const auto:94&, const auto:95&)>; <template-parameter-1-2> = void; <template-parameter-1-3> = void]’
/home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:2016:7: required from ‘void NS_TRBDF2::NavierStokesProjectionOperator<dim, fe_degree_p, fe_degree_v, n_q_points_1d_p, n_q_points_1d_v, Vec>::compute_diagonal() [with int dim = 2; int fe_degree_p = 1; int fe_degree_v = 2; int n_q_points_1d_p = 2; int n_q_points_1d_v = 3; Vec = dealii::LinearAlgebra::distributed::Vector<double>]’
/home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:2450:42: required from ‘void NS_TRBDF2::NavierStokesProjection<dim>::diffusion_step() [with int dim = 2]’
/home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:2940:7: required from ‘void NS_TRBDF2::NavierStokesProjection<dim>::run(bool, unsigned int) [with int dim = 2]’
/home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:3035:13: required from here
/home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:1676:37: warning: ‘void dealii::FEFaceEvaluation<dim, fe_degree, n_q_points_1d, n_components_, Number, VectorizedArrayType>::gather_evaluate(const VectorType&, bool, bool) [with VectorType = dealii::LinearAlgebra::distributed::Vector<double>; int dim = 2; int fe_degree = 2; int n_q_points_1d = 3; int n_components_ = 2; Number = double; VectorizedArrayType = dealii::VectorizedArray<double, 2>]’ is deprecated [-Wdeprecated-declarations]
1676 | phi_old_extr.gather_evaluate(u_extr, true, false);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~
In file included from /raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/operators.h:30,
from /home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:47:
/raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/fe_evaluation.h:8880:1: note: declared here
8880 | FEFaceEvaluation<
| ^~~~~~~~~~~~~~~~~
8881 | dim,
| ~~~~
8882 | fe_degree,
| ~~~~~~~~~~
8883 | n_q_points_1d,
| ~~~~~~~~~~~~~~
8884 | n_components_,
| ~~~~~~~~~~~~~~
8885 | Number,
| ~~~~~~~
8886 | VectorizedArrayType>::gather_evaluate(const VectorType &input_vector,
| ~~~~~~~~~~~~~~~~~~~~
/home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:1690:25: warning: ‘void dealii::FEFaceEvaluation<dim, fe_degree, n_q_points_1d, n_components_, Number, VectorizedArrayType>::evaluate(bool, bool) [with int dim = 2; int fe_degree = 2; int n_q_points_1d = 3; int n_components_ = 2; Number = double; VectorizedArrayType = dealii::VectorizedArray<double, 2>]’ is deprecated [-Wdeprecated-declarations]
1690 | phi.evaluate(true, true);
| ~~~~~~~~~~~~^~~~~~~~~~~~
In file included from /raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/operators.h:30,
from /home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:47:
/raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/fe_evaluation.h:8599:1: note: declared here
8599 | FEFaceEvaluation<dim,
| ^~~~~~~~~~~~~~~~~~~~~
8600 | fe_degree,
| ~~~~~~~~~~
8601 | n_q_points_1d,
| ~~~~~~~~~~~~~~
8602 | n_components,
| ~~~~~~~~~~~~~
8603 | Number,
| ~~~~~~~
8604 | VectorizedArrayType>::evaluate(const bool evaluate_values,
| ~~~~~~~~~~~~~~~~~~~~
/home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:1704:26: warning: ‘void dealii::FEFaceEvaluation<dim, fe_degree, n_q_points_1d, n_components_, Number, VectorizedArrayType>::integrate(bool, bool) [with int dim = 2; int fe_degree = 2; int n_q_points_1d = 3; int n_components_ = 2; Number = double; VectorizedArrayType = dealii::VectorizedArray<double, 2>]’ is deprecated [-Wdeprecated-declarations]
1704 | phi.integrate(true, true);
| ~~~~~~~~~~~~~^~~~~~~~~~~~
In file included from /raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/operators.h:30,
from /home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:47:
/raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/fe_evaluation.h:8755:1: note: declared here
8755 | FEFaceEvaluation<dim,
| ^~~~~~~~~~~~~~~~~~~~~
8756 | fe_degree,
| ~~~~~~~~~~
8757 | n_q_points_1d,
| ~~~~~~~~~~~~~~
8758 | n_components,
| ~~~~~~~~~~~~~
8759 | Number,
| ~~~~~~~
8760 | VectorizedArrayType>::integrate(const bool integrate_values,
| ~~~~~~~~~~~~~~~~~~~~
/home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:1717:25: warning: ‘void dealii::FEFaceEvaluation<dim, fe_degree, n_q_points_1d, n_components_, Number, VectorizedArrayType>::evaluate(bool, bool) [with int dim = 2; int fe_degree = 2; int n_q_points_1d = 3; int n_components_ = 2; Number = double; VectorizedArrayType = dealii::VectorizedArray<double, 2>]’ is deprecated [-Wdeprecated-declarations]
1717 | phi.evaluate(true, true);
| ~~~~~~~~~~~~^~~~~~~~~~~~
In file included from /raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/operators.h:30,
from /home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:47:
/raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/fe_evaluation.h:8599:1: note: declared here
8599 | FEFaceEvaluation<dim,
| ^~~~~~~~~~~~~~~~~~~~~
8600 | fe_degree,
| ~~~~~~~~~~
8601 | n_q_points_1d,
| ~~~~~~~~~~~~~~
8602 | n_components,
| ~~~~~~~~~~~~~
8603 | Number,
| ~~~~~~~
8604 | VectorizedArrayType>::evaluate(const bool evaluate_values,
| ~~~~~~~~~~~~~~~~~~~~
/home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:1745:26: warning: ‘void dealii::FEFaceEvaluation<dim, fe_degree, n_q_points_1d, n_components_, Number, VectorizedArrayType>::integrate(bool, bool) [with int dim = 2; int fe_degree = 2; int n_q_points_1d = 3; int n_components_ = 2; Number = double; VectorizedArrayType = dealii::VectorizedArray<double, 2>]’ is deprecated [-Wdeprecated-declarations]
1745 | phi.integrate(true, true);
| ~~~~~~~~~~~~~^~~~~~~~~~~~
In file included from /raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/operators.h:30,
from /home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:47:
/raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/fe_evaluation.h:8755:1: note: declared here
8755 | FEFaceEvaluation<dim,
| ^~~~~~~~~~~~~~~~~~~~~
8756 | fe_degree,
| ~~~~~~~~~~
8757 | n_q_points_1d,
| ~~~~~~~~~~~~~~
8758 | n_components,
| ~~~~~~~~~~~~~
8759 | Number,
| ~~~~~~~
8760 | VectorizedArrayType>::integrate(const bool integrate_values,
| ~~~~~~~~~~~~~~~~~~~~
/home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:1766:33: warning: ‘void dealii::FEFaceEvaluation<dim, fe_degree, n_q_points_1d, n_components_, Number, VectorizedArrayType>::gather_evaluate(const VectorType&, bool, bool) [with VectorType = dealii::LinearAlgebra::distributed::Vector<double>; int dim = 2; int fe_degree = 2; int n_q_points_1d = 3; int n_components_ = 2; Number = double; VectorizedArrayType = dealii::VectorizedArray<double, 2>]’ is deprecated [-Wdeprecated-declarations]
1766 | phi_extr.gather_evaluate(u_extr, true, false);
| ~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~
In file included from /raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/operators.h:30,
from /home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:47:
/raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/fe_evaluation.h:8880:1: note: declared here
8880 | FEFaceEvaluation<
| ^~~~~~~~~~~~~~~~~
8881 | dim,
| ~~~~
8882 | fe_degree,
| ~~~~~~~~~~
8883 | n_q_points_1d,
| ~~~~~~~~~~~~~~
8884 | n_components_,
| ~~~~~~~~~~~~~~
8885 | Number,
| ~~~~~~~
8886 | VectorizedArrayType>::gather_evaluate(const VectorType &input_vector,
| ~~~~~~~~~~~~~~~~~~~~
/home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:1780:25: warning: ‘void dealii::FEFaceEvaluation<dim, fe_degree, n_q_points_1d, n_components_, Number, VectorizedArrayType>::evaluate(bool, bool) [with int dim = 2; int fe_degree = 2; int n_q_points_1d = 3; int n_components_ = 2; Number = double; VectorizedArrayType = dealii::VectorizedArray<double, 2>]’ is deprecated [-Wdeprecated-declarations]
1780 | phi.evaluate(true, true);
| ~~~~~~~~~~~~^~~~~~~~~~~~
In file included from /raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/operators.h:30,
from /home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:47:
/raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/fe_evaluation.h:8599:1: note: declared here
8599 | FEFaceEvaluation<dim,
| ^~~~~~~~~~~~~~~~~~~~~
8600 | fe_degree,
| ~~~~~~~~~~
8601 | n_q_points_1d,
| ~~~~~~~~~~~~~~
8602 | n_components,
| ~~~~~~~~~~~~~
8603 | Number,
| ~~~~~~~
8604 | VectorizedArrayType>::evaluate(const bool evaluate_values,
| ~~~~~~~~~~~~~~~~~~~~
/home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:1794:26: warning: ‘void dealii::FEFaceEvaluation<dim, fe_degree, n_q_points_1d, n_components_, Number, VectorizedArrayType>::integrate(bool, bool) [with int dim = 2; int fe_degree = 2; int n_q_points_1d = 3; int n_components_ = 2; Number = double; VectorizedArrayType = dealii::VectorizedArray<double, 2>]’ is deprecated [-Wdeprecated-declarations]
1794 | phi.integrate(true, true);
| ~~~~~~~~~~~~~^~~~~~~~~~~~
In file included from /raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/operators.h:30,
from /home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:47:
/raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/fe_evaluation.h:8755:1: note: declared here
8755 | FEFaceEvaluation<dim,
| ^~~~~~~~~~~~~~~~~~~~~
8756 | fe_degree,
| ~~~~~~~~~~
8757 | n_q_points_1d,
| ~~~~~~~~~~~~~~
8758 | n_components,
| ~~~~~~~~~~~~~
8759 | Number,
| ~~~~~~~
8760 | VectorizedArrayType>::integrate(const bool integrate_values,
| ~~~~~~~~~~~~~~~~~~~~
/home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:1807:25: warning: ‘void dealii::FEFaceEvaluation<dim, fe_degree, n_q_points_1d, n_components_, Number, VectorizedArrayType>::evaluate(bool, bool) [with int dim = 2; int fe_degree = 2; int n_q_points_1d = 3; int n_components_ = 2; Number = double; VectorizedArrayType = dealii::VectorizedArray<double, 2>]’ is deprecated [-Wdeprecated-declarations]
1807 | phi.evaluate(true, true);
| ~~~~~~~~~~~~^~~~~~~~~~~~
In file included from /raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/operators.h:30,
from /home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:47:
/raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/fe_evaluation.h:8599:1: note: declared here
8599 | FEFaceEvaluation<dim,
| ^~~~~~~~~~~~~~~~~~~~~
8600 | fe_degree,
| ~~~~~~~~~~
8601 | n_q_points_1d,
| ~~~~~~~~~~~~~~
8602 | n_components,
| ~~~~~~~~~~~~~
8603 | Number,
| ~~~~~~~
8604 | VectorizedArrayType>::evaluate(const bool evaluate_values,
| ~~~~~~~~~~~~~~~~~~~~
/home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:1835:26: warning: ‘void dealii::FEFaceEvaluation<dim, fe_degree, n_q_points_1d, n_components_, Number, VectorizedArrayType>::integrate(bool, bool) [with int dim = 2; int fe_degree = 2; int n_q_points_1d = 3; int n_components_ = 2; Number = double; VectorizedArrayType = dealii::VectorizedArray<double, 2>]’ is deprecated [-Wdeprecated-declarations]
1835 | phi.integrate(true, true);
| ~~~~~~~~~~~~~^~~~~~~~~~~~
In file included from /raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/operators.h:30,
from /home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:47:
/raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/fe_evaluation.h:8755:1: note: declared here
8755 | FEFaceEvaluation<dim,
| ^~~~~~~~~~~~~~~~~~~~~
8756 | fe_degree,
| ~~~~~~~~~~
8757 | n_q_points_1d,
| ~~~~~~~~~~~~~~
8758 | n_components,
| ~~~~~~~~~~~~~
8759 | Number,
| ~~~~~~~
8760 | VectorizedArrayType>::integrate(const bool integrate_values,
| ~~~~~~~~~~~~~~~~~~~~
/home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc: In instantiation of ‘void NS_TRBDF2::NavierStokesProjectionOperator<dim, fe_degree_p, fe_degree_v, n_q_points_1d_p, n_q_points_1d_v, Vec>::assemble_diagonal_cell_term_velocity(const dealii::MatrixFree<dim, typename Vec::value_type>&, Vec&, const unsigned int&, const std::pair<unsigned int, unsigned int>&) const [with int dim = 2; int fe_degree_p = 1; int fe_degree_v = 2; int n_q_points_1d_p = 2; int n_q_points_1d_v = 3; Vec = dealii::LinearAlgebra::distributed::Vector<float>; typename Vec::value_type = float]’:
/home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:2019:17: required from ‘NS_TRBDF2::NavierStokesProjectionOperator<2, 1, 2, 2, 3, dealii::LinearAlgebra::distributed::Vector<float> >::compute_diagonal()::<lambda(const auto:84&, auto:85&, const auto:86&, const auto:87&)> [with auto:84 = dealii::MatrixFree<2, float, dealii::VectorizedArray<float, 4> >; auto:85 = dealii::LinearAlgebra::distributed::Vector<float>; auto:86 = unsigned int; auto:87 = std::pair<unsigned int, unsigned int>]’
/scratch/local/gcc-11.2.0/include/c++/11.2.0/type_traits:2466:26: required by substitution of ‘template<class _Fn, class ... _Args> static std::__result_of_success<decltype (declval<_Fn>()((declval<_Args>)()...)), std::__invoke_other> std::__result_of_other_impl::_S_test(int) [with _Fn = NS_TRBDF2::NavierStokesProjectionOperator<2, 1, 2, 2, 3, dealii::LinearAlgebra::distributed::Vector<float> >::compute_diagonal()::<lambda(const auto:84&, auto:85&, const auto:86&, const auto:87&)>&; _Args = {const dealii::MatrixFree<2, float, dealii::VectorizedArray<float, 4> >&, dealii::LinearAlgebra::distributed::Vector<float, dealii::MemorySpace::Host>&, const unsigned int&, const std::pair<unsigned int, unsigned int>&}]’
/scratch/local/gcc-11.2.0/include/c++/11.2.0/type_traits:2477:55: required from ‘struct std::__result_of_impl<false, false, NS_TRBDF2::NavierStokesProjectionOperator<2, 1, 2, 2, 3, dealii::LinearAlgebra::distributed::Vector<float> >::compute_diagonal()::<lambda(const auto:84&, auto:85&, const auto:86&, const auto:87&)>&, const dealii::MatrixFree<2, float, dealii::VectorizedArray<float, 4> >&, dealii::LinearAlgebra::distributed::Vector<float, dealii::MemorySpace::Host>&, const unsigned int&, const std::pair<unsigned int, unsigned int>&>’
/scratch/local/gcc-11.2.0/include/c++/11.2.0/bits/std_function.h:334:9: recursively required by substitution of ‘template<class _Result, class _Ret> struct std::__is_invocable_impl<_Result, _Ret, true, std::__void_t<typename _CTp::type> > [with _Result = std::__invoke_result<NS_TRBDF2::NavierStokesProjectionOperator<2, 1, 2, 2, 3, dealii::LinearAlgebra::distributed::Vector<float> >::compute_diagonal()::<lambda(const auto:84&, auto:85&, const auto:86&, const auto:87&)>&, const dealii::MatrixFree<2, float, dealii::VectorizedArray<float, 4> >&, dealii::LinearAlgebra::distributed::Vector<float, dealii::MemorySpace::Host>&, const unsigned int&, const std::pair<unsigned int, unsigned int>&>; _Ret = void]’
/scratch/local/gcc-11.2.0/include/c++/11.2.0/bits/std_function.h:334:9: required from ‘struct std::function<void(const dealii::MatrixFree<2, float, dealii::VectorizedArray<float, 4> >&, dealii::LinearAlgebra::distributed::Vector<float>&, const unsigned int&, const std::pair<unsigned int, unsigned int>&)>::_Callable<NS_TRBDF2::NavierStokesProjectionOperator<2, 1, 2, 2, 3, dealii::LinearAlgebra::distributed::Vector<float> >::compute_diagonal()::<lambda(const auto:84&, auto:85&, const auto:86&, const auto:87&)>, std::__invoke_result<NS_TRBDF2::NavierStokesProjectionOperator<2, 1, 2, 2, 3, dealii::LinearAlgebra::distributed::Vector<float> >::compute_diagonal()::<lambda(const auto:84&, auto:85&, const auto:86&, const auto:87&)>&, const dealii::MatrixFree<2, float, dealii::VectorizedArray<float, 4> >&, dealii::LinearAlgebra::distributed::Vector<float, dealii::MemorySpace::Host>&, const unsigned int&, const std::pair<unsigned int, unsigned int>&> >’
/scratch/local/gcc-11.2.0/include/c++/11.2.0/bits/std_function.h:344:8: required by substitution of ‘template<class _Res, class ... _ArgTypes> template<class _Cond, class _Tp> using _Requires = typename std::enable_if<_Cond::value, _Tp>::type [with _Cond = std::function<void(const dealii::MatrixFree<2, float, dealii::VectorizedArray<float, 4> >&, dealii::LinearAlgebra::distributed::Vector<float>&, const unsigned int&, const std::pair<unsigned int, unsigned int>&)>::_Callable<NS_TRBDF2::NavierStokesProjectionOperator<2, 1, 2, 2, 3, dealii::LinearAlgebra::distributed::Vector<float> >::compute_diagonal()::<lambda(const auto:84&, auto:85&, const auto:86&, const auto:87&)>, std::__invoke_result<NS_TRBDF2::NavierStokesProjectionOperator<2, 1, 2, 2, 3, dealii::LinearAlgebra::distributed::Vector<float> >::compute_diagonal()::<lambda(const auto:84&, auto:85&, const auto:86&, const auto:87&)>&, const dealii::MatrixFree<2, float, dealii::VectorizedArray<float, 4> >&, dealii::LinearAlgebra::distributed::Vector<float, dealii::MemorySpace::Host>&, const unsigned int&, const std::pair<unsigned int, unsigned int>&> >; _Tp = void; _Res = void; _ArgTypes = {const dealii::MatrixFree<2, float, dealii::VectorizedArray<float, 4> >&, dealii::LinearAlgebra::distributed::Vector<float, dealii::MemorySpace::Host>&, const unsigned int&, const std::pair<unsigned int, unsigned int>&}]’
/scratch/local/gcc-11.2.0/include/c++/11.2.0/bits/std_function.h:413:9: required by substitution of ‘template<class _Functor, class, class> std::function<void(const dealii::MatrixFree<2, float, dealii::VectorizedArray<float, 4> >&, dealii::LinearAlgebra::distributed::Vector<float>&, const unsigned int&, const std::pair<unsigned int, unsigned int>&)>::function(_Functor) [with _Functor = NS_TRBDF2::NavierStokesProjectionOperator<2, 1, 2, 2, 3, dealii::LinearAlgebra::distributed::Vector<float> >::compute_diagonal()::<lambda(const auto:84&, auto:85&, const auto:86&, const auto:87&)>; <template-parameter-1-2> = void; <template-parameter-1-3> = void]’
/home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:2016:7: required from ‘void NS_TRBDF2::NavierStokesProjectionOperator<dim, fe_degree_p, fe_degree_v, n_q_points_1d_p, n_q_points_1d_v, Vec>::compute_diagonal() [with int dim = 2; int fe_degree_p = 1; int fe_degree_v = 2; int n_q_points_1d_p = 2; int n_q_points_1d_v = 3; Vec = dealii::LinearAlgebra::distributed::Vector<float>]’
/home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:2504:42: required from ‘void NS_TRBDF2::NavierStokesProjection<dim>::projection_step() [with int dim = 2]’
/home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:2946:7: required from ‘void NS_TRBDF2::NavierStokesProjection<dim>::run(bool, unsigned int) [with int dim = 2]’
/home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:3035:13: required from here
/home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:1439:37: warning: ‘void dealii::FEEvaluation<dim, fe_degree, n_q_points_1d, n_components_, Number, VectorizedArrayType>::gather_evaluate(const VectorType&, bool, bool, bool) [with VectorType = dealii::LinearAlgebra::distributed::Vector<float>; int dim = 2; int fe_degree = 2; int n_q_points_1d = 3; int n_components_ = 2; Number = float; VectorizedArrayType = dealii::VectorizedArray<float, 4>]’ is deprecated [-Wdeprecated-declarations]
1439 | phi_old_extr.gather_evaluate(u_extr, true, false);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~
In file included from /raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/operators.h:30,
from /home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:47:
/raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/fe_evaluation.h:7883:1: note: declared here
7883 | FEEvaluation<
| ^~~~~~~~~~~~~
7884 | dim,
| ~~~~
7885 | fe_degree,
| ~~~~~~~~~~
7886 | n_q_points_1d,
| ~~~~~~~~~~~~~~
7887 | n_components_,
| ~~~~~~~~~~~~~~
7888 | Number,
| ~~~~~~~
7889 | VectorizedArrayType>::gather_evaluate(const VectorType &input_vector,
| ~~~~~~~~~~~~~~~~~~~~
/home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:1447:23: warning: ‘void dealii::FEEvaluation<dim, fe_degree, n_q_points_1d, n_components_, Number, VectorizedArrayType>::evaluate(bool, bool, bool) [with int dim = 2; int fe_degree = 2; int n_q_points_1d = 3; int n_components_ = 2; Number = float; VectorizedArrayType = dealii::VectorizedArray<float, 4>]’ is deprecated [-Wdeprecated-declarations]
1447 | phi.evaluate(true, true);
| ~~~~~~~~~~~~^~~~~~~~~~~~
In file included from /raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/operators.h:30,
from /home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:47:
/raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/fe_evaluation.h:7746:1: note: declared here
7746 | FEEvaluation<dim,
| ^~~~~~~~~~~~~~~~~
7747 | fe_degree,
| ~~~~~~~~~~
7748 | n_q_points_1d,
| ~~~~~~~~~~~~~~
7749 | n_components_,
| ~~~~~~~~~~~~~~
7750 | Number,
| ~~~~~~~
7751 | VectorizedArrayType>::evaluate(const bool evaluate_values,
| ~~~~~~~~~~~~~~~~~~~~
/home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:1459:24: warning: ‘void dealii::FEEvaluation<dim, fe_degree, n_q_points_1d, n_components_, Number, VectorizedArrayType>::integrate(bool, bool) [with int dim = 2; int fe_degree = 2; int n_q_points_1d = 3; int n_components_ = 2; Number = float; VectorizedArrayType = dealii::VectorizedArray<float, 4>]’ is deprecated [-Wdeprecated-declarations]
1459 | phi.integrate(true, true);
| ~~~~~~~~~~~~~^~~~~~~~~~~~
In file included from /raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/operators.h:30,
from /home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:47:
/raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/fe_evaluation.h:8016:1: note: declared here
8016 | FEEvaluation<dim,
| ^~~~~~~~~~~~~~~~~
8017 | fe_degree,
| ~~~~~~~~~~
8018 | n_q_points_1d,
| ~~~~~~~~~~~~~~
8019 | n_components_,
| ~~~~~~~~~~~~~~
8020 | Number,
| ~~~~~~~
8021 | VectorizedArrayType>::integrate(const bool integrate_values,
| ~~~~~~~~~~~~~~~~~~~~
/home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:1479:37: warning: ‘void dealii::FEEvaluation<dim, fe_degree, n_q_points_1d, n_components_, Number, VectorizedArrayType>::gather_evaluate(const VectorType&, bool, bool, bool) [with VectorType = dealii::LinearAlgebra::distributed::Vector<float>; int dim = 2; int fe_degree = 2; int n_q_points_1d = 3; int n_components_ = 2; Number = float; VectorizedArrayType = dealii::VectorizedArray<float, 4>]’ is deprecated [-Wdeprecated-declarations]
1479 | phi_int_extr.gather_evaluate(u_extr, true, false);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~
In file included from /raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/operators.h:30,
from /home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:47:
/raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/fe_evaluation.h:7883:1: note: declared here
7883 | FEEvaluation<
| ^~~~~~~~~~~~~
7884 | dim,
| ~~~~
7885 | fe_degree,
| ~~~~~~~~~~
7886 | n_q_points_1d,
| ~~~~~~~~~~~~~~
7887 | n_components_,
| ~~~~~~~~~~~~~~
7888 | Number,
| ~~~~~~~
7889 | VectorizedArrayType>::gather_evaluate(const VectorType &input_vector,
| ~~~~~~~~~~~~~~~~~~~~
/home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:1487:23: warning: ‘void dealii::FEEvaluation<dim, fe_degree, n_q_points_1d, n_components_, Number, VectorizedArrayType>::evaluate(bool, bool, bool) [with int dim = 2; int fe_degree = 2; int n_q_points_1d = 3; int n_components_ = 2; Number = float; VectorizedArrayType = dealii::VectorizedArray<float, 4>]’ is deprecated [-Wdeprecated-declarations]
1487 | phi.evaluate(true, true);
| ~~~~~~~~~~~~^~~~~~~~~~~~
In file included from /raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/operators.h:30,
from /home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:47:
/raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/fe_evaluation.h:7746:1: note: declared here
7746 | FEEvaluation<dim,
| ^~~~~~~~~~~~~~~~~
7747 | fe_degree,
| ~~~~~~~~~~
7748 | n_q_points_1d,
| ~~~~~~~~~~~~~~
7749 | n_components_,
| ~~~~~~~~~~~~~~
7750 | Number,
| ~~~~~~~
7751 | VectorizedArrayType>::evaluate(const bool evaluate_values,
| ~~~~~~~~~~~~~~~~~~~~
/home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:1499:24: warning: ‘void dealii::FEEvaluation<dim, fe_degree, n_q_points_1d, n_components_, Number, VectorizedArrayType>::integrate(bool, bool) [with int dim = 2; int fe_degree = 2; int n_q_points_1d = 3; int n_components_ = 2; Number = float; VectorizedArrayType = dealii::VectorizedArray<float, 4>]’ is deprecated [-Wdeprecated-declarations]
1499 | phi.integrate(true, true);
| ~~~~~~~~~~~~~^~~~~~~~~~~~
In file included from /raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/operators.h:30,
from /home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:47:
/raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/fe_evaluation.h:8016:1: note: declared here
8016 | FEEvaluation<dim,
| ^~~~~~~~~~~~~~~~~
8017 | fe_degree,
| ~~~~~~~~~~
8018 | n_q_points_1d,
| ~~~~~~~~~~~~~~
8019 | n_components_,
| ~~~~~~~~~~~~~~
8020 | Number,
| ~~~~~~~
8021 | VectorizedArrayType>::integrate(const bool integrate_values,
| ~~~~~~~~~~~~~~~~~~~~
/home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc: In instantiation of ‘void NS_TRBDF2::NavierStokesProjectionOperator<dim, fe_degree_p, fe_degree_v, n_q_points_1d_p, n_q_points_1d_v, Vec>::assemble_diagonal_face_term_velocity(const dealii::MatrixFree<dim, typename Vec::value_type>&, Vec&, const unsigned int&, const std::pair<unsigned int, unsigned int>&) const [with int dim = 2; int fe_degree_p = 1; int fe_degree_v = 2; int n_q_points_1d_p = 2; int n_q_points_1d_v = 3; Vec = dealii::LinearAlgebra::distributed::Vector<float>; typename Vec::value_type = float]’:
/home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:2022:17: required from ‘NS_TRBDF2::NavierStokesProjectionOperator<2, 1, 2, 2, 3, dealii::LinearAlgebra::distributed::Vector<float> >::compute_diagonal()::<lambda(const auto:88&, auto:89&, const auto:90&, const auto:91&)> [with auto:88 = dealii::MatrixFree<2, float, dealii::VectorizedArray<float, 4> >; auto:89 = dealii::LinearAlgebra::distributed::Vector<float>; auto:90 = unsigned int; auto:91 = std::pair<unsigned int, unsigned int>]’
/scratch/local/gcc-11.2.0/include/c++/11.2.0/type_traits:2466:26: required by substitution of ‘template<class _Fn, class ... _Args> static std::__result_of_success<decltype (declval<_Fn>()((declval<_Args>)()...)), std::__invoke_other> std::__result_of_other_impl::_S_test(int) [with _Fn = NS_TRBDF2::NavierStokesProjectionOperator<2, 1, 2, 2, 3, dealii::LinearAlgebra::distributed::Vector<float> >::compute_diagonal()::<lambda(const auto:88&, auto:89&, const auto:90&, const auto:91&)>&; _Args = {const dealii::MatrixFree<2, float, dealii::VectorizedArray<float, 4> >&, dealii::LinearAlgebra::distributed::Vector<float, dealii::MemorySpace::Host>&, const unsigned int&, const std::pair<unsigned int, unsigned int>&}]’
/scratch/local/gcc-11.2.0/include/c++/11.2.0/type_traits:2477:55: required from ‘struct std::__result_of_impl<false, false, NS_TRBDF2::NavierStokesProjectionOperator<2, 1, 2, 2, 3, dealii::LinearAlgebra::distributed::Vector<float> >::compute_diagonal()::<lambda(const auto:88&, auto:89&, const auto:90&, const auto:91&)>&, const dealii::MatrixFree<2, float, dealii::VectorizedArray<float, 4> >&, dealii::LinearAlgebra::distributed::Vector<float, dealii::MemorySpace::Host>&, const unsigned int&, const std::pair<unsigned int, unsigned int>&>’
/scratch/local/gcc-11.2.0/include/c++/11.2.0/bits/std_function.h:334:9: recursively required by substitution of ‘template<class _Result, class _Ret> struct std::__is_invocable_impl<_Result, _Ret, true, std::__void_t<typename _CTp::type> > [with _Result = std::__invoke_result<NS_TRBDF2::NavierStokesProjectionOperator<2, 1, 2, 2, 3, dealii::LinearAlgebra::distributed::Vector<float> >::compute_diagonal()::<lambda(const auto:88&, auto:89&, const auto:90&, const auto:91&)>&, const dealii::MatrixFree<2, float, dealii::VectorizedArray<float, 4> >&, dealii::LinearAlgebra::distributed::Vector<float, dealii::MemorySpace::Host>&, const unsigned int&, const std::pair<unsigned int, unsigned int>&>; _Ret = void]’
/scratch/local/gcc-11.2.0/include/c++/11.2.0/bits/std_function.h:334:9: required from ‘struct std::function<void(const dealii::MatrixFree<2, float, dealii::VectorizedArray<float, 4> >&, dealii::LinearAlgebra::distributed::Vector<float>&, const unsigned int&, const std::pair<unsigned int, unsigned int>&)>::_Callable<NS_TRBDF2::NavierStokesProjectionOperator<2, 1, 2, 2, 3, dealii::LinearAlgebra::distributed::Vector<float> >::compute_diagonal()::<lambda(const auto:88&, auto:89&, const auto:90&, const auto:91&)>, std::__invoke_result<NS_TRBDF2::NavierStokesProjectionOperator<2, 1, 2, 2, 3, dealii::LinearAlgebra::distributed::Vector<float> >::compute_diagonal()::<lambda(const auto:88&, auto:89&, const auto:90&, const auto:91&)>&, const dealii::MatrixFree<2, float, dealii::VectorizedArray<float, 4> >&, dealii::LinearAlgebra::distributed::Vector<float, dealii::MemorySpace::Host>&, const unsigned int&, const std::pair<unsigned int, unsigned int>&> >’
/scratch/local/gcc-11.2.0/include/c++/11.2.0/bits/std_function.h:344:8: required by substitution of ‘template<class _Res, class ... _ArgTypes> template<class _Cond, class _Tp> using _Requires = typename std::enable_if<_Cond::value, _Tp>::type [with _Cond = std::function<void(const dealii::MatrixFree<2, float, dealii::VectorizedArray<float, 4> >&, dealii::LinearAlgebra::distributed::Vector<float>&, const unsigned int&, const std::pair<unsigned int, unsigned int>&)>::_Callable<NS_TRBDF2::NavierStokesProjectionOperator<2, 1, 2, 2, 3, dealii::LinearAlgebra::distributed::Vector<float> >::compute_diagonal()::<lambda(const auto:88&, auto:89&, const auto:90&, const auto:91&)>, std::__invoke_result<NS_TRBDF2::NavierStokesProjectionOperator<2, 1, 2, 2, 3, dealii::LinearAlgebra::distributed::Vector<float> >::compute_diagonal()::<lambda(const auto:88&, auto:89&, const auto:90&, const auto:91&)>&, const dealii::MatrixFree<2, float, dealii::VectorizedArray<float, 4> >&, dealii::LinearAlgebra::distributed::Vector<float, dealii::MemorySpace::Host>&, const unsigned int&, const std::pair<unsigned int, unsigned int>&> >; _Tp = void; _Res = void; _ArgTypes = {const dealii::MatrixFree<2, float, dealii::VectorizedArray<float, 4> >&, dealii::LinearAlgebra::distributed::Vector<float, dealii::MemorySpace::Host>&, const unsigned int&, const std::pair<unsigned int, unsigned int>&}]’
/scratch/local/gcc-11.2.0/include/c++/11.2.0/bits/std_function.h:413:9: required by substitution of ‘template<class _Functor, class, class> std::function<void(const dealii::MatrixFree<2, float, dealii::VectorizedArray<float, 4> >&, dealii::LinearAlgebra::distributed::Vector<float>&, const unsigned int&, const std::pair<unsigned int, unsigned int>&)>::function(_Functor) [with _Functor = NS_TRBDF2::NavierStokesProjectionOperator<2, 1, 2, 2, 3, dealii::LinearAlgebra::distributed::Vector<float> >::compute_diagonal()::<lambda(const auto:88&, auto:89&, const auto:90&, const auto:91&)>; <template-parameter-1-2> = void; <template-parameter-1-3> = void]’
/home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:2016:7: required from ‘void NS_TRBDF2::NavierStokesProjectionOperator<dim, fe_degree_p, fe_degree_v, n_q_points_1d_p, n_q_points_1d_v, Vec>::compute_diagonal() [with int dim = 2; int fe_degree_p = 1; int fe_degree_v = 2; int n_q_points_1d_p = 2; int n_q_points_1d_v = 3; Vec = dealii::LinearAlgebra::distributed::Vector<float>]’
/home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:2504:42: required from ‘void NS_TRBDF2::NavierStokesProjection<dim>::projection_step() [with int dim = 2]’
/home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:2946:7: required from ‘void NS_TRBDF2::NavierStokesProjection<dim>::run(bool, unsigned int) [with int dim = 2]’
/home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:3035:13: required from here
/home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:1537:39: warning: ‘void dealii::FEFaceEvaluation<dim, fe_degree, n_q_points_1d, n_components_, Number, VectorizedArrayType>::gather_evaluate(const VectorType&, bool, bool) [with VectorType = dealii::LinearAlgebra::distributed::Vector<float>; int dim = 2; int fe_degree = 2; int n_q_points_1d = 3; int n_components_ = 2; Number = float; VectorizedArrayType = dealii::VectorizedArray<float, 4>]’ is deprecated [-Wdeprecated-declarations]
1537 | phi_old_extr_p.gather_evaluate(u_extr, true, false);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~
In file included from /raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/operators.h:30,
from /home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:47:
/raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/fe_evaluation.h:8880:1: note: declared here
8880 | FEFaceEvaluation<
| ^~~~~~~~~~~~~~~~~
8881 | dim,
| ~~~~
8882 | fe_degree,
| ~~~~~~~~~~
8883 | n_q_points_1d,
| ~~~~~~~~~~~~~~
8884 | n_components_,
| ~~~~~~~~~~~~~~
8885 | Number,
| ~~~~~~~
8886 | VectorizedArrayType>::gather_evaluate(const VectorType &input_vector,
| ~~~~~~~~~~~~~~~~~~~~
/home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:1539:39: warning: ‘void dealii::FEFaceEvaluation<dim, fe_degree, n_q_points_1d, n_components_, Number, VectorizedArrayType>::gather_evaluate(const VectorType&, bool, bool) [with VectorType = dealii::LinearAlgebra::distributed::Vector<float>; int dim = 2; int fe_degree = 2; int n_q_points_1d = 3; int n_components_ = 2; Number = float; VectorizedArrayType = dealii::VectorizedArray<float, 4>]’ is deprecated [-Wdeprecated-declarations]
1539 | phi_old_extr_m.gather_evaluate(u_extr, true, false);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~
In file included from /raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/operators.h:30,
from /home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:47:
/raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/fe_evaluation.h:8880:1: note: declared here
8880 | FEFaceEvaluation<
| ^~~~~~~~~~~~~~~~~
8881 | dim,
| ~~~~
8882 | fe_degree,
| ~~~~~~~~~~
8883 | n_q_points_1d,
| ~~~~~~~~~~~~~~
8884 | n_components_,
| ~~~~~~~~~~~~~~
8885 | Number,
| ~~~~~~~
8886 | VectorizedArrayType>::gather_evaluate(const VectorType &input_vector,
| ~~~~~~~~~~~~~~~~~~~~
/home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:1553:25: warning: ‘void dealii::FEFaceEvaluation<dim, fe_degree, n_q_points_1d, n_components_, Number, VectorizedArrayType>::evaluate(bool, bool) [with int dim = 2; int fe_degree = 2; int n_q_points_1d = 3; int n_components_ = 2; Number = float; VectorizedArrayType = dealii::VectorizedArray<float, 4>]’ is deprecated [-Wdeprecated-declarations]
1553 | phi_p.evaluate(true, true);
| ~~~~~~~~~~~~~~^~~~~~~~~~~~
In file included from /raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/operators.h:30,
from /home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:47:
/raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/fe_evaluation.h:8599:1: note: declared here
8599 | FEFaceEvaluation<dim,
| ^~~~~~~~~~~~~~~~~~~~~
8600 | fe_degree,
| ~~~~~~~~~~
8601 | n_q_points_1d,
| ~~~~~~~~~~~~~~
8602 | n_components,
| ~~~~~~~~~~~~~
8603 | Number,
| ~~~~~~~
8604 | VectorizedArrayType>::evaluate(const bool evaluate_values,
| ~~~~~~~~~~~~~~~~~~~~
/home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:1555:25: warning: ‘void dealii::FEFaceEvaluation<dim, fe_degree, n_q_points_1d, n_components_, Number, VectorizedArrayType>::evaluate(bool, bool) [with int dim = 2; int fe_degree = 2; int n_q_points_1d = 3; int n_components_ = 2; Number = float; VectorizedArrayType = dealii::VectorizedArray<float, 4>]’ is deprecated [-Wdeprecated-declarations]
1555 | phi_m.evaluate(true, true);
| ~~~~~~~~~~~~~~^~~~~~~~~~~~
In file included from /raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/operators.h:30,
from /home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:47:
/raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/fe_evaluation.h:8599:1: note: declared here
8599 | FEFaceEvaluation<dim,
| ^~~~~~~~~~~~~~~~~~~~~
8600 | fe_degree,
| ~~~~~~~~~~
8601 | n_q_points_1d,
| ~~~~~~~~~~~~~~
8602 | n_components,
| ~~~~~~~~~~~~~
8603 | Number,
| ~~~~~~~
8604 | VectorizedArrayType>::evaluate(const bool evaluate_values,
| ~~~~~~~~~~~~~~~~~~~~
/home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:1574:26: warning: ‘void dealii::FEFaceEvaluation<dim, fe_degree, n_q_points_1d, n_components_, Number, VectorizedArrayType>::integrate(bool, bool) [with int dim = 2; int fe_degree = 2; int n_q_points_1d = 3; int n_components_ = 2; Number = float; VectorizedArrayType = dealii::VectorizedArray<float, 4>]’ is deprecated [-Wdeprecated-declarations]
1574 | phi_p.integrate(true, true);
| ~~~~~~~~~~~~~~~^~~~~~~~~~~~
In file included from /raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/operators.h:30,
from /home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:47:
/raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/fe_evaluation.h:8755:1: note: declared here
8755 | FEFaceEvaluation<dim,
| ^~~~~~~~~~~~~~~~~~~~~
8756 | fe_degree,
| ~~~~~~~~~~
8757 | n_q_points_1d,
| ~~~~~~~~~~~~~~
8758 | n_components,
| ~~~~~~~~~~~~~
8759 | Number,
| ~~~~~~~
8760 | VectorizedArrayType>::integrate(const bool integrate_values,
| ~~~~~~~~~~~~~~~~~~~~
/home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:1576:26: warning: ‘void dealii::FEFaceEvaluation<dim, fe_degree, n_q_points_1d, n_components_, Number, VectorizedArrayType>::integrate(bool, bool) [with int dim = 2; int fe_degree = 2; int n_q_points_1d = 3; int n_components_ = 2; Number = float; VectorizedArrayType = dealii::VectorizedArray<float, 4>]’ is deprecated [-Wdeprecated-declarations]
1576 | phi_m.integrate(true, true);
| ~~~~~~~~~~~~~~~^~~~~~~~~~~~
In file included from /raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/operators.h:30,
from /home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:47:
/raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/fe_evaluation.h:8755:1: note: declared here
8755 | FEFaceEvaluation<dim,
| ^~~~~~~~~~~~~~~~~~~~~
8756 | fe_degree,
| ~~~~~~~~~~
8757 | n_q_points_1d,
| ~~~~~~~~~~~~~~
8758 | n_components,
| ~~~~~~~~~~~~~
8759 | Number,
| ~~~~~~~
8760 | VectorizedArrayType>::integrate(const bool integrate_values,
| ~~~~~~~~~~~~~~~~~~~~
/home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:1603:35: warning: ‘void dealii::FEFaceEvaluation<dim, fe_degree, n_q_points_1d, n_components_, Number, VectorizedArrayType>::gather_evaluate(const VectorType&, bool, bool) [with VectorType = dealii::LinearAlgebra::distributed::Vector<float>; int dim = 2; int fe_degree = 2; int n_q_points_1d = 3; int n_components_ = 2; Number = float; VectorizedArrayType = dealii::VectorizedArray<float, 4>]’ is deprecated [-Wdeprecated-declarations]
1603 | phi_extr_p.gather_evaluate(u_extr, true, false);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~
In file included from /raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/operators.h:30,
from /home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:47:
/raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/fe_evaluation.h:8880:1: note: declared here
8880 | FEFaceEvaluation<
| ^~~~~~~~~~~~~~~~~
8881 | dim,
| ~~~~
8882 | fe_degree,
| ~~~~~~~~~~
8883 | n_q_points_1d,
| ~~~~~~~~~~~~~~
8884 | n_components_,
| ~~~~~~~~~~~~~~
8885 | Number,
| ~~~~~~~
8886 | VectorizedArrayType>::gather_evaluate(const VectorType &input_vector,
| ~~~~~~~~~~~~~~~~~~~~
/home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:1605:35: warning: ‘void dealii::FEFaceEvaluation<dim, fe_degree, n_q_points_1d, n_components_, Number, VectorizedArrayType>::gather_evaluate(const VectorType&, bool, bool) [with VectorType = dealii::LinearAlgebra::distributed::Vector<float>; int dim = 2; int fe_degree = 2; int n_q_points_1d = 3; int n_components_ = 2; Number = float; VectorizedArrayType = dealii::VectorizedArray<float, 4>]’ is deprecated [-Wdeprecated-declarations]
1605 | phi_extr_m.gather_evaluate(u_extr, true, false);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~
In file included from /raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/operators.h:30,
from /home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:47:
/raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/fe_evaluation.h:8880:1: note: declared here
8880 | FEFaceEvaluation<
| ^~~~~~~~~~~~~~~~~
8881 | dim,
| ~~~~
8882 | fe_degree,
| ~~~~~~~~~~
8883 | n_q_points_1d,
| ~~~~~~~~~~~~~~
8884 | n_components_,
| ~~~~~~~~~~~~~~
8885 | Number,
| ~~~~~~~
8886 | VectorizedArrayType>::gather_evaluate(const VectorType &input_vector,
| ~~~~~~~~~~~~~~~~~~~~
/home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:1619:25: warning: ‘void dealii::FEFaceEvaluation<dim, fe_degree, n_q_points_1d, n_components_, Number, VectorizedArrayType>::evaluate(bool, bool) [with int dim = 2; int fe_degree = 2; int n_q_points_1d = 3; int n_components_ = 2; Number = float; VectorizedArrayType = dealii::VectorizedArray<float, 4>]’ is deprecated [-Wdeprecated-declarations]
1619 | phi_p.evaluate(true, true);
| ~~~~~~~~~~~~~~^~~~~~~~~~~~
In file included from /raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/operators.h:30,
from /home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:47:
/raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/fe_evaluation.h:8599:1: note: declared here
8599 | FEFaceEvaluation<dim,
| ^~~~~~~~~~~~~~~~~~~~~
8600 | fe_degree,
| ~~~~~~~~~~
8601 | n_q_points_1d,
| ~~~~~~~~~~~~~~
8602 | n_components,
| ~~~~~~~~~~~~~
8603 | Number,
| ~~~~~~~
8604 | VectorizedArrayType>::evaluate(const bool evaluate_values,
| ~~~~~~~~~~~~~~~~~~~~
/home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:1621:25: warning: ‘void dealii::FEFaceEvaluation<dim, fe_degree, n_q_points_1d, n_components_, Number, VectorizedArrayType>::evaluate(bool, bool) [with int dim = 2; int fe_degree = 2; int n_q_points_1d = 3; int n_components_ = 2; Number = float; VectorizedArrayType = dealii::VectorizedArray<float, 4>]’ is deprecated [-Wdeprecated-declarations]
1621 | phi_m.evaluate(true, true);
| ~~~~~~~~~~~~~~^~~~~~~~~~~~
In file included from /raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/operators.h:30,
from /home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:47:
/raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/fe_evaluation.h:8599:1: note: declared here
8599 | FEFaceEvaluation<dim,
| ^~~~~~~~~~~~~~~~~~~~~
8600 | fe_degree,
| ~~~~~~~~~~
8601 | n_q_points_1d,
| ~~~~~~~~~~~~~~
8602 | n_components,
| ~~~~~~~~~~~~~
8603 | Number,
| ~~~~~~~
8604 | VectorizedArrayType>::evaluate(const bool evaluate_values,
| ~~~~~~~~~~~~~~~~~~~~
/home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:1640:26: warning: ‘void dealii::FEFaceEvaluation<dim, fe_degree, n_q_points_1d, n_components_, Number, VectorizedArrayType>::integrate(bool, bool) [with int dim = 2; int fe_degree = 2; int n_q_points_1d = 3; int n_components_ = 2; Number = float; VectorizedArrayType = dealii::VectorizedArray<float, 4>]’ is deprecated [-Wdeprecated-declarations]
1640 | phi_p.integrate(true, true);
| ~~~~~~~~~~~~~~~^~~~~~~~~~~~
In file included from /raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/operators.h:30,
from /home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:47:
/raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/fe_evaluation.h:8755:1: note: declared here
8755 | FEFaceEvaluation<dim,
| ^~~~~~~~~~~~~~~~~~~~~
8756 | fe_degree,
| ~~~~~~~~~~
8757 | n_q_points_1d,
| ~~~~~~~~~~~~~~
8758 | n_components,
| ~~~~~~~~~~~~~
8759 | Number,
| ~~~~~~~
8760 | VectorizedArrayType>::integrate(const bool integrate_values,
| ~~~~~~~~~~~~~~~~~~~~
/home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:1642:26: warning: ‘void dealii::FEFaceEvaluation<dim, fe_degree, n_q_points_1d, n_components_, Number, VectorizedArrayType>::integrate(bool, bool) [with int dim = 2; int fe_degree = 2; int n_q_points_1d = 3; int n_components_ = 2; Number = float; VectorizedArrayType = dealii::VectorizedArray<float, 4>]’ is deprecated [-Wdeprecated-declarations]
1642 | phi_m.integrate(true, true);
| ~~~~~~~~~~~~~~~^~~~~~~~~~~~
In file included from /raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/operators.h:30,
from /home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:47:
/raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/fe_evaluation.h:8755:1: note: declared here
8755 | FEFaceEvaluation<dim,
| ^~~~~~~~~~~~~~~~~~~~~
8756 | fe_degree,
| ~~~~~~~~~~
8757 | n_q_points_1d,
| ~~~~~~~~~~~~~~
8758 | n_components,
| ~~~~~~~~~~~~~
8759 | Number,
| ~~~~~~~
8760 | VectorizedArrayType>::integrate(const bool integrate_values,
| ~~~~~~~~~~~~~~~~~~~~
/home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc: In instantiation of ‘void NS_TRBDF2::NavierStokesProjectionOperator<dim, fe_degree_p, fe_degree_v, n_q_points_1d_p, n_q_points_1d_v, Vec>::assemble_diagonal_boundary_term_velocity(const dealii::MatrixFree<dim, typename Vec::value_type>&, Vec&, const unsigned int&, const std::pair<unsigned int, unsigned int>&) const [with int dim = 2; int fe_degree_p = 1; int fe_degree_v = 2; int n_q_points_1d_p = 2; int n_q_points_1d_v = 3; Vec = dealii::LinearAlgebra::distributed::Vector<float>; typename Vec::value_type = float]’:
/home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:2025:17: required from ‘NS_TRBDF2::NavierStokesProjectionOperator<2, 1, 2, 2, 3, dealii::LinearAlgebra::distributed::Vector<float> >::compute_diagonal()::<lambda(const auto:92&, auto:93&, const auto:94&, const auto:95&)> [with auto:92 = dealii::MatrixFree<2, float, dealii::VectorizedArray<float, 4> >; auto:93 = dealii::LinearAlgebra::distributed::Vector<float>; auto:94 = unsigned int; auto:95 = std::pair<unsigned int, unsigned int>]’
/scratch/local/gcc-11.2.0/include/c++/11.2.0/type_traits:2466:26: required by substitution of ‘template<class _Fn, class ... _Args> static std::__result_of_success<decltype (declval<_Fn>()((declval<_Args>)()...)), std::__invoke_other> std::__result_of_other_impl::_S_test(int) [with _Fn = NS_TRBDF2::NavierStokesProjectionOperator<2, 1, 2, 2, 3, dealii::LinearAlgebra::distributed::Vector<float> >::compute_diagonal()::<lambda(const auto:92&, auto:93&, const auto:94&, const auto:95&)>&; _Args = {const dealii::MatrixFree<2, float, dealii::VectorizedArray<float, 4> >&, dealii::LinearAlgebra::distributed::Vector<float, dealii::MemorySpace::Host>&, const unsigned int&, const std::pair<unsigned int, unsigned int>&}]’
/scratch/local/gcc-11.2.0/include/c++/11.2.0/type_traits:2477:55: required from ‘struct std::__result_of_impl<false, false, NS_TRBDF2::NavierStokesProjectionOperator<2, 1, 2, 2, 3, dealii::LinearAlgebra::distributed::Vector<float> >::compute_diagonal()::<lambda(const auto:92&, auto:93&, const auto:94&, const auto:95&)>&, const dealii::MatrixFree<2, float, dealii::VectorizedArray<float, 4> >&, dealii::LinearAlgebra::distributed::Vector<float, dealii::MemorySpace::Host>&, const unsigned int&, const std::pair<unsigned int, unsigned int>&>’
/scratch/local/gcc-11.2.0/include/c++/11.2.0/bits/std_function.h:334:9: recursively required by substitution of ‘template<class _Result, class _Ret> struct std::__is_invocable_impl<_Result, _Ret, true, std::__void_t<typename _CTp::type> > [with _Result = std::__invoke_result<NS_TRBDF2::NavierStokesProjectionOperator<2, 1, 2, 2, 3, dealii::LinearAlgebra::distributed::Vector<float> >::compute_diagonal()::<lambda(const auto:92&, auto:93&, const auto:94&, const auto:95&)>&, const dealii::MatrixFree<2, float, dealii::VectorizedArray<float, 4> >&, dealii::LinearAlgebra::distributed::Vector<float, dealii::MemorySpace::Host>&, const unsigned int&, const std::pair<unsigned int, unsigned int>&>; _Ret = void]’
/scratch/local/gcc-11.2.0/include/c++/11.2.0/bits/std_function.h:334:9: required from ‘struct std::function<void(const dealii::MatrixFree<2, float, dealii::VectorizedArray<float, 4> >&, dealii::LinearAlgebra::distributed::Vector<float>&, const unsigned int&, const std::pair<unsigned int, unsigned int>&)>::_Callable<NS_TRBDF2::NavierStokesProjectionOperator<2, 1, 2, 2, 3, dealii::LinearAlgebra::distributed::Vector<float> >::compute_diagonal()::<lambda(const auto:92&, auto:93&, const auto:94&, const auto:95&)>, std::__invoke_result<NS_TRBDF2::NavierStokesProjectionOperator<2, 1, 2, 2, 3, dealii::LinearAlgebra::distributed::Vector<float> >::compute_diagonal()::<lambda(const auto:92&, auto:93&, const auto:94&, const auto:95&)>&, const dealii::MatrixFree<2, float, dealii::VectorizedArray<float, 4> >&, dealii::LinearAlgebra::distributed::Vector<float, dealii::MemorySpace::Host>&, const unsigned int&, const std::pair<unsigned int, unsigned int>&> >’
/scratch/local/gcc-11.2.0/include/c++/11.2.0/bits/std_function.h:344:8: required by substitution of ‘template<class _Res, class ... _ArgTypes> template<class _Cond, class _Tp> using _Requires = typename std::enable_if<_Cond::value, _Tp>::type [with _Cond = std::function<void(const dealii::MatrixFree<2, float, dealii::VectorizedArray<float, 4> >&, dealii::LinearAlgebra::distributed::Vector<float>&, const unsigned int&, const std::pair<unsigned int, unsigned int>&)>::_Callable<NS_TRBDF2::NavierStokesProjectionOperator<2, 1, 2, 2, 3, dealii::LinearAlgebra::distributed::Vector<float> >::compute_diagonal()::<lambda(const auto:92&, auto:93&, const auto:94&, const auto:95&)>, std::__invoke_result<NS_TRBDF2::NavierStokesProjectionOperator<2, 1, 2, 2, 3, dealii::LinearAlgebra::distributed::Vector<float> >::compute_diagonal()::<lambda(const auto:92&, auto:93&, const auto:94&, const auto:95&)>&, const dealii::MatrixFree<2, float, dealii::VectorizedArray<float, 4> >&, dealii::LinearAlgebra::distributed::Vector<float, dealii::MemorySpace::Host>&, const unsigned int&, const std::pair<unsigned int, unsigned int>&> >; _Tp = void; _Res = void; _ArgTypes = {const dealii::MatrixFree<2, float, dealii::VectorizedArray<float, 4> >&, dealii::LinearAlgebra::distributed::Vector<float, dealii::MemorySpace::Host>&, const unsigned int&, const std::pair<unsigned int, unsigned int>&}]’
/scratch/local/gcc-11.2.0/include/c++/11.2.0/bits/std_function.h:413:9: required by substitution of ‘template<class _Functor, class, class> std::function<void(const dealii::MatrixFree<2, float, dealii::VectorizedArray<float, 4> >&, dealii::LinearAlgebra::distributed::Vector<float>&, const unsigned int&, const std::pair<unsigned int, unsigned int>&)>::function(_Functor) [with _Functor = NS_TRBDF2::NavierStokesProjectionOperator<2, 1, 2, 2, 3, dealii::LinearAlgebra::distributed::Vector<float> >::compute_diagonal()::<lambda(const auto:92&, auto:93&, const auto:94&, const auto:95&)>; <template-parameter-1-2> = void; <template-parameter-1-3> = void]’
/home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:2016:7: required from ‘void NS_TRBDF2::NavierStokesProjectionOperator<dim, fe_degree_p, fe_degree_v, n_q_points_1d_p, n_q_points_1d_v, Vec>::compute_diagonal() [with int dim = 2; int fe_degree_p = 1; int fe_degree_v = 2; int n_q_points_1d_p = 2; int n_q_points_1d_v = 3; Vec = dealii::LinearAlgebra::distributed::Vector<float>]’
/home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:2504:42: required from ‘void NS_TRBDF2::NavierStokesProjection<dim>::projection_step() [with int dim = 2]’
/home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:2946:7: required from ‘void NS_TRBDF2::NavierStokesProjection<dim>::run(bool, unsigned int) [with int dim = 2]’
/home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:3035:13: required from here
/home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:1676:37: warning: ‘void dealii::FEFaceEvaluation<dim, fe_degree, n_q_points_1d, n_components_, Number, VectorizedArrayType>::gather_evaluate(const VectorType&, bool, bool) [with VectorType = dealii::LinearAlgebra::distributed::Vector<float>; int dim = 2; int fe_degree = 2; int n_q_points_1d = 3; int n_components_ = 2; Number = float; VectorizedArrayType = dealii::VectorizedArray<float, 4>]’ is deprecated [-Wdeprecated-declarations]
1676 | phi_old_extr.gather_evaluate(u_extr, true, false);
| ~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~
In file included from /raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/operators.h:30,
from /home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:47:
/raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/fe_evaluation.h:8880:1: note: declared here
8880 | FEFaceEvaluation<
| ^~~~~~~~~~~~~~~~~
8881 | dim,
| ~~~~
8882 | fe_degree,
| ~~~~~~~~~~
8883 | n_q_points_1d,
| ~~~~~~~~~~~~~~
8884 | n_components_,
| ~~~~~~~~~~~~~~
8885 | Number,
| ~~~~~~~
8886 | VectorizedArrayType>::gather_evaluate(const VectorType &input_vector,
| ~~~~~~~~~~~~~~~~~~~~
/home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:1690:25: warning: ‘void dealii::FEFaceEvaluation<dim, fe_degree, n_q_points_1d, n_components_, Number, VectorizedArrayType>::evaluate(bool, bool) [with int dim = 2; int fe_degree = 2; int n_q_points_1d = 3; int n_components_ = 2; Number = float; VectorizedArrayType = dealii::VectorizedArray<float, 4>]’ is deprecated [-Wdeprecated-declarations]
1690 | phi.evaluate(true, true);
| ~~~~~~~~~~~~^~~~~~~~~~~~
In file included from /raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/operators.h:30,
from /home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:47:
/raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/fe_evaluation.h:8599:1: note: declared here
8599 | FEFaceEvaluation<dim,
| ^~~~~~~~~~~~~~~~~~~~~
8600 | fe_degree,
| ~~~~~~~~~~
8601 | n_q_points_1d,
| ~~~~~~~~~~~~~~
8602 | n_components,
| ~~~~~~~~~~~~~
8603 | Number,
| ~~~~~~~
8604 | VectorizedArrayType>::evaluate(const bool evaluate_values,
| ~~~~~~~~~~~~~~~~~~~~
/home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:1704:26: warning: ‘void dealii::FEFaceEvaluation<dim, fe_degree, n_q_points_1d, n_components_, Number, VectorizedArrayType>::integrate(bool, bool) [with int dim = 2; int fe_degree = 2; int n_q_points_1d = 3; int n_components_ = 2; Number = float; VectorizedArrayType = dealii::VectorizedArray<float, 4>]’ is deprecated [-Wdeprecated-declarations]
1704 | phi.integrate(true, true);
| ~~~~~~~~~~~~~^~~~~~~~~~~~
In file included from /raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/operators.h:30,
from /home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:47:
/raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/fe_evaluation.h:8755:1: note: declared here
8755 | FEFaceEvaluation<dim,
| ^~~~~~~~~~~~~~~~~~~~~
8756 | fe_degree,
| ~~~~~~~~~~
8757 | n_q_points_1d,
| ~~~~~~~~~~~~~~
8758 | n_components,
| ~~~~~~~~~~~~~
8759 | Number,
| ~~~~~~~
8760 | VectorizedArrayType>::integrate(const bool integrate_values,
| ~~~~~~~~~~~~~~~~~~~~
/home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:1717:25: warning: ‘void dealii::FEFaceEvaluation<dim, fe_degree, n_q_points_1d, n_components_, Number, VectorizedArrayType>::evaluate(bool, bool) [with int dim = 2; int fe_degree = 2; int n_q_points_1d = 3; int n_components_ = 2; Number = float; VectorizedArrayType = dealii::VectorizedArray<float, 4>]’ is deprecated [-Wdeprecated-declarations]
1717 | phi.evaluate(true, true);
| ~~~~~~~~~~~~^~~~~~~~~~~~
In file included from /raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/operators.h:30,
from /home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:47:
/raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/fe_evaluation.h:8599:1: note: declared here
8599 | FEFaceEvaluation<dim,
| ^~~~~~~~~~~~~~~~~~~~~
8600 | fe_degree,
| ~~~~~~~~~~
8601 | n_q_points_1d,
| ~~~~~~~~~~~~~~
8602 | n_components,
| ~~~~~~~~~~~~~
8603 | Number,
| ~~~~~~~
8604 | VectorizedArrayType>::evaluate(const bool evaluate_values,
| ~~~~~~~~~~~~~~~~~~~~
/home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:1745:26: warning: ‘void dealii::FEFaceEvaluation<dim, fe_degree, n_q_points_1d, n_components_, Number, VectorizedArrayType>::integrate(bool, bool) [with int dim = 2; int fe_degree = 2; int n_q_points_1d = 3; int n_components_ = 2; Number = float; VectorizedArrayType = dealii::VectorizedArray<float, 4>]’ is deprecated [-Wdeprecated-declarations]
1745 | phi.integrate(true, true);
| ~~~~~~~~~~~~~^~~~~~~~~~~~
In file included from /raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/operators.h:30,
from /home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:47:
/raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/fe_evaluation.h:8755:1: note: declared here
8755 | FEFaceEvaluation<dim,
| ^~~~~~~~~~~~~~~~~~~~~
8756 | fe_degree,
| ~~~~~~~~~~
8757 | n_q_points_1d,
| ~~~~~~~~~~~~~~
8758 | n_components,
| ~~~~~~~~~~~~~
8759 | Number,
| ~~~~~~~
8760 | VectorizedArrayType>::integrate(const bool integrate_values,
| ~~~~~~~~~~~~~~~~~~~~
/home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:1766:33: warning: ‘void dealii::FEFaceEvaluation<dim, fe_degree, n_q_points_1d, n_components_, Number, VectorizedArrayType>::gather_evaluate(const VectorType&, bool, bool) [with VectorType = dealii::LinearAlgebra::distributed::Vector<float>; int dim = 2; int fe_degree = 2; int n_q_points_1d = 3; int n_components_ = 2; Number = float; VectorizedArrayType = dealii::VectorizedArray<float, 4>]’ is deprecated [-Wdeprecated-declarations]
1766 | phi_extr.gather_evaluate(u_extr, true, false);
| ~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~
In file included from /raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/operators.h:30,
from /home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:47:
/raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/fe_evaluation.h:8880:1: note: declared here
8880 | FEFaceEvaluation<
| ^~~~~~~~~~~~~~~~~
8881 | dim,
| ~~~~
8882 | fe_degree,
| ~~~~~~~~~~
8883 | n_q_points_1d,
| ~~~~~~~~~~~~~~
8884 | n_components_,
| ~~~~~~~~~~~~~~
8885 | Number,
| ~~~~~~~
8886 | VectorizedArrayType>::gather_evaluate(const VectorType &input_vector,
| ~~~~~~~~~~~~~~~~~~~~
/home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:1780:25: warning: ‘void dealii::FEFaceEvaluation<dim, fe_degree, n_q_points_1d, n_components_, Number, VectorizedArrayType>::evaluate(bool, bool) [with int dim = 2; int fe_degree = 2; int n_q_points_1d = 3; int n_components_ = 2; Number = float; VectorizedArrayType = dealii::VectorizedArray<float, 4>]’ is deprecated [-Wdeprecated-declarations]
1780 | phi.evaluate(true, true);
| ~~~~~~~~~~~~^~~~~~~~~~~~
In file included from /raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/operators.h:30,
from /home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:47:
/raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/fe_evaluation.h:8599:1: note: declared here
8599 | FEFaceEvaluation<dim,
| ^~~~~~~~~~~~~~~~~~~~~
8600 | fe_degree,
| ~~~~~~~~~~
8601 | n_q_points_1d,
| ~~~~~~~~~~~~~~
8602 | n_components,
| ~~~~~~~~~~~~~
8603 | Number,
| ~~~~~~~
8604 | VectorizedArrayType>::evaluate(const bool evaluate_values,
| ~~~~~~~~~~~~~~~~~~~~
/home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:1794:26: warning: ‘void dealii::FEFaceEvaluation<dim, fe_degree, n_q_points_1d, n_components_, Number, VectorizedArrayType>::integrate(bool, bool) [with int dim = 2; int fe_degree = 2; int n_q_points_1d = 3; int n_components_ = 2; Number = float; VectorizedArrayType = dealii::VectorizedArray<float, 4>]’ is deprecated [-Wdeprecated-declarations]
1794 | phi.integrate(true, true);
| ~~~~~~~~~~~~~^~~~~~~~~~~~
In file included from /raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/operators.h:30,
from /home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:47:
/raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/fe_evaluation.h:8755:1: note: declared here
8755 | FEFaceEvaluation<dim,
| ^~~~~~~~~~~~~~~~~~~~~
8756 | fe_degree,
| ~~~~~~~~~~
8757 | n_q_points_1d,
| ~~~~~~~~~~~~~~
8758 | n_components,
| ~~~~~~~~~~~~~
8759 | Number,
| ~~~~~~~
8760 | VectorizedArrayType>::integrate(const bool integrate_values,
| ~~~~~~~~~~~~~~~~~~~~
/home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:1807:25: warning: ‘void dealii::FEFaceEvaluation<dim, fe_degree, n_q_points_1d, n_components_, Number, VectorizedArrayType>::evaluate(bool, bool) [with int dim = 2; int fe_degree = 2; int n_q_points_1d = 3; int n_components_ = 2; Number = float; VectorizedArrayType = dealii::VectorizedArray<float, 4>]’ is deprecated [-Wdeprecated-declarations]
1807 | phi.evaluate(true, true);
| ~~~~~~~~~~~~^~~~~~~~~~~~
In file included from /raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/operators.h:30,
from /home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:47:
/raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/fe_evaluation.h:8599:1: note: declared here
8599 | FEFaceEvaluation<dim,
| ^~~~~~~~~~~~~~~~~~~~~
8600 | fe_degree,
| ~~~~~~~~~~
8601 | n_q_points_1d,
| ~~~~~~~~~~~~~~
8602 | n_components,
| ~~~~~~~~~~~~~
8603 | Number,
| ~~~~~~~
8604 | VectorizedArrayType>::evaluate(const bool evaluate_values,
| ~~~~~~~~~~~~~~~~~~~~
/home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:1835:26: warning: ‘void dealii::FEFaceEvaluation<dim, fe_degree, n_q_points_1d, n_components_, Number, VectorizedArrayType>::integrate(bool, bool) [with int dim = 2; int fe_degree = 2; int n_q_points_1d = 3; int n_components_ = 2; Number = float; VectorizedArrayType = dealii::VectorizedArray<float, 4>]’ is deprecated [-Wdeprecated-declarations]
1835 | phi.integrate(true, true);
| ~~~~~~~~~~~~~^~~~~~~~~~~~
In file included from /raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/operators.h:30,
from /home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:47:
/raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/fe_evaluation.h:8755:1: note: declared here
8755 | FEFaceEvaluation<dim,
| ^~~~~~~~~~~~~~~~~~~~~
8756 | fe_degree,
| ~~~~~~~~~~
8757 | n_q_points_1d,
| ~~~~~~~~~~~~~~
8758 | n_components,
| ~~~~~~~~~~~~~
8759 | Number,
| ~~~~~~~
8760 | VectorizedArrayType>::integrate(const bool integrate_values,
| ~~~~~~~~~~~~~~~~~~~~
/home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc: In instantiation of ‘void NS_TRBDF2::NavierStokesProjectionOperator<dim, fe_degree_p, fe_degree_v, n_q_points_1d_p, n_q_points_1d_v, Vec>::assemble_boundary_term_pressure(const dealii::MatrixFree<dim, typename Vec::value_type>&, Vec&, const Vec&, const std::pair<unsigned int, unsigned int>&) const [with int dim = 2; int fe_degree_p = 1; int fe_degree_v = 2; int n_q_points_1d_p = 2; int n_q_points_1d_v = 3; Vec = dealii::LinearAlgebra::distributed::Vector<float>; typename Vec::value_type = float]’:
/home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:1400:24: required from ‘void NS_TRBDF2::NavierStokesProjectionOperator<dim, fe_degree_p, fe_degree_v, n_q_points_1d_p, n_q_points_1d_v, Vec>::apply_add(Vec&, const Vec&) const [with int dim = 2; int fe_degree_p = 1; int fe_degree_v = 2; int n_q_points_1d_p = 2; int n_q_points_1d_v = 3; Vec = dealii::LinearAlgebra::distributed::Vector<float>]’
/home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:1387:8: required from here
/home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:1300:28: warning: ‘void dealii::FEFaceEvaluation<dim, fe_degree, n_q_points_1d, n_components_, Number, VectorizedArrayType>::gather_evaluate(const VectorType&, bool, bool) [with VectorType = dealii::LinearAlgebra::distributed::Vector<float>; int dim = 2; int fe_degree = 1; int n_q_points_1d = 2; int n_components_ = 1; Number = float; VectorizedArrayType = dealii::VectorizedArray<float, 4>]’ is deprecated [-Wdeprecated-declarations]
1300 | phi.gather_evaluate(src, true, true);
| ~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~
In file included from /raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/operators.h:30,
from /home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:47:
/raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/fe_evaluation.h:8880:1: note: declared here
8880 | FEFaceEvaluation<
| ^~~~~~~~~~~~~~~~~
8881 | dim,
| ~~~~
8882 | fe_degree,
| ~~~~~~~~~~
8883 | n_q_points_1d,
| ~~~~~~~~~~~~~~
8884 | n_components_,
| ~~~~~~~~~~~~~~
8885 | Number,
| ~~~~~~~
8886 | VectorizedArrayType>::gather_evaluate(const VectorType &input_vector,
| ~~~~~~~~~~~~~~~~~~~~
/home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc: In instantiation of ‘void NS_TRBDF2::NavierStokesProjectionOperator<dim, fe_degree_p, fe_degree_v, n_q_points_1d_p, n_q_points_1d_v, Vec>::assemble_boundary_term_pressure(const dealii::MatrixFree<dim, typename Vec::value_type>&, Vec&, const Vec&, const std::pair<unsigned int, unsigned int>&) const [with int dim = 2; int fe_degree_p = 1; int fe_degree_v = 2; int n_q_points_1d_p = 2; int n_q_points_1d_v = 3; Vec = dealii::LinearAlgebra::distributed::Vector<double>; typename Vec::value_type = double]’:
/home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:1400:24: required from ‘void NS_TRBDF2::NavierStokesProjectionOperator<dim, fe_degree_p, fe_degree_v, n_q_points_1d_p, n_q_points_1d_v, Vec>::apply_add(Vec&, const Vec&) const [with int dim = 2; int fe_degree_p = 1; int fe_degree_v = 2; int n_q_points_1d_p = 2; int n_q_points_1d_v = 3; Vec = dealii::LinearAlgebra::distributed::Vector<double>]’
/home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:1387:8: required from here
/home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:1300:28: warning: ‘void dealii::FEFaceEvaluation<dim, fe_degree, n_q_points_1d, n_components_, Number, VectorizedArrayType>::gather_evaluate(const VectorType&, bool, bool) [with VectorType = dealii::LinearAlgebra::distributed::Vector<double>; int dim = 2; int fe_degree = 1; int n_q_points_1d = 2; int n_components_ = 1; Number = double; VectorizedArrayType = dealii::VectorizedArray<double, 2>]’ is deprecated [-Wdeprecated-declarations]
1300 | phi.gather_evaluate(src, true, true);
| ~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~
In file included from /raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/operators.h:30,
from /home/fac/g/bangerth/p/deal.II/1/dealii/code-gallery/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc:47:
/raid/bangerth/p/deal.II/1/install/include/deal.II/matrix_free/fe_evaluation.h:8880:1: note: declared here
8880 | FEFaceEvaluation<
| ^~~~~~~~~~~~~~~~~
8881 | dim,
| ~~~~
8882 | fe_degree,
| ~~~~~~~~~~
8883 | n_q_points_1d,
| ~~~~~~~~~~~~~~
8884 | n_components_,
| ~~~~~~~~~~~~~~
8885 | Number,
| ~~~~~~~
8886 | VectorizedArrayType>::gather_evaluate(const VectorType &input_vector,
| ~~~~~~~~~~~~~~~~~~~~
All code-gallery programs now compile, with both the latest release 9.5
and the current master, according to our github worker. I'll thus mark this as resolved. See also #159 and #160.
After merging the current crop of PRs that fix compilation for all code gallery programs (and replace deprecated function calls), there remain a few places where programs use deprecated matrix-free functions with which I am not familiar. @kronbichler @peterrum -- would you be willing to look at these? The warnings I get are as follows:
This goes on for several more pages, but github only allows me to attach up to 64kB of text :-)