From: Wolfgang Bangerth Date: Fri, 5 Mar 2021 02:20:36 +0000 (+0100) Subject: Replace 'typedef' by 'using' in the test suite. X-Git-Tag: v9.3.0-rc1~374^2 X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=d695e3ee64a6d896d33b1f285ec1e3bb5ff2dc34;p=dealii.git Replace 'typedef' by 'using' in the test suite. --- diff --git a/tests/ad_common_tests/helper_scalar_coupled_2_components_01.h b/tests/ad_common_tests/helper_scalar_coupled_2_components_01.h index c6185076fd..4e2438c182 100644 --- a/tests/ad_common_tests/helper_scalar_coupled_2_components_01.h +++ b/tests/ad_common_tests/helper_scalar_coupled_2_components_01.h @@ -86,9 +86,9 @@ template void test_scalar_scalar_coupled() { - typedef AD::ScalarFunction ADHelper; - typedef typename ADHelper::ad_type ADNumberType; - typedef typename ADHelper::scalar_type ScalarNumberType; + using ADHelper = AD::ScalarFunction; + using ADNumberType = typename ADHelper::ad_type; + using ScalarNumberType = typename ADHelper::scalar_type; std::cout << "*** Test variables: Scalar + Scalar (coupled), " << "dim = " << Utilities::to_string(dim) << ", " @@ -100,7 +100,7 @@ test_scalar_scalar_coupled() FullMatrix D2psi; // Function and its derivatives - typedef FunctionsTestScalarScalarCoupled func_ad; + using func_ad = FunctionsTestScalarScalarCoupled; // Setup the variable components and choose a value at which to // evaluate the tape @@ -191,8 +191,8 @@ test_scalar_scalar_coupled() << "extracted Dpsi (s2): " << dpsi_ds2 << "\n"; // Verify the result - typedef FunctionsTestScalarScalarCoupled func; - static const ScalarNumberType tol = + using func = FunctionsTestScalarScalarCoupled; + static const ScalarNumberType tol = 1e5 * std::numeric_limits::epsilon(); Assert(std::abs(psi - func::psi(s1, s2)) < tol, ExcMessage("No match for function value.")); diff --git a/tests/ad_common_tests/helper_scalar_coupled_2_components_02.h b/tests/ad_common_tests/helper_scalar_coupled_2_components_02.h index 447a06cbcd..df2ca432a0 100644 --- a/tests/ad_common_tests/helper_scalar_coupled_2_components_02.h +++ b/tests/ad_common_tests/helper_scalar_coupled_2_components_02.h @@ -88,9 +88,9 @@ template void test_vector_scalar_coupled() { - typedef AD::ScalarFunction ADHelper; - typedef typename ADHelper::ad_type ADNumberType; - typedef typename ADHelper::scalar_type ScalarNumberType; + using ADHelper = AD::ScalarFunction; + using ADNumberType = typename ADHelper::ad_type; + using ScalarNumberType = typename ADHelper::scalar_type; std::cout << "*** Test variables: Vector + Scalar (coupled), " << "dim = " << Utilities::to_string(dim) << ", " @@ -102,7 +102,7 @@ test_vector_scalar_coupled() FullMatrix D2psi; // Function and its derivatives - typedef FunctionsTestVectorScalarCoupled func_ad; + using func_ad = FunctionsTestVectorScalarCoupled; // Setup the variable components and choose a value at which to // evaluate the tape @@ -196,8 +196,8 @@ test_vector_scalar_coupled() << "extracted Dpsi (s): " << dpsi_ds << "\n"; // Verify the result - typedef FunctionsTestVectorScalarCoupled func; - static const ScalarNumberType tol = + using func = FunctionsTestVectorScalarCoupled; + static const ScalarNumberType tol = 1e5 * std::numeric_limits::epsilon(); Assert(std::abs(psi - func::psi(v, s)) < tol, ExcMessage("No match for function value.")); diff --git a/tests/ad_common_tests/helper_scalar_coupled_2_components_03.h b/tests/ad_common_tests/helper_scalar_coupled_2_components_03.h index fbd91323cc..cc62591697 100644 --- a/tests/ad_common_tests/helper_scalar_coupled_2_components_03.h +++ b/tests/ad_common_tests/helper_scalar_coupled_2_components_03.h @@ -96,9 +96,9 @@ template void test_tensor_scalar_coupled() { - typedef AD::ScalarFunction ADHelper; - typedef typename ADHelper::ad_type ADNumberType; - typedef typename ADHelper::scalar_type ScalarNumberType; + using ADHelper = AD::ScalarFunction; + using ADNumberType = typename ADHelper::ad_type; + using ScalarNumberType = typename ADHelper::scalar_type; std::cout << "*** Test variables: Tensor + Scalar (coupled), " << "dim = " << Utilities::to_string(dim) << ", " @@ -110,7 +110,7 @@ test_tensor_scalar_coupled() FullMatrix D2psi; // Function and its derivatives - typedef FunctionsTestTensorScalarCoupled func_ad; + using func_ad = FunctionsTestTensorScalarCoupled; const FEValuesExtractors::Tensor<2> t_dof(0); const FEValuesExtractors::Scalar s_dof( @@ -206,8 +206,8 @@ test_tensor_scalar_coupled() ; // Verify the result - typedef FunctionsTestTensorScalarCoupled func; - static const ScalarNumberType tol = + using func = FunctionsTestTensorScalarCoupled; + static const ScalarNumberType tol = 1e5 * std::numeric_limits::epsilon(); Assert(std::abs(psi - func::psi(t, s)) < tol, diff --git a/tests/ad_common_tests/helper_scalar_coupled_2_components_04.h b/tests/ad_common_tests/helper_scalar_coupled_2_components_04.h index 8a432352f9..d068e90f72 100644 --- a/tests/ad_common_tests/helper_scalar_coupled_2_components_04.h +++ b/tests/ad_common_tests/helper_scalar_coupled_2_components_04.h @@ -109,9 +109,9 @@ template void test_vector_vector_coupled() { - typedef AD::ScalarFunction ADHelper; - typedef typename ADHelper::ad_type ADNumberType; - typedef typename ADHelper::scalar_type ScalarNumberType; + using ADHelper = AD::ScalarFunction; + using ADNumberType = typename ADHelper::ad_type; + using ScalarNumberType = typename ADHelper::scalar_type; std::cout << "*** Test variables: Vector + Vector (coupled), " << "dim = " << Utilities::to_string(dim) << ", " @@ -123,7 +123,7 @@ test_vector_vector_coupled() FullMatrix D2psi; // Function and its derivatives - typedef FunctionsTestVectorVectorCoupled func_ad; + using func_ad = FunctionsTestVectorVectorCoupled; const FEValuesExtractors::Vector v1_dof(0); const FEValuesExtractors::Vector v2_dof( @@ -218,8 +218,8 @@ test_vector_vector_coupled() << "extracted Dpsi (v2): " << dpsi_dv2 << "\n"; // Verify the result - typedef FunctionsTestVectorVectorCoupled func; - static const ScalarNumberType tol = + using func = FunctionsTestVectorVectorCoupled; + static const ScalarNumberType tol = 1e5 * std::numeric_limits::epsilon(); Assert(std::abs(psi - func::psi(v1, v2)) < tol, diff --git a/tests/ad_common_tests/helper_scalar_coupled_2_components_05.h b/tests/ad_common_tests/helper_scalar_coupled_2_components_05.h index 430f9fab58..07cb80cfee 100644 --- a/tests/ad_common_tests/helper_scalar_coupled_2_components_05.h +++ b/tests/ad_common_tests/helper_scalar_coupled_2_components_05.h @@ -149,9 +149,9 @@ template void test_tensor_vector_coupled() { - typedef AD::ScalarFunction ADHelper; - typedef typename ADHelper::ad_type ADNumberType; - typedef typename ADHelper::scalar_type ScalarNumberType; + using ADHelper = AD::ScalarFunction; + using ADNumberType = typename ADHelper::ad_type; + using ScalarNumberType = typename ADHelper::scalar_type; std::cout << "*** Test variables: Tensor + Vector (coupled), " << "dim = " << Utilities::to_string(dim) << ", " @@ -163,7 +163,7 @@ test_tensor_vector_coupled() FullMatrix D2psi; // Function and its derivatives - typedef FunctionsTestTensorVectorCoupled func_ad; + using func_ad = FunctionsTestTensorVectorCoupled; // Setup the variable components and choose a value at which to // evaluate the tape @@ -263,8 +263,8 @@ test_tensor_vector_coupled() << "extracted Dpsi (v): " << dpsi_dv << "\n"; // Verify the result - typedef FunctionsTestTensorVectorCoupled func; - static const ScalarNumberType tol = + using func = FunctionsTestTensorVectorCoupled; + static const ScalarNumberType tol = 1e5 * std::numeric_limits::epsilon(); std::cout << "dpsi_dt: " << dpsi_dt << std::endl; std::cout << "func::dpsi_dt(t,v): " << func::dpsi_dt(t, v) << std::endl; diff --git a/tests/ad_common_tests/helper_scalar_coupled_2_components_06.h b/tests/ad_common_tests/helper_scalar_coupled_2_components_06.h index bb3cfa849b..0333dabcb0 100644 --- a/tests/ad_common_tests/helper_scalar_coupled_2_components_06.h +++ b/tests/ad_common_tests/helper_scalar_coupled_2_components_06.h @@ -157,9 +157,9 @@ template void test_symmetric_tensor_vector_coupled() { - typedef AD::ScalarFunction ADHelper; - typedef typename ADHelper::ad_type ADNumberType; - typedef typename ADHelper::scalar_type ScalarNumberType; + using ADHelper = AD::ScalarFunction; + using ADNumberType = typename ADHelper::ad_type; + using ScalarNumberType = typename ADHelper::scalar_type; std::cout << "*** Test variables: SymmetricTensor + Vector (coupled), " << "dim = " << Utilities::to_string(dim) << ", " @@ -171,7 +171,7 @@ test_symmetric_tensor_vector_coupled() FullMatrix D2psi; // Function and its derivatives - typedef FunctionsTestSymmetricTensorVectorCoupled func_ad; + using func_ad = FunctionsTestSymmetricTensorVectorCoupled; // Setup the variable components and choose a value at which to // evaluate the tape @@ -271,8 +271,8 @@ test_symmetric_tensor_vector_coupled() << "extracted Dpsi (v): " << dpsi_dv << "\n"; // Verify the result - typedef FunctionsTestSymmetricTensorVectorCoupled func; - static const ScalarNumberType tol = + using func = FunctionsTestSymmetricTensorVectorCoupled; + static const ScalarNumberType tol = 1e5 * std::numeric_limits::epsilon(); std::cout << "dpsi_dt: " << dpsi_dt << std::endl; std::cout << "func::dpsi_dt(t,v): " << func::dpsi_dt(t, v) << std::endl; diff --git a/tests/ad_common_tests/helper_scalar_coupled_2_components_06a.h b/tests/ad_common_tests/helper_scalar_coupled_2_components_06a.h index 6f178471bb..dabcd3b157 100644 --- a/tests/ad_common_tests/helper_scalar_coupled_2_components_06a.h +++ b/tests/ad_common_tests/helper_scalar_coupled_2_components_06a.h @@ -164,9 +164,9 @@ template void test_symmetric_tensor_vector_coupled() { - typedef AD::ScalarFunction ADHelper; - typedef typename ADHelper::ad_type ADNumberType; - typedef typename ADHelper::scalar_type ScalarNumberType; + using ADHelper = AD::ScalarFunction; + using ADNumberType = typename ADHelper::ad_type; + using ScalarNumberType = typename ADHelper::scalar_type; std::cout << "*** Test variables: SymmetricTensor + Vector (coupled), " << "dim = " << Utilities::to_string(dim) << ", " @@ -178,7 +178,7 @@ test_symmetric_tensor_vector_coupled() FullMatrix D2psi; // Function and its derivatives - typedef FunctionsTestSymmetricTensorVectorCoupled func_ad; + using func_ad = FunctionsTestSymmetricTensorVectorCoupled; // Setup the variable components and choose a value at which to // evaluate the tape @@ -278,8 +278,8 @@ test_symmetric_tensor_vector_coupled() << "extracted Dpsi (v): " << dpsi_dv << "\n"; // Verify the result - typedef FunctionsTestSymmetricTensorVectorCoupled func; - static const ScalarNumberType tol = + using func = FunctionsTestSymmetricTensorVectorCoupled; + static const ScalarNumberType tol = 1e5 * std::numeric_limits::epsilon(); std::cout << "dpsi_dt: " << dpsi_dt << std::endl; std::cout << "func::dpsi_dt(t,v): " << func::dpsi_dt(t, v) << std::endl; diff --git a/tests/ad_common_tests/helper_scalar_coupled_2_components_07.h b/tests/ad_common_tests/helper_scalar_coupled_2_components_07.h index 9bfcaea68d..ff9af10bee 100644 --- a/tests/ad_common_tests/helper_scalar_coupled_2_components_07.h +++ b/tests/ad_common_tests/helper_scalar_coupled_2_components_07.h @@ -169,9 +169,9 @@ template void test_symmetric_tensor_tensor_coupled() { - typedef AD::ScalarFunction ADHelper; - typedef typename ADHelper::ad_type ADNumberType; - typedef typename ADHelper::scalar_type ScalarNumberType; + using ADHelper = AD::ScalarFunction; + using ADNumberType = typename ADHelper::ad_type; + using ScalarNumberType = typename ADHelper::scalar_type; std::cout << "*** Test variables: SymmetricTensor + Tensor (coupled), " << "dim = " << Utilities::to_string(dim) << ", " @@ -183,7 +183,7 @@ test_symmetric_tensor_tensor_coupled() FullMatrix D2psi; // Function and its derivatives - typedef FunctionsTestSymmetricTensorTensorCoupled func_ad; + using func_ad = FunctionsTestSymmetricTensorTensorCoupled; // Setup the variable components and choose a value at which to // evaluate the tape @@ -284,8 +284,8 @@ test_symmetric_tensor_tensor_coupled() << "extracted Dpsi (t2): " << dpsi_dt2 << "\n"; // Verify the result - typedef FunctionsTestSymmetricTensorTensorCoupled func; - static const ScalarNumberType tol = + using func = FunctionsTestSymmetricTensorTensorCoupled; + static const ScalarNumberType tol = 1e5 * std::numeric_limits::epsilon(); std::cout << "dpsi_dt1: " << dpsi_dt1 << std::endl; std::cout << "func::dpsi_dt1(t1,t2): " << func::dpsi_dt1(t1, t2) << std::endl; diff --git a/tests/ad_common_tests/helper_scalar_coupled_2_components_08.h b/tests/ad_common_tests/helper_scalar_coupled_2_components_08.h index 3a1a928c5a..ff2c6c02e4 100644 --- a/tests/ad_common_tests/helper_scalar_coupled_2_components_08.h +++ b/tests/ad_common_tests/helper_scalar_coupled_2_components_08.h @@ -139,9 +139,9 @@ template void test_symmetric_tensor_symmetric_tensor_coupled() { - typedef AD::ScalarFunction ADHelper; - typedef typename ADHelper::ad_type ADNumberType; - typedef typename ADHelper::scalar_type ScalarNumberType; + using ADHelper = AD::ScalarFunction; + using ADNumberType = typename ADHelper::ad_type; + using ScalarNumberType = typename ADHelper::scalar_type; std::cout << "*** Test variables: SymmetricTensor + SymmetricTensor (coupled), " @@ -154,8 +154,8 @@ test_symmetric_tensor_symmetric_tensor_coupled() FullMatrix D2psi; // Function and its derivatives - typedef FunctionsTestSymmetricTensorSymmetricTensorCoupled - func_ad; + using func_ad = + FunctionsTestSymmetricTensorSymmetricTensorCoupled; // Setup the variable components and choose a value at which to // evaluate the tape @@ -256,9 +256,8 @@ test_symmetric_tensor_symmetric_tensor_coupled() << "extracted Dpsi (t2): " << dpsi_dt2 << "\n"; // Verify the result - typedef FunctionsTestSymmetricTensorSymmetricTensorCoupled - func; + using func = + FunctionsTestSymmetricTensorSymmetricTensorCoupled; static const ScalarNumberType tol = 1e5 * std::numeric_limits::epsilon(); std::cout << "dpsi_dt1: " << dpsi_dt1 << std::endl; diff --git a/tests/ad_common_tests/helper_scalar_coupled_3_components_01.h b/tests/ad_common_tests/helper_scalar_coupled_3_components_01.h index d1859321dc..00c6cbaed7 100644 --- a/tests/ad_common_tests/helper_scalar_coupled_3_components_01.h +++ b/tests/ad_common_tests/helper_scalar_coupled_3_components_01.h @@ -221,9 +221,9 @@ template void test_tensor_vector_scalar_coupled() { - typedef AD::ScalarFunction ADHelper; - typedef typename ADHelper::ad_type ADNumberType; - typedef typename ADHelper::scalar_type ScalarNumberType; + using ADHelper = AD::ScalarFunction; + using ADNumberType = typename ADHelper::ad_type; + using ScalarNumberType = typename ADHelper::scalar_type; const unsigned int this_mpi_process = Utilities::MPI::this_mpi_process(MPI_COMM_WORLD); @@ -239,7 +239,7 @@ test_tensor_vector_scalar_coupled() FullMatrix D2psi; // Function and its derivatives - typedef FunctionsTestTensorVectorScalarCoupled func_ad; + using func_ad = FunctionsTestTensorVectorScalarCoupled; // Setup the variable components and choose a value at which to // evaluate the tape @@ -354,8 +354,8 @@ test_tensor_vector_scalar_coupled() << "extracted Dpsi (s): " << dpsi_ds << "\n"; // Verify the result - typedef FunctionsTestTensorVectorScalarCoupled func; - static const ScalarNumberType tol = + using func = FunctionsTestTensorVectorScalarCoupled; + static const ScalarNumberType tol = 1e5 * std::numeric_limits::epsilon(); Assert(std::abs(psi - func::psi(t, v, s)) < tol, ExcMessage("No match for function value.")); diff --git a/tests/ad_common_tests/helper_scalar_coupled_3_components_01_tapeless_only.h b/tests/ad_common_tests/helper_scalar_coupled_3_components_01_tapeless_only.h index 9333093d3c..a27b1440cc 100644 --- a/tests/ad_common_tests/helper_scalar_coupled_3_components_01_tapeless_only.h +++ b/tests/ad_common_tests/helper_scalar_coupled_3_components_01_tapeless_only.h @@ -225,9 +225,9 @@ template void test_tensor_vector_scalar_coupled() { - typedef AD::ScalarFunction ADHelper; - typedef typename ADHelper::ad_type ADNumberType; - typedef typename ADHelper::scalar_type ScalarNumberType; + using ADHelper = AD::ScalarFunction; + using ADNumberType = typename ADHelper::ad_type; + using ScalarNumberType = typename ADHelper::scalar_type; const unsigned int this_mpi_process = Utilities::MPI::this_mpi_process(MPI_COMM_WORLD); @@ -243,7 +243,7 @@ test_tensor_vector_scalar_coupled() FullMatrix D2psi; // Function and its derivatives - typedef FunctionsTestTensorVectorScalarCoupled func_ad; + using func_ad = FunctionsTestTensorVectorScalarCoupled; // Setup the variable components and choose a value at which to // evaluate the tape @@ -333,8 +333,8 @@ test_tensor_vector_scalar_coupled() << "extracted Dpsi (s): " << dpsi_ds << "\n"; // Verify the result - typedef FunctionsTestTensorVectorScalarCoupled func; - static const ScalarNumberType tol = + using func = FunctionsTestTensorVectorScalarCoupled; + static const ScalarNumberType tol = 1e5 * std::numeric_limits::epsilon(); Assert(std::abs(psi - func::psi(t, v, s)) < tol, ExcMessage("No match for function value.")); diff --git a/tests/ad_common_tests/helper_scalar_single_component_01.h b/tests/ad_common_tests/helper_scalar_single_component_01.h index 41d37c9f19..b643a253fc 100644 --- a/tests/ad_common_tests/helper_scalar_single_component_01.h +++ b/tests/ad_common_tests/helper_scalar_single_component_01.h @@ -60,9 +60,9 @@ template void test_scalar() { - typedef AD::ScalarFunction ADHelper; - typedef typename ADHelper::ad_type ADNumberType; - typedef typename ADHelper::scalar_type ScalarNumberType; + using ADHelper = AD::ScalarFunction; + using ADNumberType = typename ADHelper::ad_type; + using ScalarNumberType = typename ADHelper::scalar_type; std::cout << "*** Test variables: Scalar dof, " << "dim = " << Utilities::to_string(dim) << ", " @@ -74,7 +74,7 @@ test_scalar() FullMatrix D2psi; // Function and its derivatives - typedef FunctionsTestScalar func_ad; + using func_ad = FunctionsTestScalar; // Setup the variable components and choose a value at which to // evaluate the tape @@ -152,8 +152,8 @@ test_scalar() ad_helper.extract_gradient_component(Dpsi, s_dof); // Verify the result - typedef FunctionsTestScalar func; - static const ScalarNumberType tol = + using func = FunctionsTestScalar; + static const ScalarNumberType tol = 1e5 * std::numeric_limits::epsilon(); std::cout << "psi: " << psi << std::endl; std::cout << "func::psi(s): " << func::psi(s) << std::endl; diff --git a/tests/ad_common_tests/helper_scalar_single_component_02.h b/tests/ad_common_tests/helper_scalar_single_component_02.h index 1d9c450a13..0ea8185607 100644 --- a/tests/ad_common_tests/helper_scalar_single_component_02.h +++ b/tests/ad_common_tests/helper_scalar_single_component_02.h @@ -67,9 +67,9 @@ template void test_vector() { - typedef AD::ScalarFunction ADHelper; - typedef typename ADHelper::ad_type ADNumberType; - typedef typename ADHelper::scalar_type ScalarNumberType; + using ADHelper = AD::ScalarFunction; + using ADNumberType = typename ADHelper::ad_type; + using ScalarNumberType = typename ADHelper::scalar_type; std::cout << "*** Test variables: Vector dof, " << "dim = " << Utilities::to_string(dim) << ", " @@ -81,7 +81,7 @@ test_vector() FullMatrix D2psi; // Function and its derivatives - typedef FunctionsTestVector func_ad; + using func_ad = FunctionsTestVector; // Setup the variable components and choose a value at which to // evaluate the tape @@ -163,8 +163,8 @@ test_vector() ad_helper.extract_gradient_component(Dpsi, v_dof); // Verify the result - typedef FunctionsTestVector func; - static const ScalarNumberType tol = + using func = FunctionsTestVector; + static const ScalarNumberType tol = 1e5 * std::numeric_limits::epsilon(); std::cout << "psi: " << psi << std::endl; std::cout << "func::psi(v): " << func::psi(v) << std::endl; diff --git a/tests/ad_common_tests/helper_scalar_single_component_03.h b/tests/ad_common_tests/helper_scalar_single_component_03.h index 34661693da..ae93460bd6 100644 --- a/tests/ad_common_tests/helper_scalar_single_component_03.h +++ b/tests/ad_common_tests/helper_scalar_single_component_03.h @@ -77,9 +77,9 @@ template void test_tensor() { - typedef AD::ScalarFunction ADHelper; - typedef typename ADHelper::ad_type ADNumberType; - typedef typename ADHelper::scalar_type ScalarNumberType; + using ADHelper = AD::ScalarFunction; + using ADNumberType = typename ADHelper::ad_type; + using ScalarNumberType = typename ADHelper::scalar_type; std::cout << "*** Test variables: Tensor dof, " << "dim = " << Utilities::to_string(dim) << ", " @@ -91,7 +91,7 @@ test_tensor() FullMatrix D2psi; // Function and its derivatives - typedef FunctionsTestTensor func_ad; + using func_ad = FunctionsTestTensor; // Setup the variable components and choose a value at which to // evaluate the tape @@ -174,8 +174,8 @@ test_tensor() ad_helper.extract_gradient_component(Dpsi, t_dof); // Verify the result - typedef FunctionsTestTensor func; - static const ScalarNumberType tol = + using func = FunctionsTestTensor; + static const ScalarNumberType tol = 1e5 * std::numeric_limits::epsilon(); std::cout << "psi: " << psi << std::endl; std::cout << "func::psi(t): " << func::psi(t) << std::endl; diff --git a/tests/ad_common_tests/helper_scalar_single_component_04.h b/tests/ad_common_tests/helper_scalar_single_component_04.h index 11d16322f2..88bdf91737 100644 --- a/tests/ad_common_tests/helper_scalar_single_component_04.h +++ b/tests/ad_common_tests/helper_scalar_single_component_04.h @@ -80,9 +80,9 @@ template void test_symmetric_tensor() { - typedef AD::ScalarFunction ADHelper; - typedef typename ADHelper::ad_type ADNumberType; - typedef typename ADHelper::scalar_type ScalarNumberType; + using ADHelper = AD::ScalarFunction; + using ADNumberType = typename ADHelper::ad_type; + using ScalarNumberType = typename ADHelper::scalar_type; std::cout << "*** Test variables: SymmetricTensor dof, " << "dim = " << Utilities::to_string(dim) << ", " @@ -94,7 +94,7 @@ test_symmetric_tensor() FullMatrix D2psi; // Function and its derivatives - typedef FunctionsTestSymmetricTensor func_ad; + using func_ad = FunctionsTestSymmetricTensor; // Setup the variable components and choose a value at which to // evaluate the tape @@ -178,8 +178,8 @@ test_symmetric_tensor() ad_helper.extract_gradient_component(Dpsi, t_dof); // Verify the result - typedef FunctionsTestSymmetricTensor func; - static const ScalarNumberType tol = + using func = FunctionsTestSymmetricTensor; + static const ScalarNumberType tol = 1e5 * std::numeric_limits::epsilon(); std::cout << "psi: " << psi << std::endl; std::cout << "func::psi(t): " << func::psi(t) << std::endl; diff --git a/tests/ad_common_tests/helper_vector_1_indep_1_dep_vars_01.h b/tests/ad_common_tests/helper_vector_1_indep_1_dep_vars_01.h index a95c4bb2a1..94eb17f0e7 100644 --- a/tests/ad_common_tests/helper_vector_1_indep_1_dep_vars_01.h +++ b/tests/ad_common_tests/helper_vector_1_indep_1_dep_vars_01.h @@ -56,16 +56,16 @@ template void test_AD_vector_jacobian() { - typedef AD::VectorFunction ADHelper; - typedef typename ADHelper::ad_type ADNumberType; - typedef typename ADHelper::scalar_type ScalarNumberType; + using ADHelper = AD::VectorFunction; + using ADNumberType = typename ADHelper::ad_type; + using ScalarNumberType = typename ADHelper::scalar_type; std::cout << "*** Test variables: Variables: 1 independent, 1 dependent, " << "dim = " << Utilities::to_string(dim) << ", " << "Type code: " << static_cast(ad_type_code) << std::endl; // Function and its derivatives - typedef FunctionsTestScalar func_ad; + using func_ad = FunctionsTestScalar; // Setup the variable components and choose a value at which to // evaluate the tape @@ -143,8 +143,8 @@ test_AD_vector_jacobian() Dfuncs.print_formatted(std::cout, 3, true, 0, "0.0"); // Verify the result - typedef FunctionsTestScalar func; - static const ScalarNumberType tol = + using func = FunctionsTestScalar; + static const ScalarNumberType tol = 1e5 * std::numeric_limits::epsilon(); std::cout << "funcs[0]: " << funcs[0] << "\t func::f0(s[0])): " << func::f0(s[0]) << std::endl; diff --git a/tests/ad_common_tests/helper_vector_1_indep_2_dep_vars_01.h b/tests/ad_common_tests/helper_vector_1_indep_2_dep_vars_01.h index fba99f1549..223a407fe3 100644 --- a/tests/ad_common_tests/helper_vector_1_indep_2_dep_vars_01.h +++ b/tests/ad_common_tests/helper_vector_1_indep_2_dep_vars_01.h @@ -68,16 +68,16 @@ template void test_AD_vector_jacobian() { - typedef AD::VectorFunction ADHelper; - typedef typename ADHelper::ad_type ADNumberType; - typedef typename ADHelper::scalar_type ScalarNumberType; + using ADHelper = AD::VectorFunction; + using ADNumberType = typename ADHelper::ad_type; + using ScalarNumberType = typename ADHelper::scalar_type; std::cout << "*** Test variables: Variables: 1 independent, 2 dependent, " << "dim = " << Utilities::to_string(dim) << ", " << "Type code: " << static_cast(ad_type_code) << std::endl; // Function and its derivatives - typedef FunctionsTestSquare func_ad; + using func_ad = FunctionsTestSquare; // Setup the variable components and choose a value at which to // evaluate the tape @@ -155,8 +155,8 @@ test_AD_vector_jacobian() Dfuncs.print_formatted(std::cout, 3, true, 0, "0.0"); // Verify the result - typedef FunctionsTestSquare func; - static const ScalarNumberType tol = + using func = FunctionsTestSquare; + static const ScalarNumberType tol = 1e5 * std::numeric_limits::epsilon(); std::cout << "funcs[0]: " << funcs[0] << "\t func::f0(s[0])): " << func::f0(s[0]) << std::endl; diff --git a/tests/ad_common_tests/helper_vector_2_indep_1_dep_vars_01.h b/tests/ad_common_tests/helper_vector_2_indep_1_dep_vars_01.h index 43ce745d5e..ee0c1dae4a 100644 --- a/tests/ad_common_tests/helper_vector_2_indep_1_dep_vars_01.h +++ b/tests/ad_common_tests/helper_vector_2_indep_1_dep_vars_01.h @@ -62,16 +62,16 @@ template void test_AD_vector_jacobian() { - typedef AD::VectorFunction ADHelper; - typedef typename ADHelper::ad_type ADNumberType; - typedef typename ADHelper::scalar_type ScalarNumberType; + using ADHelper = AD::VectorFunction; + using ADNumberType = typename ADHelper::ad_type; + using ScalarNumberType = typename ADHelper::scalar_type; std::cout << "*** Test variables: Variables: 2 independent, 1 dependent, " << "dim = " << Utilities::to_string(dim) << ", " << "Type code: " << static_cast(ad_type_code) << std::endl; // Function and its derivatives - typedef FunctionsTestSquare func_ad; + using func_ad = FunctionsTestSquare; // Setup the variable components and choose a value at which to // evaluate the tape @@ -150,8 +150,8 @@ test_AD_vector_jacobian() Dfuncs.print_formatted(std::cout, 3, true, 0, "0.0"); // Verify the result - typedef FunctionsTestSquare func; - static const ScalarNumberType tol = + using func = FunctionsTestSquare; + static const ScalarNumberType tol = 1e5 * std::numeric_limits::epsilon(); std::cout << "funcs[0]: " << funcs[0] << "\t func::f0(s[0],s[1])): " << func::f0(s[0], s[1]) << std::endl; diff --git a/tests/ad_common_tests/helper_vector_2_indep_2_dep_vars_01.h b/tests/ad_common_tests/helper_vector_2_indep_2_dep_vars_01.h index 4ce3c01ba5..4bd6f7203f 100644 --- a/tests/ad_common_tests/helper_vector_2_indep_2_dep_vars_01.h +++ b/tests/ad_common_tests/helper_vector_2_indep_2_dep_vars_01.h @@ -80,16 +80,16 @@ template void test_AD_vector_jacobian() { - typedef AD::VectorFunction ADHelper; - typedef typename ADHelper::ad_type ADNumberType; - typedef typename ADHelper::scalar_type ScalarNumberType; + using ADHelper = AD::VectorFunction; + using ADNumberType = typename ADHelper::ad_type; + using ScalarNumberType = typename ADHelper::scalar_type; std::cout << "*** Test variables: Variables: 2 independent, 2 dependent, " << "dim = " << Utilities::to_string(dim) << ", " << "Type code: " << static_cast(ad_type_code) << std::endl; // Function and its derivatives - typedef FunctionsTestSquare func_ad; + using func_ad = FunctionsTestSquare; // Setup the variable components and choose a value at which to // evaluate the tape @@ -169,8 +169,8 @@ test_AD_vector_jacobian() Dfuncs.print_formatted(std::cout, 3, true, 0, "0.0"); // Verify the result - typedef FunctionsTestSquare func; - static const ScalarNumberType tol = + using func = FunctionsTestSquare; + static const ScalarNumberType tol = 1e5 * std::numeric_limits::epsilon(); std::cout << "funcs[0]: " << funcs[0] << "\t func::f0(s[0],s[1])): " << func::f0(s[0], s[1]) << std::endl; diff --git a/tests/ad_common_tests/physics_functions_01.h b/tests/ad_common_tests/physics_functions_01.h index ffb9a8584e..9b53e6f07b 100644 --- a/tests/ad_common_tests/physics_functions_01.h +++ b/tests/ad_common_tests/physics_functions_01.h @@ -36,8 +36,8 @@ template void test_physics() { - typedef - typename AD::NumberTraits::ad_type ADNumberType; + using ADNumberType = + typename AD::NumberTraits::ad_type; std::cout << "*** Test physics functions: Kinematics, " << "dim = " << Utilities::to_string(dim) << ", " diff --git a/tests/ad_common_tests/physics_functions_02.h b/tests/ad_common_tests/physics_functions_02.h index 4581e4f550..3507e38881 100644 --- a/tests/ad_common_tests/physics_functions_02.h +++ b/tests/ad_common_tests/physics_functions_02.h @@ -37,8 +37,8 @@ template void test_physics() { - typedef - typename AD::NumberTraits::ad_type ADNumberType; + using ADNumberType = + typename AD::NumberTraits::ad_type; std::cout << "*** Test physics functions: Standard tensors, " << "dim = " << Utilities::to_string(dim) << ", " diff --git a/tests/ad_common_tests/physics_functions_03.h b/tests/ad_common_tests/physics_functions_03.h index cb67d507d6..9acf932dcb 100644 --- a/tests/ad_common_tests/physics_functions_03.h +++ b/tests/ad_common_tests/physics_functions_03.h @@ -37,8 +37,8 @@ template void test_physics() { - typedef - typename AD::NumberTraits::ad_type ADNumberType; + using ADNumberType = + typename AD::NumberTraits::ad_type; std::cout << "*** Test physics functions: Standard tensors, " << "dim = " << Utilities::to_string(dim) << ", " diff --git a/tests/ad_common_tests/step-44-helper_res_lin_01.h b/tests/ad_common_tests/step-44-helper_res_lin_01.h index 1ec0a5903b..3bdcfe12e3 100644 --- a/tests/ad_common_tests/step-44-helper_res_lin_01.h +++ b/tests/ad_common_tests/step-44-helper_res_lin_01.h @@ -1191,8 +1191,8 @@ namespace Step44 Assert(n_dependent_variables == n_independent_variables, ExcMessage("Expect square system.")); - typedef AD::ResidualLinearization ADHelper; - typedef typename ADHelper::ad_type ADNumberType; + using ADHelper = AD::ResidualLinearization; + using ADNumberType = typename ADHelper::ad_type; ADHelper ad_helper(n_independent_variables, n_dependent_variables); ad_helper.set_tape_buffer_sizes(); // Increase the buffer size from the // default values diff --git a/tests/ad_common_tests/step-44-helper_scalar_01.h b/tests/ad_common_tests/step-44-helper_scalar_01.h index e643e8e18f..31eb6320f1 100644 --- a/tests/ad_common_tests/step-44-helper_scalar_01.h +++ b/tests/ad_common_tests/step-44-helper_scalar_01.h @@ -578,8 +578,8 @@ namespace Step44 const unsigned int n_independent_variables = SymmetricTensor<2, dim>::n_independent_components + 1 + 1; - typedef AD::ScalarFunction ADHelper; - typedef typename ADHelper::ad_type ADNumberType; + using ADHelper = AD::ScalarFunction; + using ADNumberType = typename ADHelper::ad_type; ADHelper ad_helper(n_independent_variables); ad_helper.set_tape_buffer_sizes(); // Increase the buffer size from the // default values @@ -663,8 +663,8 @@ namespace Step44 const FEValuesExtractors::Scalar J_dofs(0); const unsigned int n_independent_variables = 1; - typedef typename AD::ScalarFunction::ad_type - ADNumberType; + using ADNumberType = + typename AD::ScalarFunction::ad_type; AD::ScalarFunction ad_helper( n_independent_variables); ad_helper.set_tape_buffer_sizes(); // Increase the buffer size from the diff --git a/tests/ad_common_tests/step-44-helper_var_form_01.h b/tests/ad_common_tests/step-44-helper_var_form_01.h index f3e25ab0cd..f7484785f1 100644 --- a/tests/ad_common_tests/step-44-helper_var_form_01.h +++ b/tests/ad_common_tests/step-44-helper_var_form_01.h @@ -1154,8 +1154,8 @@ namespace Step44 const unsigned int n_independent_variables = data.local_dof_indices.size(); - typedef AD::EnergyFunctional ADHelper; - typedef typename ADHelper::ad_type ADNumberType; + using ADHelper = AD::EnergyFunctional; + using ADNumberType = typename ADHelper::ad_type; ADHelper ad_helper(n_independent_variables); ad_helper.set_tape_buffer_sizes(); // Increase the buffer size from the // default values diff --git a/tests/ad_common_tests/step-44-helper_vector_01.h b/tests/ad_common_tests/step-44-helper_vector_01.h index 4907f3caf9..73ce42fc22 100644 --- a/tests/ad_common_tests/step-44-helper_vector_01.h +++ b/tests/ad_common_tests/step-44-helper_vector_01.h @@ -1193,8 +1193,8 @@ namespace Step44 Assert(n_dependent_variables == n_independent_variables, ExcMessage("Expect square system.")); - typedef AD::VectorFunction ADHelper; - typedef typename ADHelper::ad_type ADNumberType; + using ADHelper = AD::VectorFunction; + using ADNumberType = typename ADHelper::ad_type; ADHelper ad_helper(n_independent_variables, n_dependent_variables); ad_helper.set_tape_buffer_sizes(); // Increase the buffer size from the // default values diff --git a/tests/ad_common_tests/symmetric_tensor_functions_01.h b/tests/ad_common_tests/symmetric_tensor_functions_01.h index fe0dea4bf3..89f0d0d9b2 100644 --- a/tests/ad_common_tests/symmetric_tensor_functions_01.h +++ b/tests/ad_common_tests/symmetric_tensor_functions_01.h @@ -33,8 +33,8 @@ template void test_symmetric_tensor() { - typedef - typename AD::NumberTraits::ad_type ADNumberType; + using ADNumberType = + typename AD::NumberTraits::ad_type; std::cout << "*** Test SymmetricTensor functions, " << "dim = " << Utilities::to_string(dim) << ", " diff --git a/tests/ad_common_tests/symmetric_tensor_functions_02.h b/tests/ad_common_tests/symmetric_tensor_functions_02.h index 2d150e47af..0e2bc7a8c2 100644 --- a/tests/ad_common_tests/symmetric_tensor_functions_02.h +++ b/tests/ad_common_tests/symmetric_tensor_functions_02.h @@ -98,9 +98,9 @@ template void test_symmetric_tensor() { - typedef AD::ScalarFunction ADHelper; - typedef typename ADHelper::ad_type ADNumberType; - typedef typename ADHelper::scalar_type ScalarNumberType; + using ADHelper = AD::ScalarFunction; + using ADNumberType = typename ADHelper::ad_type; + using ScalarNumberType = typename ADHelper::scalar_type; std::cout << "*** dim = " << Utilities::to_string(dim) << ", " << "Type code: " << static_cast(ad_type_code) << std::endl; @@ -115,7 +115,7 @@ test_symmetric_tensor() FullMatrix D2psi; // Function and its derivatives - typedef FunctionsTestSymmetricTensor func_ad; + using func_ad = FunctionsTestSymmetricTensor; // Setup the variable components and choose a value at which to // evaluate the tape @@ -199,8 +199,8 @@ test_symmetric_tensor() ad_helper.extract_gradient_component(Dpsi, t_dof); // Verify the result - typedef FunctionsTestSymmetricTensor func; - static const ScalarNumberType tol = + using func = FunctionsTestSymmetricTensor; + static const ScalarNumberType tol = 1e5 * std::numeric_limits::epsilon(); std::cout << "psi: " << psi << std::endl; std::cout << "func::psi(t): " << func::psi(t) << std::endl; diff --git a/tests/ad_common_tests/symmetric_tensor_functions_03.h b/tests/ad_common_tests/symmetric_tensor_functions_03.h index d6d013c061..b020c87233 100644 --- a/tests/ad_common_tests/symmetric_tensor_functions_03.h +++ b/tests/ad_common_tests/symmetric_tensor_functions_03.h @@ -122,9 +122,9 @@ template void test_NH(const bool nontrivial_initial_values) { - typedef AD::ScalarFunction ADHelper; - typedef typename ADHelper::ad_type ADNumberType; - typedef typename ADHelper::scalar_type ScalarNumberType; + using ADHelper = AD::ScalarFunction; + using ADNumberType = typename ADHelper::ad_type; + using ScalarNumberType = typename ADHelper::scalar_type; std::cout << "*** Standard definition of incompressible NeoHookean material, " << "dim = " << Utilities::to_string(dim) << ", " @@ -138,7 +138,7 @@ test_NH(const bool nontrivial_initial_values) FullMatrix D2psi; // Function and its derivatives - typedef IncompressibleNeoHookean func_ad; + using func_ad = IncompressibleNeoHookean; // Setup the variable components and choose a value at which to // evaluate the tape @@ -223,8 +223,8 @@ test_NH(const bool nontrivial_initial_values) ad_helper.extract_gradient_component(Dpsi, C_dof); // Verify the result - typedef IncompressibleNeoHookean func; - static const ScalarNumberType tol = + using func = IncompressibleNeoHookean; + static const ScalarNumberType tol = 1e5 * std::numeric_limits::epsilon(); std::cout << "psi: " << psi << std::endl; std::cout << "func::psi(C): " << func::psi(C) << std::endl; @@ -255,9 +255,9 @@ void test_NH_eigen_energy(const enum SymmetricTensorEigenvectorMethod method, const bool nontrivial_initial_values) { - typedef AD::ScalarFunction ADHelper; - typedef typename ADHelper::ad_type ADNumberType; - typedef typename ADHelper::scalar_type ScalarNumberType; + using ADHelper = AD::ScalarFunction; + using ADNumberType = typename ADHelper::ad_type; + using ScalarNumberType = typename ADHelper::scalar_type; std::cout << "*** Principal stretch definition of incompressible NeoHookean material (from free energy function), " @@ -273,7 +273,7 @@ test_NH_eigen_energy(const enum SymmetricTensorEigenvectorMethod method, FullMatrix D2psi; // Function and its derivatives - typedef IncompressibleNeoHookeanPrincipalStretches func_ad; + using func_ad = IncompressibleNeoHookeanPrincipalStretches; // Setup the variable components and choose a value at which to // evaluate the tape @@ -359,8 +359,8 @@ test_NH_eigen_energy(const enum SymmetricTensorEigenvectorMethod method, ad_helper.extract_gradient_component(Dpsi, C_dof); // Verify the result - typedef IncompressibleNeoHookean func; - static const ScalarNumberType tol_val = + using func = IncompressibleNeoHookean; + static const ScalarNumberType tol_val = (nontrivial_initial_values ? 1e-6 : 1e5 * std::numeric_limits::epsilon()); diff --git a/tests/ad_common_tests/symmetric_tensor_functions_04.h b/tests/ad_common_tests/symmetric_tensor_functions_04.h index 06026b1dc0..11e83915b9 100644 --- a/tests/ad_common_tests/symmetric_tensor_functions_04.h +++ b/tests/ad_common_tests/symmetric_tensor_functions_04.h @@ -123,9 +123,9 @@ template void test_NH(const bool nontrivial_initial_values) { - typedef AD::ScalarFunction ADHelper; - typedef typename ADHelper::ad_type ADNumberType; - typedef typename ADHelper::scalar_type ScalarNumberType; + using ADHelper = AD::ScalarFunction; + using ADNumberType = typename ADHelper::ad_type; + using ScalarNumberType = typename ADHelper::scalar_type; std::cout << "*** Standard definition of incompressible NeoHookean material, " << "dim = " << Utilities::to_string(dim) << ", " @@ -139,7 +139,7 @@ test_NH(const bool nontrivial_initial_values) FullMatrix D2psi; // Function and its derivatives - typedef IncompressibleNeoHookean func_ad; + using func_ad = IncompressibleNeoHookean; // Setup the variable components and choose a value at which to // evaluate the tape @@ -224,8 +224,8 @@ test_NH(const bool nontrivial_initial_values) ad_helper.extract_gradient_component(Dpsi, C_dof); // Verify the result - typedef IncompressibleNeoHookean func; - static const ScalarNumberType tol = + using func = IncompressibleNeoHookean; + static const ScalarNumberType tol = 1e5 * std::numeric_limits::epsilon(); std::cout << "psi: " << psi << std::endl; std::cout << "func::psi(C): " << func::psi(C) << std::endl; @@ -256,9 +256,9 @@ void test_NH_eigen_stress(const enum SymmetricTensorEigenvectorMethod method, const bool nontrivial_initial_values) { - typedef AD::VectorFunction ADHelper; - typedef typename ADHelper::ad_type ADNumberType; - typedef typename ADHelper::scalar_type ScalarNumberType; + using ADHelper = AD::VectorFunction; + using ADNumberType = typename ADHelper::ad_type; + using ScalarNumberType = typename ADHelper::scalar_type; std::cout << "*** Principal stretch definition of incompressible NeoHookean material (from stress), " @@ -274,7 +274,7 @@ test_NH_eigen_stress(const enum SymmetricTensorEigenvectorMethod method, FullMatrix D2psi; // Function and its derivatives - typedef IncompressibleNeoHookeanPrincipalStretches func_ad; + using func_ad = IncompressibleNeoHookeanPrincipalStretches; // Setup the variable components and choose a value at which to // evaluate the tape @@ -368,8 +368,8 @@ test_NH_eigen_stress(const enum SymmetricTensorEigenvectorMethod method, ad_helper.extract_value_component(Dpsi, C_dof); // Verify the result - typedef IncompressibleNeoHookean func; - static const ScalarNumberType tol_val = + using func = IncompressibleNeoHookean; + static const ScalarNumberType tol_val = (nontrivial_initial_values ? 1e-4 : 1e6 * std::numeric_limits::epsilon()); diff --git a/tests/ad_common_tests/tensor_functions_01.h b/tests/ad_common_tests/tensor_functions_01.h index 57d172dfb4..224e3857cc 100644 --- a/tests/ad_common_tests/tensor_functions_01.h +++ b/tests/ad_common_tests/tensor_functions_01.h @@ -32,8 +32,8 @@ template void test_tensor() { - typedef - typename AD::NumberTraits::ad_type ADNumberType; + using ADNumberType = + typename AD::NumberTraits::ad_type; std::cout << "*** Test Tensor functions, " << "dim = " << Utilities::to_string(dim) << ", " diff --git a/tests/ad_common_tests/tensor_functions_02.h b/tests/ad_common_tests/tensor_functions_02.h index a4da116885..6c3c74e5e7 100644 --- a/tests/ad_common_tests/tensor_functions_02.h +++ b/tests/ad_common_tests/tensor_functions_02.h @@ -93,9 +93,9 @@ template void test_tensor() { - typedef AD::ScalarFunction ADHelper; - typedef typename ADHelper::ad_type ADNumberType; - typedef typename ADHelper::scalar_type ScalarNumberType; + using ADHelper = AD::ScalarFunction; + using ADNumberType = typename ADHelper::ad_type; + using ScalarNumberType = typename ADHelper::scalar_type; std::cout << "*** dim = " << Utilities::to_string(dim) << ", " << "Type code: " << static_cast(ad_type_code) << std::endl; @@ -110,7 +110,7 @@ test_tensor() FullMatrix D2psi; // Function and its derivatives - typedef FunctionsTestTensor func_ad; + using func_ad = FunctionsTestTensor; // Setup the variable components and choose a value at which to // evaluate the tape @@ -193,8 +193,8 @@ test_tensor() ad_helper.extract_gradient_component(Dpsi, t_dof); // Verify the result - typedef FunctionsTestTensor func; - static const ScalarNumberType tol = + using func = FunctionsTestTensor; + static const ScalarNumberType tol = 1e5 * std::numeric_limits::epsilon(); std::cout << "psi: " << psi << std::endl; std::cout << "func::psi(t): " << func::psi(t) << std::endl; diff --git a/tests/adolc/helper_retaping_01.cc b/tests/adolc/helper_retaping_01.cc index 64db8b3dca..fbd4472e80 100644 --- a/tests/adolc/helper_retaping_01.cc +++ b/tests/adolc/helper_retaping_01.cc @@ -97,9 +97,9 @@ test_scalar_scalar_coupled_one_run(const number_t s1, const number_t s2, const bool overwrite_tape) { - typedef AD::ScalarFunction ADHelper; - typedef typename ADHelper::ad_type ADNumberType; - typedef typename ADHelper::scalar_type ScalarNumberType; + using ADHelper = AD::ScalarFunction; + using ADNumberType = typename ADHelper::ad_type; + using ScalarNumberType = typename ADHelper::scalar_type; std::cout << "*** Test variables: Scalar + Scalar (coupled), " << "dim = " << Utilities::to_string(dim) << ", " @@ -113,7 +113,7 @@ test_scalar_scalar_coupled_one_run(const number_t s1, FullMatrix D2psi; // Function and its derivatives - typedef FunctionsTestScalarScalarCoupled func_ad; + using func_ad = FunctionsTestScalarScalarCoupled; // Setup the variable components and choose a value at which to // evaluate the tape @@ -194,8 +194,8 @@ test_scalar_scalar_coupled_one_run(const number_t s1, << "extracted Dpsi (s2): " << dpsi_ds2 << "\n"; // Verify the result - typedef FunctionsTestScalarScalarCoupled func; - static const ScalarNumberType tol = + using func = FunctionsTestScalarScalarCoupled; + static const ScalarNumberType tol = 1e8 * std::numeric_limits::epsilon(); std::cout << "dpsi_ds1: " << dpsi_ds1 << std::endl; std::cout << "func::dpsi_ds1(s1,s2): " << func::dpsi_ds1(s1, s2) << std::endl; diff --git a/tests/adolc/helper_retaping_02.cc b/tests/adolc/helper_retaping_02.cc index b0d093ea33..5b16cb4a8a 100644 --- a/tests/adolc/helper_retaping_02.cc +++ b/tests/adolc/helper_retaping_02.cc @@ -97,9 +97,9 @@ test_scalar_scalar_coupled_one_run(const number_t s1, const number_t s2, const bool overwrite_tape) { - typedef AD::ScalarFunction ADHelper; - typedef typename ADHelper::ad_type ADNumberType; - typedef typename ADHelper::scalar_type ScalarNumberType; + using ADHelper = AD::ScalarFunction; + using ADNumberType = typename ADHelper::ad_type; + using ScalarNumberType = typename ADHelper::scalar_type; std::cout << "*** Test variables: Scalar + Scalar (coupled), " << "dim = " << Utilities::to_string(dim) << ", " @@ -113,7 +113,7 @@ test_scalar_scalar_coupled_one_run(const number_t s1, FullMatrix D2psi; // Function and its derivatives - typedef FunctionsTestScalarScalarCoupled func_ad; + using func_ad = FunctionsTestScalarScalarCoupled; // Setup the variable components and choose a value at which to // evaluate the tape @@ -197,8 +197,8 @@ test_scalar_scalar_coupled_one_run(const number_t s1, << "extracted Dpsi (s2): " << dpsi_ds2 << "\n"; // Verify the result - typedef FunctionsTestScalarScalarCoupled func; - static const ScalarNumberType tol = + using func = FunctionsTestScalarScalarCoupled; + static const ScalarNumberType tol = 1e8 * std::numeric_limits::epsilon(); std::cout << "dpsi_ds1: " << dpsi_ds1 << std::endl; std::cout << "func::dpsi_ds1(s1,s2): " << func::dpsi_ds1(s1, s2) << std::endl; diff --git a/tests/adolc/helper_retaping_03.cc b/tests/adolc/helper_retaping_03.cc index 97e746a304..a20f08f40e 100644 --- a/tests/adolc/helper_retaping_03.cc +++ b/tests/adolc/helper_retaping_03.cc @@ -96,9 +96,9 @@ test_scalar_scalar_coupled_one_run(const number_t s1, const number_t s2, const bool clear_tapes) { - typedef AD::ScalarFunction ADHelper; - typedef typename ADHelper::ad_type ADNumberType; - typedef typename ADHelper::scalar_type ScalarNumberType; + using ADHelper = AD::ScalarFunction; + using ADNumberType = typename ADHelper::ad_type; + using ScalarNumberType = typename ADHelper::scalar_type; std::cout << "*** Test variables: Scalar + Scalar (coupled), " << "dim = " << Utilities::to_string(dim) << ", " @@ -111,7 +111,7 @@ test_scalar_scalar_coupled_one_run(const number_t s1, FullMatrix D2psi; // Function and its derivatives - typedef FunctionsTestScalarScalarCoupled func_ad; + using func_ad = FunctionsTestScalarScalarCoupled; // Setup the variable components and choose a value at which to // evaluate the tape @@ -200,8 +200,8 @@ test_scalar_scalar_coupled_one_run(const number_t s1, << "extracted Dpsi (s2): " << dpsi_ds2 << "\n"; // Verify the result - typedef FunctionsTestScalarScalarCoupled func; - static const ScalarNumberType tol = + using func = FunctionsTestScalarScalarCoupled; + static const ScalarNumberType tol = 1e8 * std::numeric_limits::epsilon(); std::cout << "dpsi_ds1: " << dpsi_ds1 << std::endl; std::cout << "func::dpsi_ds1(s1,s2): " << func::dpsi_ds1(s1, s2) << std::endl; diff --git a/tests/adolc/helper_scalar_failure_01.cc b/tests/adolc/helper_scalar_failure_01.cc index 7629711e68..c3fbb39b9c 100644 --- a/tests/adolc/helper_scalar_failure_01.cc +++ b/tests/adolc/helper_scalar_failure_01.cc @@ -39,8 +39,8 @@ template bool test_overlapping_ind_var_components() { - typedef AD::ScalarFunction ADHelper; - typedef typename ADHelper::ad_type ADNumberType; + using ADHelper = AD::ScalarFunction; + using ADNumberType = typename ADHelper::ad_type; std::cout << "*** Test variables: Scalar + Scalar (coupled), " << (AD::ADNumberTraits::is_taped == true ? "Taped" : diff --git a/tests/adolc/helper_scalar_failure_02.cc b/tests/adolc/helper_scalar_failure_02.cc index ec3ddbd827..65c7854598 100644 --- a/tests/adolc/helper_scalar_failure_02.cc +++ b/tests/adolc/helper_scalar_failure_02.cc @@ -39,8 +39,8 @@ template bool test_overlapping_ind_var_components() { - typedef AD::ScalarFunction ADHelper; - typedef typename ADHelper::ad_type ADNumberType; + using ADHelper = AD::ScalarFunction; + using ADNumberType = typename ADHelper::ad_type; std::cout << "*** Test variables: Vector + Scalar (coupled), " << (AD::ADNumberTraits::is_taped == true ? "Taped" : diff --git a/tests/adolc/helper_scalar_failure_03.cc b/tests/adolc/helper_scalar_failure_03.cc index f0c1d33428..1a55a4bc21 100644 --- a/tests/adolc/helper_scalar_failure_03.cc +++ b/tests/adolc/helper_scalar_failure_03.cc @@ -38,8 +38,8 @@ template bool test_overlapping_ind_var_components() { - typedef AD::ScalarFunction ADHelper; - typedef typename ADHelper::ad_type ADNumberType; + using ADHelper = AD::ScalarFunction; + using ADNumberType = typename ADHelper::ad_type; std::cout << "*** Test variables: Tensor + Vector (coupled), " << (AD::ADNumberTraits::is_taped == true ? "Taped" : diff --git a/tests/adolc/helper_scalar_failure_04.cc b/tests/adolc/helper_scalar_failure_04.cc index 0f4ce829a0..b36d7e8dd4 100644 --- a/tests/adolc/helper_scalar_failure_04.cc +++ b/tests/adolc/helper_scalar_failure_04.cc @@ -39,8 +39,8 @@ template bool test_incorrect_no_of_ind_vars() { - typedef AD::ScalarFunction ADHelper; - typedef typename ADHelper::ad_type ADNumberType; + using ADHelper = AD::ScalarFunction; + using ADNumberType = typename ADHelper::ad_type; std::cout << "*** Test variables: Scalar + Scalar (coupled), " << (AD::ADNumberTraits::is_taped == true ? "Taped" : diff --git a/tests/adolc/helper_scalar_failure_05.cc b/tests/adolc/helper_scalar_failure_05.cc index b0e9047951..d65d70929f 100644 --- a/tests/adolc/helper_scalar_failure_05.cc +++ b/tests/adolc/helper_scalar_failure_05.cc @@ -40,8 +40,8 @@ template bool test_register_multiple_dep_vars() { - typedef AD::ScalarFunction ADHelper; - typedef typename ADHelper::ad_type ADNumberType; + using ADHelper = AD::ScalarFunction; + using ADNumberType = typename ADHelper::ad_type; std::cout << "*** Test variables: Scalar + Scalar (coupled), " << (AD::ADNumberTraits::is_taped == true ? "Taped" : diff --git a/tests/adolc/helper_tape_index_01.cc b/tests/adolc/helper_tape_index_01.cc index bae7cd9d99..bebbedf457 100644 --- a/tests/adolc/helper_tape_index_01.cc +++ b/tests/adolc/helper_tape_index_01.cc @@ -92,9 +92,9 @@ test_scalar_scalar_coupled_one_run(const number_t s1, const number_t s2, const tape_index_t tape_no) { - typedef AD::ScalarFunction ADHelper; - typedef typename ADHelper::ad_type ADNumberType; - typedef typename ADHelper::scalar_type ScalarNumberType; + using ADHelper = AD::ScalarFunction; + using ADNumberType = typename ADHelper::ad_type; + using ScalarNumberType = typename ADHelper::scalar_type; std::cout // << "*** Test variables: Scalar + Scalar (coupled), " @@ -108,7 +108,7 @@ test_scalar_scalar_coupled_one_run(const number_t s1, FullMatrix D2psi; // Function and its derivatives - typedef FunctionsTestScalarScalarCoupled func_ad; + using func_ad = FunctionsTestScalarScalarCoupled; // Setup the variable components and choose a value at which to // evaluate the tape @@ -189,8 +189,8 @@ test_scalar_scalar_coupled_one_run(const number_t s1, // << "extracted Dpsi (s2): " << dpsi_ds2 << "\n"; // Verify the result - typedef FunctionsTestScalarScalarCoupled func; - static const ScalarNumberType tol = 1.e-7; + using func = FunctionsTestScalarScalarCoupled; + static const ScalarNumberType tol = 1.e-7; // std::cout << "dpsi_ds1: " << dpsi_ds1 << std::endl; // std::cout << "func::dpsi_ds1(s1,s2): " << func::dpsi_ds1(s1,s2) << // std::endl; std::cout << "diff: " << std::abs(dpsi_ds1 - diff --git a/tests/adolc/tensor_ops_01.cc b/tests/adolc/tensor_ops_01.cc index a76e730f07..54d4045af0 100644 --- a/tests/adolc/tensor_ops_01.cc +++ b/tests/adolc/tensor_ops_01.cc @@ -35,11 +35,11 @@ template ::ad_type - ad_number_t; - typedef Tensor<2, dim, ad_number_t> AD_Tensor; - typedef Tensor<2, dim, number_t> NonAD_Tensor; + using ad_number_t = + typename Differentiation::AD::NumberTraits::ad_type; + using AD_Tensor = Tensor<2, dim, ad_number_t>; + using NonAD_Tensor = Tensor<2, dim, number_t>; // Constructors NonAD_Tensor t1; @@ -112,13 +112,13 @@ template ::ad_type - ad_number_t; - typedef SymmetricTensor<2, dim, ad_number_t> AD_STensor; - typedef SymmetricTensor<4, dim, ad_number_t> AD_STensor4; - typedef SymmetricTensor<2, dim, number_t> NonAD_STensor; - typedef SymmetricTensor<4, dim, number_t> NonAD_STensor4; + using ad_number_t = + typename Differentiation::AD::NumberTraits::ad_type; + using AD_STensor = SymmetricTensor<2, dim, ad_number_t>; + using AD_STensor4 = SymmetricTensor<4, dim, ad_number_t>; + using NonAD_STensor = SymmetricTensor<2, dim, number_t>; + using NonAD_STensor4 = SymmetricTensor<4, dim, number_t>; // Constructors NonAD_STensor t1; diff --git a/tests/adolc/tensor_ops_02.cc b/tests/adolc/tensor_ops_02.cc index 12772c2b86..a65b217446 100644 --- a/tests/adolc/tensor_ops_02.cc +++ b/tests/adolc/tensor_ops_02.cc @@ -34,11 +34,11 @@ template ::ad_type - ad_number_t; - typedef Tensor<2, dim, ad_number_t> AD_Tensor; - typedef Tensor<2, dim, number_t> NonAD_Tensor; + using ad_number_t = + typename Differentiation::AD::NumberTraits::ad_type; + using AD_Tensor = Tensor<2, dim, ad_number_t>; + using NonAD_Tensor = Tensor<2, dim, number_t>; AD_Tensor adt1; for (unsigned int i = 0; i < NonAD_Tensor::n_independent_components; ++i) @@ -55,13 +55,13 @@ template ::ad_type - ad_number_t; - typedef SymmetricTensor<2, dim, ad_number_t> AD_STensor2; - typedef SymmetricTensor<4, dim, ad_number_t> AD_STensor4; - typedef SymmetricTensor<2, dim, number_t> NonAD_STensor2; - typedef SymmetricTensor<4, dim, number_t> NonAD_STensor4; + using ad_number_t = + typename Differentiation::AD::NumberTraits::ad_type; + using AD_STensor2 = SymmetricTensor<2, dim, ad_number_t>; + using AD_STensor4 = SymmetricTensor<4, dim, ad_number_t>; + using NonAD_STensor2 = SymmetricTensor<2, dim, number_t>; + using NonAD_STensor4 = SymmetricTensor<4, dim, number_t>; // Constructors AD_STensor2 adt1; diff --git a/tests/arpack/parpack_advection_diffusion_trilinos.cc b/tests/arpack/parpack_advection_diffusion_trilinos.cc index 2414d381e0..5784d10b71 100644 --- a/tests/arpack/parpack_advection_diffusion_trilinos.cc +++ b/tests/arpack/parpack_advection_diffusion_trilinos.cc @@ -289,7 +289,7 @@ test() /*tolerance (global)*/ 0.0, /*reduce (w.r.t. initial)*/ 1.e-13); - typedef TrilinosWrappers::MPI::Vector VectorType; + using VectorType = TrilinosWrappers::MPI::Vector; SolverGMRES solver_c(inner_control_c); TrilinosWrappers::PreconditionIdentity preconditioner; diff --git a/tests/arpack/step-36_parpack_mf.cc b/tests/arpack/step-36_parpack_mf.cc index b50ac4a944..ccc7f45325 100644 --- a/tests/arpack/step-36_parpack_mf.cc +++ b/tests/arpack/step-36_parpack_mf.cc @@ -137,7 +137,7 @@ test() // set up iterative inverse static ReductionControl inner_control_c(dof_handler.n_dofs(), 0.0, 1.e-13); - typedef LinearAlgebra::distributed::Vector VectorType; + using VectorType = LinearAlgebra::distributed::Vector; SolverCG solver_c(inner_control_c); PreconditionIdentity preconditioner; const auto shift_and_invert = diff --git a/tests/arpack/step-36_parpack_mf_02.cc b/tests/arpack/step-36_parpack_mf_02.cc index e08de962d3..28de80add2 100644 --- a/tests/arpack/step-36_parpack_mf_02.cc +++ b/tests/arpack/step-36_parpack_mf_02.cc @@ -136,7 +136,7 @@ test() // set up iterative inverse static ReductionControl inner_control_c(dof_handler.n_dofs(), 0.0, 1.e-14); - typedef LinearAlgebra::distributed::Vector VectorType; + using VectorType = LinearAlgebra::distributed::Vector; SolverCG solver_c(inner_control_c); PreconditionIdentity preconditioner; const auto invert = inverse_operator(linear_operator(mass), diff --git a/tests/arpack/step-36_parpack_mf_03.cc b/tests/arpack/step-36_parpack_mf_03.cc index e7f7b699b9..c8567ed085 100644 --- a/tests/arpack/step-36_parpack_mf_03.cc +++ b/tests/arpack/step-36_parpack_mf_03.cc @@ -137,7 +137,7 @@ test() // set up iterative inverse static ReductionControl inner_control_c(dof_handler.n_dofs(), 0.0, 1.e-14); - typedef LinearAlgebra::distributed::Vector VectorType; + using VectorType = LinearAlgebra::distributed::Vector; SolverCG solver_c(inner_control_c); PreconditionIdentity preconditioner; const auto invert = inverse_operator(linear_operator(mass), diff --git a/tests/arpack/step-36_parpack_trilinos.cc b/tests/arpack/step-36_parpack_trilinos.cc index e2e8f591b3..3865dc3a06 100644 --- a/tests/arpack/step-36_parpack_trilinos.cc +++ b/tests/arpack/step-36_parpack_trilinos.cc @@ -277,7 +277,7 @@ test() /*tolerance (global)*/ 0.0, /*reduce (w.r.t. initial)*/ 1.e-13); - typedef TrilinosWrappers::MPI::Vector VectorType; + using VectorType = TrilinosWrappers::MPI::Vector; SolverCG solver_c(inner_control_c); TrilinosWrappers::PreconditionIdentity preconditioner; diff --git a/tests/base/aligned_vector_01.cc b/tests/base/aligned_vector_01.cc index 41d6a50bc0..a1e3e69553 100644 --- a/tests/base/aligned_vector_01.cc +++ b/tests/base/aligned_vector_01.cc @@ -25,8 +25,8 @@ void test() { - typedef AlignedVector VEC; - VEC a(4); + using VEC = AlignedVector; + VEC a(4); deallog << "Constructor: "; for (unsigned int i = 0; i < a.size(); ++i) deallog << a[i] << " "; diff --git a/tests/base/aligned_vector_02.cc b/tests/base/aligned_vector_02.cc index f6043b7041..64f6272e44 100644 --- a/tests/base/aligned_vector_02.cc +++ b/tests/base/aligned_vector_02.cc @@ -21,8 +21,8 @@ #include "../tests.h" -typedef AlignedVector VEC; -typedef AlignedVector VECVEC; +using VEC = AlignedVector; +using VECVEC = AlignedVector; void print_vec(VECVEC &v) { @@ -39,8 +39,8 @@ print_vec(VECVEC &v) void test() { - typedef AlignedVector VEC; - VEC a(4); + using VEC = AlignedVector; + VEC a(4); a[0] = 2; a[1] = 1; a[2] = 42; diff --git a/tests/base/aligned_vector_03.cc b/tests/base/aligned_vector_03.cc index 42200a350f..8a9cb19511 100644 --- a/tests/base/aligned_vector_03.cc +++ b/tests/base/aligned_vector_03.cc @@ -24,8 +24,8 @@ void test() { - typedef AlignedVector VEC; - VEC a(4); + using VEC = AlignedVector; + VEC a(4); deallog << "Constructor: "; for (unsigned int i = 0; i < a.size(); ++i) deallog << a[i] << " "; diff --git a/tests/base/aligned_vector_move.cc b/tests/base/aligned_vector_move.cc index 95f32babfc..777f542eb2 100644 --- a/tests/base/aligned_vector_move.cc +++ b/tests/base/aligned_vector_move.cc @@ -24,7 +24,7 @@ void test() { - typedef AlignedVector VEC; + using VEC = AlignedVector; VEC a(4, 2); diff --git a/tests/base/anisotropic_2.cc b/tests/base/anisotropic_2.cc index 24f92e18cf..091e076fee 100644 --- a/tests/base/anisotropic_2.cc +++ b/tests/base/anisotropic_2.cc @@ -25,7 +25,7 @@ using namespace Polynomials; -typedef std::vector> PolVector; +using PolVector = std::vector>; void diff --git a/tests/base/derivative_forms_01.cc b/tests/base/derivative_forms_01.cc index 775eecd823..f2de9cfbb6 100644 --- a/tests/base/derivative_forms_01.cc +++ b/tests/base/derivative_forms_01.cc @@ -25,8 +25,8 @@ // and we compute the first and second derivatives using // Sacado -typedef typename Sacado::Fad::DFad Sdouble; -typedef typename Sacado::Fad::DFad SSdouble; +using Sdouble = typename Sacado::Fad::DFad; +using SSdouble = typename Sacado::Fad::DFad; template void diff --git a/tests/base/mpi_some_to_some_02.cc b/tests/base/mpi_some_to_some_02.cc index 17b68b98c1..800c2d1bc1 100644 --- a/tests/base/mpi_some_to_some_02.cc +++ b/tests/base/mpi_some_to_some_02.cc @@ -51,7 +51,7 @@ test(const unsigned int max_particles, auto my_proc = Utilities::MPI::this_mpi_process(MPI_COMM_WORLD); // Test some fake structure, similar to particles - typedef typename std::pair> particle; + using particle = typename std::pair>; unsigned int n_local_particles = random_index(max_particles); diff --git a/tests/base/scalar_01.cc b/tests/base/scalar_01.cc index 294d5d6f39..61d68a8804 100644 --- a/tests/base/scalar_01.cc +++ b/tests/base/scalar_01.cc @@ -38,8 +38,8 @@ main() initlog(); deallog << std::setprecision(3); - typedef Tensor<0, 1> T; - T t1(13.), t2(42); + using T = Tensor<0, 1>; + T t1(13.), t2(42); compare(T(), 0.); compare(T(13.), 13.); diff --git a/tests/base/vectorization_02.cc b/tests/base/vectorization_02.cc index 0efa95f5cf..5e34c052bf 100644 --- a/tests/base/vectorization_02.cc +++ b/tests/base/vectorization_02.cc @@ -24,11 +24,11 @@ void test() { - typedef VectorizedArray vector_t; - const unsigned int n_vectors = VectorizedArray::size(); - typedef AlignedVector VEC; - std::vector a_ref(4), b_ref; - VEC a(4); + using vector_t = VectorizedArray; + const unsigned int n_vectors = VectorizedArray::size(); + using VEC = AlignedVector; + std::vector a_ref(4), b_ref; + VEC a(4); deallog << "Constructor: "; for (unsigned int i = 0; i < a.size(); ++i) for (unsigned int d = 0; d < n_vectors; ++d) diff --git a/tests/bits/christian_1.cc b/tests/bits/christian_1.cc index 5f3a51066c..d626df1cd6 100644 --- a/tests/bits/christian_1.cc +++ b/tests/bits/christian_1.cc @@ -73,7 +73,7 @@ DoFToolsEx::transfer(const DoFHandler &source_dof, InVector local_dofs(source_dof.get_fe().dofs_per_cell); // iterate over all active source cells - typedef typename DoFHandler::active_cell_iterator cell_iterator; + using cell_iterator = typename DoFHandler::active_cell_iterator; cell_iterator cell = source_dof.begin_active(), endc = source_dof.end(); for (; cell != endc; ++cell) { diff --git a/tests/bits/iterators_01.cc b/tests/bits/iterators_01.cc index f5ccad2e92..74b808a96e 100644 --- a/tests/bits/iterators_01.cc +++ b/tests/bits/iterators_01.cc @@ -35,28 +35,27 @@ main() { initlog(); - typedef std::iterator_traits>>:: - iterator_category tria_raw_iterator_category; - typedef std::iterator_traits>>:: - iterator_category tria_iterator_category; - typedef std::iterator_traits>>:: - iterator_category tria_active_iterator_category; - - typedef std::iterator_traits< - Particles::ParticleIterator<2>>::iterator_category particle_category; - - typedef std::iterator_traits>::IteratorOverIterators>::iterator_category - iterator_over_iterator_category; - - typedef std::iterator_traits< - internal::BlockVectorIterators::Iterator, false>>:: - iterator_category block_vector_base_iterator_category; - - typedef std::iterator_traits::iterator_category - intervall_iterator_category; - typedef std::iterator_traits::iterator_category - element_iterator_category; + using tria_raw_iterator_category = std::iterator_traits< + TriaRawIterator>>::iterator_category; + using tria_iterator_category = std::iterator_traits< + TriaIterator>>::iterator_category; + using tria_active_iterator_category = std::iterator_traits< + TriaActiveIterator>>::iterator_category; + + using particle_category = + std::iterator_traits>::iterator_category; + + using iterator_over_iterator_category = std::iterator_traits>::IteratorOverIterators>::iterator_category; + + using block_vector_base_iterator_category = std::iterator_traits< + internal::BlockVectorIterators::Iterator, + false>>::iterator_category; + + using intervall_iterator_category = + std::iterator_traits::iterator_category; + using element_iterator_category = + std::iterator_traits::iterator_category; deallog << "OK" << std::endl; } diff --git a/tests/bits/periodic_flux_coupling_01.cc b/tests/bits/periodic_flux_coupling_01.cc index aa1e3f4688..ff7803dee7 100644 --- a/tests/bits/periodic_flux_coupling_01.cc +++ b/tests/bits/periodic_flux_coupling_01.cc @@ -73,7 +73,7 @@ void MakeFlux::make_grid() { GridGenerator::hyper_cube(triangulation, -1, 1, true); - typedef typename dealii::Triangulation::cell_iterator CellIteratorTria; + using CellIteratorTria = typename dealii::Triangulation::cell_iterator; std::vector> periodic_faces; const unsigned int b_id1 = 2; diff --git a/tests/bits/solver_01.cc b/tests/bits/solver_01.cc index f05986f3db..e0b2ed0d90 100644 --- a/tests/bits/solver_01.cc +++ b/tests/bits/solver_01.cc @@ -3263,10 +3263,10 @@ test() { const double tolerance = 1e-8; - typedef SolverBicgstab<> Solver; - SolverControl solver_control(N, tolerance); - PrimitiveVectorMemory<> vector_memory; - Solver solver(solver_control, vector_memory); + using Solver = SolverBicgstab<>; + SolverControl solver_control(N, tolerance); + PrimitiveVectorMemory<> vector_memory; + Solver solver(solver_control, vector_memory); PreconditionSSOR> preconditioner; preconditioner.initialize(sm, 1.2); diff --git a/tests/bits/step-13.cc b/tests/bits/step-13.cc index 56c9c97f01..37e4c72ffb 100644 --- a/tests/bits/step-13.cc +++ b/tests/bits/step-13.cc @@ -347,7 +347,7 @@ namespace LaplaceSolver void Solver::assemble_linear_system(LinearSystem &linear_system) { - typedef typename DoFHandler::active_cell_iterator active_cell_iterator; + using active_cell_iterator = typename DoFHandler::active_cell_iterator; const unsigned int n_threads = MultithreadInfo::n_threads(); std::vector> diff --git a/tests/bits/step-14.cc b/tests/bits/step-14.cc index b1463fe530..d602f94be9 100644 --- a/tests/bits/step-14.cc +++ b/tests/bits/step-14.cc @@ -429,7 +429,7 @@ namespace LaplaceSolver void Solver::assemble_linear_system(LinearSystem &linear_system) { - typedef typename DoFHandler::active_cell_iterator active_cell_iterator; + using active_cell_iterator = typename DoFHandler::active_cell_iterator; const unsigned int n_threads = MultithreadInfo::n_threads(); std::vector> @@ -1015,7 +1015,7 @@ namespace Data template struct Exercise_2_3 { - typedef Functions::ZeroFunction BoundaryValues; + using BoundaryValues = Functions::ZeroFunction; class RightHandSide : public Functions::ConstantFunction { @@ -1354,10 +1354,10 @@ namespace LaplaceSolver void solve_dual_problem(); - typedef typename DoFHandler::active_cell_iterator active_cell_iterator; + using active_cell_iterator = typename DoFHandler::active_cell_iterator; - typedef typename std::map::face_iterator, double> - FaceIntegrals; + using FaceIntegrals = + typename std::map::face_iterator, double>; struct CellData { @@ -1901,8 +1901,8 @@ template struct Framework { public: - typedef Evaluation::EvaluationBase Evaluator; - typedef std::list EvaluatorList; + using Evaluator = Evaluation::EvaluationBase; + using EvaluatorList = std::list; struct ProblemDescription diff --git a/tests/bits/step-16.cc b/tests/bits/step-16.cc index d0566653cf..4dd9b93525 100644 --- a/tests/bits/step-16.cc +++ b/tests/bits/step-16.cc @@ -258,7 +258,7 @@ LaplaceProblem::solve() MGCoarseGridHouseholder> mg_coarse; mg_coarse.initialize(coarse_matrix); - typedef PreconditionSOR> RELAXATION; + using RELAXATION = PreconditionSOR>; MGSmootherRelaxation, RELAXATION, Vector> mg_smoother; diff --git a/tests/bits/step-4_dg_periodic.cc b/tests/bits/step-4_dg_periodic.cc index 80eb3dc459..0ef2a4d680 100644 --- a/tests/bits/step-4_dg_periodic.cc +++ b/tests/bits/step-4_dg_periodic.cc @@ -154,7 +154,7 @@ void Step4::make_grid() { GridGenerator::hyper_cube(triangulation, -1, 1, true); - typedef typename dealii::Triangulation::cell_iterator CellIteratorTria; + using CellIteratorTria = typename dealii::Triangulation::cell_iterator; std::vector> periodic_faces; const unsigned int b_id1 = 2; diff --git a/tests/bits/step-4_dg_periodic_coupling.cc b/tests/bits/step-4_dg_periodic_coupling.cc index 5ea1a127d9..e77c96f85c 100644 --- a/tests/bits/step-4_dg_periodic_coupling.cc +++ b/tests/bits/step-4_dg_periodic_coupling.cc @@ -154,7 +154,7 @@ void Step4::make_grid() { GridGenerator::hyper_cube(triangulation, -1, 1, true); - typedef typename dealii::Triangulation::cell_iterator CellIteratorTria; + using CellIteratorTria = typename dealii::Triangulation::cell_iterator; std::vector> periodic_faces; const unsigned int b_id1 = 2; diff --git a/tests/cuda/matrix_free_initialize_vector.cu b/tests/cuda/matrix_free_initialize_vector.cu index f919c63b62..69d6a1000c 100644 --- a/tests/cuda/matrix_free_initialize_vector.cu +++ b/tests/cuda/matrix_free_initialize_vector.cu @@ -62,7 +62,7 @@ template void test() { - typedef double Number; + using Number = double; parallel::distributed::Triangulation tria(MPI_COMM_WORLD); GridGenerator::hyper_cube(tria); diff --git a/tests/cuda/matrix_free_matrix_vector_10.cu b/tests/cuda/matrix_free_matrix_vector_10.cu index a5523ce6ee..cd6cd531e7 100644 --- a/tests/cuda/matrix_free_matrix_vector_10.cu +++ b/tests/cuda/matrix_free_matrix_vector_10.cu @@ -54,7 +54,7 @@ template void test() { - typedef double Number; + using Number = double; parallel::distributed::Triangulation tria(MPI_COMM_WORLD); GridGenerator::hyper_cube(tria); diff --git a/tests/cuda/matrix_free_matrix_vector_10a.cu b/tests/cuda/matrix_free_matrix_vector_10a.cu index f2831c1327..55734b1d29 100644 --- a/tests/cuda/matrix_free_matrix_vector_10a.cu +++ b/tests/cuda/matrix_free_matrix_vector_10a.cu @@ -56,7 +56,7 @@ template void test() { - typedef double Number; + using Number = double; parallel::distributed::Triangulation tria(MPI_COMM_WORLD); GridGenerator::hyper_cube(tria); diff --git a/tests/cuda/matrix_free_matrix_vector_19.cu b/tests/cuda/matrix_free_matrix_vector_19.cu index e45cbc41f9..cf7f617e04 100644 --- a/tests/cuda/matrix_free_matrix_vector_19.cu +++ b/tests/cuda/matrix_free_matrix_vector_19.cu @@ -50,7 +50,7 @@ template void test() { - typedef double Number; + using Number = double; parallel::shared::Triangulation tria( MPI_COMM_WORLD, diff --git a/tests/cuda/matrix_free_matrix_vector_25.cu b/tests/cuda/matrix_free_matrix_vector_25.cu index 475270fc72..86bc853f09 100644 --- a/tests/cuda/matrix_free_matrix_vector_25.cu +++ b/tests/cuda/matrix_free_matrix_vector_25.cu @@ -48,7 +48,7 @@ template void test() { - typedef double Number; + using Number = double; parallel::distributed::Triangulation tria(MPI_COMM_WORLD); GridGenerator::hyper_cube(tria); diff --git a/tests/cuda/matrix_free_reinit_01.cu b/tests/cuda/matrix_free_reinit_01.cu index f0afe26dd9..10e2f204d2 100644 --- a/tests/cuda/matrix_free_reinit_01.cu +++ b/tests/cuda/matrix_free_reinit_01.cu @@ -40,7 +40,7 @@ template void test() { - typedef double Number; + using Number = double; parallel::distributed::Triangulation tria(MPI_COMM_WORLD); GridGenerator::hyper_cube(tria); diff --git a/tests/cuda/precondition_03.cu b/tests/cuda/precondition_03.cu index 3aaee7147b..4dc32b4ccc 100644 --- a/tests/cuda/precondition_03.cu +++ b/tests/cuda/precondition_03.cu @@ -55,7 +55,7 @@ template void test() { - typedef double Number; + using Number = double; parallel::distributed::Triangulation tria(MPI_COMM_WORLD); GridGenerator::hyper_cube(tria); diff --git a/tests/distributed_grids/2d_refinement_10.cc b/tests/distributed_grids/2d_refinement_10.cc index aa73d51de3..d10c2115f8 100644 --- a/tests/distributed_grids/2d_refinement_10.cc +++ b/tests/distributed_grids/2d_refinement_10.cc @@ -55,7 +55,7 @@ template class TriaTest { private: - typedef typename parallel::distributed::Triangulation TypeTria; + using TypeTria = typename parallel::distributed::Triangulation; public: TriaTest(const typename dealii::Triangulation::MeshSmoothing diff --git a/tests/distributed_grids/3d_refinement_12.cc b/tests/distributed_grids/3d_refinement_12.cc index 594a181881..887570e464 100644 --- a/tests/distributed_grids/3d_refinement_12.cc +++ b/tests/distributed_grids/3d_refinement_12.cc @@ -55,7 +55,7 @@ template class TriaTest { private: - typedef typename parallel::distributed::Triangulation TypeTria; + using TypeTria = typename parallel::distributed::Triangulation; public: TriaTest(const typename dealii::Triangulation::MeshSmoothing diff --git a/tests/distributed_grids/grid_tools_exchange_cell_data_01.cc b/tests/distributed_grids/grid_tools_exchange_cell_data_01.cc index 22fe413e1d..4289128bef 100644 --- a/tests/distributed_grids/grid_tools_exchange_cell_data_01.cc +++ b/tests/distributed_grids/grid_tools_exchange_cell_data_01.cc @@ -43,7 +43,7 @@ test() std::set input, output; - typedef double DT; + using DT = double; std::map map; DT counter = 0.0; @@ -70,9 +70,8 @@ test() } } - typedef - typename parallel::distributed::Triangulation::active_cell_iterator - cell_iterator; + using cell_iterator = + typename parallel::distributed::Triangulation::active_cell_iterator; GridTools:: exchange_cell_data_to_ghosts>( tria, diff --git a/tests/distributed_grids/grid_tools_exchange_cell_data_02.cc b/tests/distributed_grids/grid_tools_exchange_cell_data_02.cc index c0e61d6555..6c804b9f5c 100644 --- a/tests/distributed_grids/grid_tools_exchange_cell_data_02.cc +++ b/tests/distributed_grids/grid_tools_exchange_cell_data_02.cc @@ -51,10 +51,10 @@ test() std::set input, output; - typedef typename DoFHandler::active_cell_iterator cell_iterator; - typedef short DT; - std::map map; - short counter = 0; + using cell_iterator = typename DoFHandler::active_cell_iterator; + using DT = short; + std::map map; + short counter = 0; std::map> vertices_with_ghost_neighbors = diff --git a/tests/distributed_grids/grid_tools_exchange_cell_data_03.cc b/tests/distributed_grids/grid_tools_exchange_cell_data_03.cc index f801858bee..d71d4b4abc 100644 --- a/tests/distributed_grids/grid_tools_exchange_cell_data_03.cc +++ b/tests/distributed_grids/grid_tools_exchange_cell_data_03.cc @@ -48,9 +48,9 @@ test() std::set input, output; - typedef typename parallel::shared::Triangulation::active_cell_iterator - cell_iterator; - typedef double DT; + using cell_iterator = + typename parallel::shared::Triangulation::active_cell_iterator; + using DT = double; std::map map; DT counter = 0.0; diff --git a/tests/distributed_grids/grid_tools_exchange_cell_data_04.cc b/tests/distributed_grids/grid_tools_exchange_cell_data_04.cc index 7cab39e2ae..9bc159392d 100644 --- a/tests/distributed_grids/grid_tools_exchange_cell_data_04.cc +++ b/tests/distributed_grids/grid_tools_exchange_cell_data_04.cc @@ -47,10 +47,9 @@ test() std::map input; std::set output; - typedef - typename parallel::distributed::Triangulation::active_cell_iterator - cell_iterator; - typedef double DT; + using cell_iterator = + typename parallel::distributed::Triangulation::active_cell_iterator; + using DT = double; std::map map; int counter = 0; diff --git a/tests/distributed_grids/intergrid_transfer_representation_parallel.cc b/tests/distributed_grids/intergrid_transfer_representation_parallel.cc index e92488351f..edc4d1b21f 100644 --- a/tests/distributed_grids/intergrid_transfer_representation_parallel.cc +++ b/tests/distributed_grids/intergrid_transfer_representation_parallel.cc @@ -89,7 +89,7 @@ test(unsigned n_refinements) InterGridMap> grid_1_to_2_map; grid_1_to_2_map.make_mapping(dof_handler1, dof_handler2); - typedef std::vector> TransferRep; + using TransferRep = std::vector>; TransferRep transfer_representation; DoFTools::compute_intergrid_transfer_representation( dof_handler1, 0, dof_handler2, 0, grid_1_to_2_map, transfer_representation); diff --git a/tests/fail/hp-step-14.cc b/tests/fail/hp-step-14.cc index 123fcac172..99a03d853a 100644 --- a/tests/fail/hp-step-14.cc +++ b/tests/fail/hp-step-14.cc @@ -437,7 +437,7 @@ namespace LaplaceSolver void Solver::assemble_linear_system(LinearSystem &linear_system) { - typedef typename DoFHandler::active_cell_iterator active_cell_iterator; + using active_cell_iterator = typename DoFHandler::active_cell_iterator; const unsigned int n_threads = MultithreadInfo::n_threads(); std::vector> @@ -1029,7 +1029,7 @@ namespace Data template struct Exercise_2_3 { - typedef Functions::ZeroFunction BoundaryValues; + using BoundaryValues = Functions::ZeroFunction; class RightHandSide : public Functions::ConstantFunction { @@ -1371,10 +1371,10 @@ namespace LaplaceSolver void solve_dual_problem(); - typedef typename DoFHandler::active_cell_iterator active_cell_iterator; + using active_cell_iterator = typename DoFHandler::active_cell_iterator; - typedef typename std::map::face_iterator, double> - FaceIntegrals; + using FaceIntegrals = + typename std::map::face_iterator, double>; struct CellData { @@ -1927,8 +1927,8 @@ template struct Framework { public: - typedef Evaluation::EvaluationBase Evaluator; - typedef std::list EvaluatorList; + using Evaluator = Evaluation::EvaluationBase; + using EvaluatorList = std::list; struct ProblemDescription diff --git a/tests/fe/fe_enriched_color_01.cc b/tests/fe/fe_enriched_color_01.cc index 7db630be93..81ab9fb7af 100644 --- a/tests/fe/fe_enriched_color_01.cc +++ b/tests/fe/fe_enriched_color_01.cc @@ -71,9 +71,8 @@ test() // Construct vector of predicates for 2 and 3 dimensions Assert(dim == 2 || dim == 3, ExcDimensionMismatch2(dim, 2, 3)); - typedef std::function::active_cell_iterator &)> - predicate_function; + using predicate_function = std::function::active_cell_iterator &)>; std::vector predicates; predicates.resize(5); if (dim == 2) diff --git a/tests/fe/fe_q_dg0.cc b/tests/fe/fe_q_dg0.cc index 2b9e62a799..8b98c87b8e 100644 --- a/tests/fe/fe_q_dg0.cc +++ b/tests/fe/fe_q_dg0.cc @@ -67,13 +67,13 @@ namespace Step22 template <> struct InnerPreconditioner<2> { - typedef SparseDirectUMFPACK type; + using type = SparseDirectUMFPACK; }; template <> struct InnerPreconditioner<3> { - typedef SparseILU type; + using type = SparseILU; }; template diff --git a/tests/fe/fe_rannacher_turek_01.cc b/tests/fe/fe_rannacher_turek_01.cc index ecd799eb0b..614b4ad7e1 100644 --- a/tests/fe/fe_rannacher_turek_01.cc +++ b/tests/fe/fe_rannacher_turek_01.cc @@ -124,8 +124,8 @@ test_interpolation() Quadrature<2> quadrature(fe.get_generalized_support_points()); FEValues<2> fev(fe, quadrature, update_values | update_JxW_values); - typedef DoFHandler<2>::cell_iterator cell_it; - cell_it cell = dofh.begin_active(); + using cell_it = DoFHandler<2>::cell_iterator; + cell_it cell = dofh.begin_active(); for (; cell != dofh.end(); ++cell) { fev.reinit(cell); diff --git a/tests/fe/fe_values_view_get_function_from_local_dof_values_01.cc b/tests/fe/fe_values_view_get_function_from_local_dof_values_01.cc index e05ebb357a..150c2d8a5c 100644 --- a/tests/fe/fe_values_view_get_function_from_local_dof_values_01.cc +++ b/tests/fe/fe_values_view_get_function_from_local_dof_values_01.cc @@ -54,23 +54,23 @@ test_view(const Vector & solution, const FEValuesExtractors::Scalar &extractor, const std::vector & local_dof_values) { - typedef typename std::remove_reference::type>::type View; - const View & fe_values_view = fe_values[extractor]; + using View = typename std::remove_reference< + typename std::remove_const::type>::type; + const View &fe_values_view = fe_values[extractor]; // Typedefs - typedef typename View::template OutputType OutputType; - typedef typename ProductType::type - value_type; - typedef typename ProductType::type - gradient_type; - typedef typename ProductType::type - hessian_type; - typedef typename ProductType::type - laplacian_type; - typedef - typename ProductType::type - third_derivative_type; + using OutputType = typename View::template OutputType; + using value_type = + typename ProductType::type; + using gradient_type = + typename ProductType::type; + using hessian_type = + typename ProductType::type; + using laplacian_type = + typename ProductType::type; + using third_derivative_type = + typename ProductType::type; // Values std::vector qp_values_local(n_q_points); @@ -140,29 +140,30 @@ test_view(const Vector & solution, const FEValuesExtractors::Vector &extractor, const std::vector & local_dof_values) { - typedef typename std::remove_reference::type>::type View; - const View & fe_values_view = fe_values[extractor]; + using View = typename std::remove_reference< + typename std::remove_const::type>::type; + const View &fe_values_view = fe_values[extractor]; // Typedefs - typedef typename View::template OutputType OutputType; - typedef typename ProductType::type - value_type; - typedef typename ProductType::type - gradient_type; - typedef typename ProductType::type symmetric_gradient_type; - typedef typename ProductType::type - divergence_type; - typedef - typename ProductType::type curl_type; - typedef typename ProductType::type - hessian_type; - typedef typename ProductType::type - laplacian_type; - typedef - typename ProductType::type - third_derivative_type; + using OutputType = typename View::template OutputType; + using value_type = + typename ProductType::type; + using gradient_type = + typename ProductType::type; + using symmetric_gradient_type = + typename ProductType::type; + using divergence_type = + typename ProductType::type; + using curl_type = + typename ProductType::type; + using hessian_type = + typename ProductType::type; + using laplacian_type = + typename ProductType::type; + using third_derivative_type = + typename ProductType::type; // Values std::vector qp_values_local(n_q_points); @@ -269,16 +270,16 @@ test_view(const Vector & solution, const FEValuesExtractors::SymmetricTensor<2> &extractor, const std::vector & local_dof_values) { - typedef typename std::remove_reference::type>::type View; - const View & fe_values_view = fe_values[extractor]; + using View = typename std::remove_reference< + typename std::remove_const::type>::type; + const View &fe_values_view = fe_values[extractor]; // Typedefs - typedef typename View::template OutputType OutputType; - typedef typename ProductType::type - value_type; - typedef typename ProductType::type - divergence_type; + using OutputType = typename View::template OutputType; + using value_type = + typename ProductType::type; + using divergence_type = + typename ProductType::type; // Values std::vector qp_values_local(n_q_points); @@ -315,18 +316,18 @@ test_view(const Vector & solution, const FEValuesExtractors::Tensor<2> &extractor, const std::vector & local_dof_values) { - typedef typename std::remove_reference::type>::type View; - const View & fe_values_view = fe_values[extractor]; + using View = typename std::remove_reference< + typename std::remove_const::type>::type; + const View &fe_values_view = fe_values[extractor]; // Typedefs - typedef typename View::template OutputType OutputType; - typedef typename ProductType::type - value_type; - typedef typename ProductType::type - gradient_type; - typedef typename ProductType::type - divergence_type; + using OutputType = typename View::template OutputType; + using value_type = + typename ProductType::type; + using gradient_type = + typename ProductType::type; + using divergence_type = + typename ProductType::type; // Values std::vector qp_values_local(n_q_points); diff --git a/tests/fe/fe_values_view_get_function_from_local_dof_values_02.cc b/tests/fe/fe_values_view_get_function_from_local_dof_values_02.cc index 708ac63ffa..5045af2f79 100644 --- a/tests/fe/fe_values_view_get_function_from_local_dof_values_02.cc +++ b/tests/fe/fe_values_view_get_function_from_local_dof_values_02.cc @@ -60,12 +60,12 @@ test_view(const Vector & solution, const FEValuesExtractors::Scalar &extractor, const std::vector & local_dof_values) { - typedef typename std::remove_reference::type>::type View; - const View & fe_values_view = fe_values[extractor]; + using View = typename std::remove_reference< + typename std::remove_const::type>::type; + const View &fe_values_view = fe_values[extractor]; // Typedefs - typedef typename View::template OutputType OutputType; + using OutputType = typename View::template OutputType; // Values std::vector qp_values_local(n_q_points); @@ -103,12 +103,12 @@ test_view(const Vector & solution, const FEValuesExtractors::Vector &extractor, const std::vector & local_dof_values) { - typedef typename std::remove_reference::type>::type View; - const View & fe_values_view = fe_values[extractor]; + using View = typename std::remove_reference< + typename std::remove_const::type>::type; + const View &fe_values_view = fe_values[extractor]; // Typedefs - typedef typename View::template OutputType OutputType; + using OutputType = typename View::template OutputType; // Values std::vector qp_values_local(n_q_points); @@ -162,16 +162,16 @@ test_view(const Vector & solution, const FEValuesExtractors::SymmetricTensor<2> &extractor, const std::vector & local_dof_values) { - typedef typename std::remove_reference::type>::type View; - const View & fe_values_view = fe_values[extractor]; + using View = typename std::remove_reference< + typename std::remove_const::type>::type; + const View &fe_values_view = fe_values[extractor]; // Typedefs - typedef typename View::template OutputType OutputType; - typedef typename ProductType::type - value_type; - typedef typename ProductType::type - divergence_type; + using OutputType = typename View::template OutputType; + using value_type = + typename ProductType::type; + using divergence_type = + typename ProductType::type; // Values std::vector qp_values_local(n_q_points); @@ -193,18 +193,18 @@ test_view(const Vector & solution, const FEValuesExtractors::Tensor<2> &extractor, const std::vector & local_dof_values) { - typedef typename std::remove_reference::type>::type View; - const View & fe_values_view = fe_values[extractor]; + using View = typename std::remove_reference< + typename std::remove_const::type>::type; + const View &fe_values_view = fe_values[extractor]; // Typedefs - typedef typename View::template OutputType OutputType; - typedef typename ProductType::type - value_type; - typedef typename ProductType::type - gradient_type; - typedef typename ProductType::type - divergence_type; + using OutputType = typename View::template OutputType; + using value_type = + typename ProductType::type; + using gradient_type = + typename ProductType::type; + using divergence_type = + typename ProductType::type; // Values std::vector qp_values_local(n_q_points); diff --git a/tests/feinterface/step-12.cc b/tests/feinterface/step-12.cc index ce696f5f8b..d235ee4ff1 100644 --- a/tests/feinterface/step-12.cc +++ b/tests/feinterface/step-12.cc @@ -265,8 +265,8 @@ namespace Step12 void AdvectionProblem::assemble_system() { - typedef decltype(dof_handler.begin_active()) Iterator; - BoundaryValues boundary_function; + using Iterator = decltype(dof_handler.begin_active()); + BoundaryValues boundary_function; auto cell_worker = [&](const Iterator & cell, ScratchData &scratch_data, diff --git a/tests/gla/block_mat_02.cc b/tests/gla/block_mat_02.cc index 4ebc44a532..70378ed135 100644 --- a/tests/gla/block_mat_02.cc +++ b/tests/gla/block_mat_02.cc @@ -146,7 +146,7 @@ template void test_LA_Trilinos() { - typedef LA_Trilinos LA; + using LA = LA_Trilinos; unsigned int myid = Utilities::MPI::this_mpi_process(MPI_COMM_WORLD); unsigned int numproc = Utilities::MPI::n_mpi_processes(MPI_COMM_WORLD); diff --git a/tests/gla/block_mat_03.cc b/tests/gla/block_mat_03.cc index 6bf10893f2..419dc8b47c 100644 --- a/tests/gla/block_mat_03.cc +++ b/tests/gla/block_mat_03.cc @@ -102,7 +102,7 @@ test() deallog << "relevant: "; locally_relevant_dofs.print(deallog); - typedef typename LA::MPI::BlockSparseMatrix::value_type number; + using number = typename LA::MPI::BlockSparseMatrix::value_type; AffineConstraints constraints(locally_relevant_dofs); constraints.close(); @@ -160,9 +160,9 @@ template void test_alt() { - typedef LA_Trilinos LA; - unsigned int myid = Utilities::MPI::this_mpi_process(MPI_COMM_WORLD); - unsigned int numproc = Utilities::MPI::n_mpi_processes(MPI_COMM_WORLD); + using LA = LA_Trilinos; + unsigned int myid = Utilities::MPI::this_mpi_process(MPI_COMM_WORLD); + unsigned int numproc = Utilities::MPI::n_mpi_processes(MPI_COMM_WORLD); if (myid == 0) deallog << "numproc=" << numproc << std::endl; diff --git a/tests/gla/gla.h b/tests/gla/gla.h index 21b3ceb4c2..811a54730c 100644 --- a/tests/gla/gla.h +++ b/tests/gla/gla.h @@ -21,10 +21,10 @@ public: class MPI { public: - typedef LinearAlgebraPETSc::MPI::Vector Vector; - typedef LinearAlgebraPETSc::MPI::SparseMatrix SparseMatrix; - typedef LinearAlgebraPETSc::MPI::BlockVector BlockVector; - typedef LinearAlgebraPETSc::MPI::BlockSparseMatrix BlockSparseMatrix; + using Vector = LinearAlgebraPETSc::MPI::Vector; + using SparseMatrix = LinearAlgebraPETSc::MPI::SparseMatrix; + using BlockVector = LinearAlgebraPETSc::MPI::BlockVector; + using BlockSparseMatrix = LinearAlgebraPETSc::MPI::BlockSparseMatrix; }; }; @@ -34,10 +34,10 @@ public: class MPI { public: - typedef LinearAlgebraTrilinos::MPI::Vector Vector; - typedef LinearAlgebraTrilinos::MPI::SparseMatrix SparseMatrix; - typedef LinearAlgebraTrilinos::MPI::BlockVector BlockVector; - typedef LinearAlgebraTrilinos::MPI::BlockSparseMatrix BlockSparseMatrix; + using Vector = LinearAlgebraTrilinos::MPI::Vector; + using SparseMatrix = LinearAlgebraTrilinos::MPI::SparseMatrix; + using BlockVector = LinearAlgebraTrilinos::MPI::BlockVector; + using BlockSparseMatrix = LinearAlgebraTrilinos::MPI::BlockSparseMatrix; }; }; diff --git a/tests/gla/mat_04.cc b/tests/gla/mat_04.cc index 76a48edf1f..f79c4c9ddc 100644 --- a/tests/gla/mat_04.cc +++ b/tests/gla/mat_04.cc @@ -107,7 +107,7 @@ template void test_trilinos_alternative() { - typedef LA_Trilinos LA; + using LA = LA_Trilinos; unsigned int myid = Utilities::MPI::this_mpi_process(MPI_COMM_WORLD); unsigned int numproc = Utilities::MPI::n_mpi_processes(MPI_COMM_WORLD); diff --git a/tests/grid/filtered_iterator.cc b/tests/grid/filtered_iterator.cc index 8ffcc5bc6c..0bac2bea95 100644 --- a/tests/grid/filtered_iterator.cc +++ b/tests/grid/filtered_iterator.cc @@ -37,7 +37,7 @@ DeclException2(ExcNumberMismatch, -typedef Triangulation<2>::active_cell_iterator active_cell_iterator; +using active_cell_iterator = Triangulation<2>::active_cell_iterator; template bool @@ -154,7 +154,7 @@ test() // check 4: and yet another possibility if (true) { - typedef FilteredIterator FI; + using FI = FilteredIterator; bool (*predicate)(const active_cell_iterator, const unsigned int) = &level_equal_to; @@ -182,9 +182,9 @@ test() // id if (true) { - typedef FilteredIterator FI; - const IteratorFilters::SubdomainEqualTo predicate(1); - FI cell(predicate); + using FI = FilteredIterator; + const IteratorFilters::SubdomainEqualTo predicate(1); + FI cell(predicate); cell.set_to_next_positive(tria.begin_active()); active_cell_iterator endc(tria.end()); active_cell_iterator cell1 = tria.begin_active(); diff --git a/tests/grid/filtered_iterator_02.cc b/tests/grid/filtered_iterator_02.cc index 4e8186b385..24c93a4da9 100644 --- a/tests/grid/filtered_iterator_02.cc +++ b/tests/grid/filtered_iterator_02.cc @@ -37,7 +37,7 @@ DeclException2(ExcNumberMismatch, -typedef Triangulation<2>::active_cell_iterator active_cell_iterator; +using active_cell_iterator = Triangulation<2>::active_cell_iterator; template bool @@ -156,7 +156,7 @@ test() // check 4: and yet another possibility if (true) { - typedef FilteredIterator FI; + using FI = FilteredIterator; bool (*predicate)(const active_cell_iterator, const unsigned int) = &level_equal_to; @@ -184,9 +184,9 @@ test() // id if (true) { - typedef FilteredIterator FI; - const IteratorFilters::SubdomainEqualTo predicate(1); - FI cell(predicate); + using FI = FilteredIterator; + const IteratorFilters::SubdomainEqualTo predicate(1); + FI cell(predicate); cell.set_to_next_positive(tria.begin_active()); active_cell_iterator endc(tria.end()); active_cell_iterator cell1 = tria.begin_active(); diff --git a/tests/grid/filtered_iterator_03.cc b/tests/grid/filtered_iterator_03.cc index d63905e58e..e6c522a490 100644 --- a/tests/grid/filtered_iterator_03.cc +++ b/tests/grid/filtered_iterator_03.cc @@ -37,7 +37,7 @@ DeclException2(ExcNumberMismatch, -typedef Triangulation<2>::active_cell_iterator active_cell_iterator; +using active_cell_iterator = Triangulation<2>::active_cell_iterator; template bool diff --git a/tests/grid/filtered_iterator_04.cc b/tests/grid/filtered_iterator_04.cc index f8897b246c..1990b81484 100644 --- a/tests/grid/filtered_iterator_04.cc +++ b/tests/grid/filtered_iterator_04.cc @@ -26,7 +26,7 @@ #include "../tests.h" -typedef Triangulation<2>::active_cell_iterator active_cell_iterator; +using active_cell_iterator = Triangulation<2>::active_cell_iterator; void test() diff --git a/tests/grid/get_finest_common_cells_01.cc b/tests/grid/get_finest_common_cells_01.cc index 8017febffd..a280bb8ef4 100644 --- a/tests/grid/get_finest_common_cells_01.cc +++ b/tests/grid/get_finest_common_cells_01.cc @@ -50,9 +50,9 @@ test() tria[1].last_active()->set_refine_flag(); tria[1].execute_coarsening_and_refinement(); - typedef std::list::cell_iterator, - typename Triangulation::cell_iterator>> - CellList; + using CellList = + std::list::cell_iterator, + typename Triangulation::cell_iterator>>; const CellList cell_list = GridTools::get_finest_common_cells(tria[0], tria[1]); diff --git a/tests/grid/get_finest_common_cells_02.cc b/tests/grid/get_finest_common_cells_02.cc index 5c1d0939ae..885bec866b 100644 --- a/tests/grid/get_finest_common_cells_02.cc +++ b/tests/grid/get_finest_common_cells_02.cc @@ -53,9 +53,9 @@ test() DoFHandler dh0(tria[0]); DoFHandler dh1(tria[1]); - typedef std::list::cell_iterator, - typename DoFHandler::cell_iterator>> - CellList; + using CellList = + std::list::cell_iterator, + typename DoFHandler::cell_iterator>>; const CellList cell_list = GridTools::get_finest_common_cells(dh0, dh1); for (typename CellList::const_iterator cell_pair = cell_list.begin(); diff --git a/tests/grid/get_finest_common_cells_03.cc b/tests/grid/get_finest_common_cells_03.cc index 5c1d0939ae..885bec866b 100644 --- a/tests/grid/get_finest_common_cells_03.cc +++ b/tests/grid/get_finest_common_cells_03.cc @@ -53,9 +53,9 @@ test() DoFHandler dh0(tria[0]); DoFHandler dh1(tria[1]); - typedef std::list::cell_iterator, - typename DoFHandler::cell_iterator>> - CellList; + using CellList = + std::list::cell_iterator, + typename DoFHandler::cell_iterator>>; const CellList cell_list = GridTools::get_finest_common_cells(dh0, dh1); for (typename CellList::const_iterator cell_pair = cell_list.begin(); diff --git a/tests/grid/get_finest_common_cells_04.cc b/tests/grid/get_finest_common_cells_04.cc index fb750f37ad..a06bca88a8 100644 --- a/tests/grid/get_finest_common_cells_04.cc +++ b/tests/grid/get_finest_common_cells_04.cc @@ -79,9 +79,9 @@ test() } #endif - typedef std::list::cell_iterator, - typename Triangulation::cell_iterator>> - CellList; + using CellList = + std::list::cell_iterator, + typename Triangulation::cell_iterator>>; deallog << "number of locally owned cells in tria 0 and tria 1: " << tria_0.n_active_cells() << ' ' << tria_1.n_active_cells() diff --git a/tests/grid/grid_tools_05.cc b/tests/grid/grid_tools_05.cc index 95a22adb68..a8046cc05f 100644 --- a/tests/grid/grid_tools_05.cc +++ b/tests/grid/grid_tools_05.cc @@ -187,9 +187,9 @@ main() generate_grid(triangulation2); - typedef Triangulation<2>::cell_iterator CellIterator2; - typedef std::vector> FaceVector2; - FaceVector2 test2; + using CellIterator2 = Triangulation<2>::cell_iterator; + using FaceVector2 = std::vector>; + FaceVector2 test2; GridTools::collect_periodic_faces( triangulation2, 42, 1, test2, dealii::Tensor<1, 2>()); @@ -206,9 +206,9 @@ main() generate_grid(triangulation3); - typedef Triangulation<3>::cell_iterator CellIterator3; - typedef std::vector> FaceVector3; - FaceVector3 test3; + using CellIterator3 = Triangulation<3>::cell_iterator; + using FaceVector3 = std::vector>; + FaceVector3 test3; GridTools::collect_periodic_faces( triangulation3, 42, 2, test3, dealii::Tensor<1, 3>()); diff --git a/tests/grid/grid_tools_06.cc b/tests/grid/grid_tools_06.cc index 9ccb261115..f489b0d54d 100644 --- a/tests/grid/grid_tools_06.cc +++ b/tests/grid/grid_tools_06.cc @@ -201,9 +201,9 @@ main() generate_grid(triangulation, i); - typedef Triangulation<2>::cell_iterator CellIterator; - typedef std::vector> FaceVector; - FaceVector test; + using CellIterator = Triangulation<2>::cell_iterator; + using FaceVector = std::vector>; + FaceVector test; GridTools::collect_periodic_faces( triangulation, 42, 43, 1, test, dealii::Tensor<1, 2>()); @@ -224,9 +224,9 @@ main() generate_grid(triangulation, i); - typedef Triangulation<3>::cell_iterator CellIterator; - typedef std::vector> FaceVector; - FaceVector test; + using CellIterator = Triangulation<3>::cell_iterator; + using FaceVector = std::vector>; + FaceVector test; GridTools::collect_periodic_faces( triangulation, 42, 43, 2, test, dealii::Tensor<1, 3>()); diff --git a/tests/grid/grid_tools_active_cell_layer_within_distance_01.cc b/tests/grid/grid_tools_active_cell_layer_within_distance_01.cc index ba788cba70..ee1d06414d 100644 --- a/tests/grid/grid_tools_active_cell_layer_within_distance_01.cc +++ b/tests/grid/grid_tools_active_cell_layer_within_distance_01.cc @@ -60,7 +60,7 @@ test() GridGenerator::hyper_cube(tria); tria.refine_global(2); - typedef typename Triangulation::active_cell_iterator cell_iterator; + using cell_iterator = typename Triangulation::active_cell_iterator; // Mark a small block at the corner of the hypercube cell_iterator cell = tria.begin_active(), endc = tria.end(); diff --git a/tests/grid/grid_tools_active_cell_layer_within_distance_02.cc b/tests/grid/grid_tools_active_cell_layer_within_distance_02.cc index 1a0265f987..3f9b886c21 100644 --- a/tests/grid/grid_tools_active_cell_layer_within_distance_02.cc +++ b/tests/grid/grid_tools_active_cell_layer_within_distance_02.cc @@ -90,7 +90,7 @@ test() GridGenerator::subdivided_hyper_rectangle( tria, step_sizes, bottom_left, upper_right, true); - typedef typename Triangulation::active_cell_iterator cell_iterator; + using cell_iterator = typename Triangulation::active_cell_iterator; // Mark a small block at the corner of the hypercube cell_iterator cell = tria.begin_active(), endc = tria.end(); diff --git a/tests/grid/grid_tools_bounding_box_01.cc b/tests/grid/grid_tools_bounding_box_01.cc index 200b93772f..417f0728b9 100644 --- a/tests/grid/grid_tools_bounding_box_01.cc +++ b/tests/grid/grid_tools_bounding_box_01.cc @@ -39,7 +39,7 @@ test() GridGenerator::hyper_cube(tria); tria.refine_global(2); - typedef typename Triangulation::active_cell_iterator cell_iterator; + using cell_iterator = typename Triangulation::active_cell_iterator; // Mark a small block at the corner of the hypercube cell_iterator cell = tria.begin_active(), endc = tria.end(); diff --git a/tests/grid/grid_tools_bounding_box_02.cc b/tests/grid/grid_tools_bounding_box_02.cc index 9bd048a3fc..d566b7ffb6 100644 --- a/tests/grid/grid_tools_bounding_box_02.cc +++ b/tests/grid/grid_tools_bounding_box_02.cc @@ -43,7 +43,7 @@ test() GridGenerator::hyper_cube(tria); tria.refine_global(2); - typedef typename Triangulation::active_cell_iterator cell_iterator; + using cell_iterator = typename Triangulation::active_cell_iterator; // Mark a small block at the corner of the hypercube cell_iterator cell = tria.begin_active(), endc = tria.end(); diff --git a/tests/grid/grid_tools_compute_mesh_predicate_bounding_box_1.cc b/tests/grid/grid_tools_compute_mesh_predicate_bounding_box_1.cc index 46740b47ee..4af8ad614e 100644 --- a/tests/grid/grid_tools_compute_mesh_predicate_bounding_box_1.cc +++ b/tests/grid/grid_tools_compute_mesh_predicate_bounding_box_1.cc @@ -56,8 +56,8 @@ test_hypercube(unsigned int ref, unsigned int max_bbox) GridGenerator::hyper_cube(tria); tria.refine_global(4); - typedef typename parallel::distributed::Triangulation:: - active_cell_iterator cell_iterator; + using cell_iterator = typename parallel::distributed:: + Triangulation::active_cell_iterator; std::function predicate = pred_locally_owned; diff --git a/tests/grid/grid_tools_halo_layer_01.cc b/tests/grid/grid_tools_halo_layer_01.cc index 22d7946cd2..c8f9f7e76b 100644 --- a/tests/grid/grid_tools_halo_layer_01.cc +++ b/tests/grid/grid_tools_halo_layer_01.cc @@ -55,7 +55,7 @@ test() GridGenerator::hyper_cube(tria); tria.refine_global(2); - typedef typename Triangulation::active_cell_iterator cell_iterator; + using cell_iterator = typename Triangulation::active_cell_iterator; // Mark a small block at the corner of the hypercube cell_iterator cell = tria.begin_active(), endc = tria.end(); diff --git a/tests/grid/grid_tools_halo_layer_02.cc b/tests/grid/grid_tools_halo_layer_02.cc index 4253584e8e..7f9c2779f0 100644 --- a/tests/grid/grid_tools_halo_layer_02.cc +++ b/tests/grid/grid_tools_halo_layer_02.cc @@ -49,7 +49,7 @@ test() GridGenerator::hyper_cube(tria); tria.refine_global(2); - typedef typename Triangulation::active_cell_iterator cell_iterator; + using cell_iterator = typename Triangulation::active_cell_iterator; // Mark a small block at the corner of the hypercube cell_iterator cell = tria.begin_active(), endc = tria.end(); diff --git a/tests/grid/grid_tools_halo_layer_03.cc b/tests/grid/grid_tools_halo_layer_03.cc index 3a10d73023..eeca99e5a7 100644 --- a/tests/grid/grid_tools_halo_layer_03.cc +++ b/tests/grid/grid_tools_halo_layer_03.cc @@ -49,7 +49,7 @@ test() GridGenerator::hyper_cube(tria); tria.refine_global(2); - typedef typename Triangulation::active_cell_iterator cell_iterator; + using cell_iterator = typename Triangulation::active_cell_iterator; // Mark a small block at the corner of the hypercube cell_iterator cell = tria.begin_active(), endc = tria.end(); diff --git a/tests/grid/grid_tools_halo_layer_04.cc b/tests/grid/grid_tools_halo_layer_04.cc index cb838440d5..2988635f24 100644 --- a/tests/grid/grid_tools_halo_layer_04.cc +++ b/tests/grid/grid_tools_halo_layer_04.cc @@ -85,7 +85,7 @@ test() tria.refine_global(2); DoFHandler dof_handler(tria); - typedef typename DoFHandler::active_cell_iterator cell_iterator; + using cell_iterator = typename DoFHandler::active_cell_iterator; // Mark a small block at the corner of the hypercube cell_iterator cell = dof_handler.begin_active(), endc = dof_handler.end(); diff --git a/tests/grid/grid_tools_halo_layer_05.cc b/tests/grid/grid_tools_halo_layer_05.cc index 08258d8a4b..4c3ef6f191 100644 --- a/tests/grid/grid_tools_halo_layer_05.cc +++ b/tests/grid/grid_tools_halo_layer_05.cc @@ -85,7 +85,7 @@ test() tria.refine_global(2); DoFHandler dof_handler(tria); - typedef typename DoFHandler::active_cell_iterator cell_iterator; + using cell_iterator = typename DoFHandler::active_cell_iterator; // Mark a small block at the corner of the hypercube cell_iterator cell = dof_handler.begin_active(), endc = dof_handler.end(); diff --git a/tests/grid/grid_tools_halo_layer_ghost_cells.cc b/tests/grid/grid_tools_halo_layer_ghost_cells.cc index 93770ffde8..a920d512da 100644 --- a/tests/grid/grid_tools_halo_layer_ghost_cells.cc +++ b/tests/grid/grid_tools_halo_layer_ghost_cells.cc @@ -37,9 +37,8 @@ test() GridGenerator::hyper_cube(tria); tria.refine_global(2); - typedef - typename parallel::distributed::Triangulation::active_cell_iterator - cell_iterator; + using cell_iterator = + typename parallel::distributed::Triangulation::active_cell_iterator; // Mark a small block at the corner of the hypercube std::vector ghost_cells_tria; diff --git a/tests/grid/move_constructor.cc b/tests/grid/move_constructor.cc index 8bf1ea8f3c..6af27e0ac8 100644 --- a/tests/grid/move_constructor.cc +++ b/tests/grid/move_constructor.cc @@ -97,9 +97,8 @@ test_periodic_cube() Triangulation tria; GridGenerator::hyper_cube(tria, -1.0, 1.0, true); - typedef GridTools::PeriodicFacePair< - typename Triangulation::cell_iterator> - periodic_face_pair; + using periodic_face_pair = + GridTools::PeriodicFacePair::cell_iterator>; std::vector periodicity_vector; GridTools::collect_periodic_faces(tria, 0, 1, 0, periodicity_vector); tria.add_periodicity(periodicity_vector); diff --git a/tests/hp/step-13.cc b/tests/hp/step-13.cc index ba84002071..f8f46f1016 100644 --- a/tests/hp/step-13.cc +++ b/tests/hp/step-13.cc @@ -349,7 +349,7 @@ namespace LaplaceSolver void Solver::assemble_linear_system(LinearSystem &linear_system) { - typedef typename DoFHandler::active_cell_iterator active_cell_iterator; + using active_cell_iterator = typename DoFHandler::active_cell_iterator; const unsigned int n_threads = MultithreadInfo::n_threads(); std::vector> diff --git a/tests/integrators/cells_and_faces_01.cc b/tests/integrators/cells_and_faces_01.cc index 120e26a171..c84ac80709 100644 --- a/tests/integrators/cells_and_faces_01.cc +++ b/tests/integrators/cells_and_faces_01.cc @@ -49,7 +49,7 @@ template class Local : public Subscriptor { public: - typedef EmptyInfo CellInfo; + using CellInfo = EmptyInfo; void cell(MeshWorker::DoFInfo &dinfo, CellInfo &info) const; diff --git a/tests/integrators/empty_info.h b/tests/integrators/empty_info.h index d29ebf040f..ebd2cda686 100644 --- a/tests/integrators/empty_info.h +++ b/tests/integrators/empty_info.h @@ -30,7 +30,7 @@ public: class EmptyInfoBox { public: - typedef EmptyInfo CellInfo; + using CellInfo = EmptyInfo; template void post_cell(const MeshWorker::DoFInfoBox &) diff --git a/tests/integrators/functional_01.cc b/tests/integrators/functional_01.cc index 6668bddcdb..5c8f88eaff 100644 --- a/tests/integrators/functional_01.cc +++ b/tests/integrators/functional_01.cc @@ -47,7 +47,7 @@ template class Local : public Subscriptor { public: - typedef EmptyInfo CellInfo; + using CellInfo = EmptyInfo; void cell(MeshWorker::DoFInfo &dinfo, CellInfo &info) const; diff --git a/tests/integrators/mesh_worker_01.cc b/tests/integrators/mesh_worker_01.cc index b9e42f8806..2fcedc565f 100644 --- a/tests/integrators/mesh_worker_01.cc +++ b/tests/integrators/mesh_worker_01.cc @@ -43,7 +43,7 @@ template class Local : public Subscriptor { public: - typedef MeshWorker::IntegrationInfo CellInfo; + using CellInfo = MeshWorker::IntegrationInfo; void cell(MeshWorker::DoFInfo &dinfo, CellInfo &info) const; diff --git a/tests/integrators/mesh_worker_matrix_01.cc b/tests/integrators/mesh_worker_matrix_01.cc index 0e5f0b9626..e8e8b33370 100644 --- a/tests/integrators/mesh_worker_matrix_01.cc +++ b/tests/integrators/mesh_worker_matrix_01.cc @@ -44,7 +44,7 @@ template class Local : public Subscriptor { public: - typedef MeshWorker::IntegrationInfo CellInfo; + using CellInfo = MeshWorker::IntegrationInfo; void cell(MeshWorker::DoFInfo &dinfo, CellInfo &info) const; diff --git a/tests/lac/block_linear_operator_05.cc b/tests/lac/block_linear_operator_05.cc index e482dcef4d..6900b21cd9 100644 --- a/tests/lac/block_linear_operator_05.cc +++ b/tests/lac/block_linear_operator_05.cc @@ -42,9 +42,8 @@ main(int argc, char *argv[]) auto op_b = linear_operator(b); - typedef LinearOperator - Op_MPI; + using Op_MPI = LinearOperator; auto op_c = block_diagonal_operator<2, TrilinosWrappers::MPI::BlockVector>( std::array({{op_a, op_a}})); diff --git a/tests/lac/constraints_hanging_nodes_bc.cc b/tests/lac/constraints_hanging_nodes_bc.cc index 8212144efd..0aee865ffd 100644 --- a/tests/lac/constraints_hanging_nodes_bc.cc +++ b/tests/lac/constraints_hanging_nodes_bc.cc @@ -117,8 +117,8 @@ test() AssertThrow(correct_constraints.is_constrained(i) == library_constraints.is_constrained(i), ExcInternalError()); - typedef const std::vector> - &constraint_format; + using constraint_format = + const std::vector> &; if (correct_constraints.is_constrained(i)) { constraint_format correct = diff --git a/tests/lac/diagonal_matrix_02.cc b/tests/lac/diagonal_matrix_02.cc index cfedbd588f..c959586311 100644 --- a/tests/lac/diagonal_matrix_02.cc +++ b/tests/lac/diagonal_matrix_02.cc @@ -50,7 +50,7 @@ template void test(const bool hanging_nodes = true) { - typedef double number; + using number = double; parallel::distributed::Triangulation tria(MPI_COMM_WORLD); GridGenerator::hyper_cube(tria); diff --git a/tests/lac/linear_operator_01.cc b/tests/lac/linear_operator_01.cc index 1724b4e1e9..d8014177eb 100644 --- a/tests/lac/linear_operator_01.cc +++ b/tests/lac/linear_operator_01.cc @@ -27,8 +27,8 @@ struct LeftVector { - typedef double value_type; - value_type value; + using value_type = double; + value_type value; LeftVector & operator=(value_type new_value) @@ -68,8 +68,8 @@ struct LeftVector struct RightVector { - typedef double value_type; - value_type value; + using value_type = double; + value_type value; RightVector & operator=(value_type new_value) @@ -114,7 +114,7 @@ main() // Create to distinct linear operators: - typedef dealii::internal::LinearOperatorImplementation::EmptyPayload Payload; + using Payload = dealii::internal::LinearOperatorImplementation::EmptyPayload; LinearOperator multiply2; multiply2.vmult = [](LeftVector &v, const RightVector &u) { v.value = 2 * u.value; diff --git a/tests/lac/linear_operator_01a.cc b/tests/lac/linear_operator_01a.cc index dc35fe6282..a7026d714a 100644 --- a/tests/lac/linear_operator_01a.cc +++ b/tests/lac/linear_operator_01a.cc @@ -30,8 +30,8 @@ struct LeftVector { - typedef std::complex value_type; - value_type value; + using value_type = std::complex; + value_type value; LeftVector & operator=(value_type new_value) @@ -71,8 +71,8 @@ struct LeftVector struct RightVector { - typedef std::complex value_type; - value_type value; + using value_type = std::complex; + value_type value; RightVector & operator=(value_type new_value) @@ -117,7 +117,7 @@ main() // Create to distinct linear operators: - typedef dealii::internal::LinearOperatorImplementation::EmptyPayload Payload; + using Payload = dealii::internal::LinearOperatorImplementation::EmptyPayload; LinearOperator multiply2; multiply2.vmult = [](LeftVector &v, const RightVector &u) { v.value = 2. * u.value; diff --git a/tests/lac/linear_operator_04a.cc b/tests/lac/linear_operator_04a.cc index 6f00651442..a4da501e1a 100644 --- a/tests/lac/linear_operator_04a.cc +++ b/tests/lac/linear_operator_04a.cc @@ -32,8 +32,8 @@ main(int argc, char *argv[]) initlog(); deallog << std::setprecision(10); - typedef TrilinosWrappers::MPI::Vector vector_t; - typedef TrilinosWrappers::SparseMatrix matrix_t; + using vector_t = TrilinosWrappers::MPI::Vector; + using matrix_t = TrilinosWrappers::SparseMatrix; matrix_t a(5U, 5U, 3U); a.compress(VectorOperation::add); diff --git a/tests/lac/linear_operator_08.cc b/tests/lac/linear_operator_08.cc index 2497cb90ee..5860755180 100644 --- a/tests/lac/linear_operator_08.cc +++ b/tests/lac/linear_operator_08.cc @@ -235,30 +235,30 @@ main() { deallog << "PreconditionChebyshev" << std::endl; - typedef PreconditionChebyshev> PREC; + using PREC = PreconditionChebyshev>; test_preconditioner(A, b); } { deallog << "PreconditionIdentity" << std::endl; - typedef PreconditionIdentity PREC; + using PREC = PreconditionIdentity; test_preconditioner(A, b); } { deallog << "PreconditionJacobi" << std::endl; - typedef PreconditionJacobi> PREC; + using PREC = PreconditionJacobi>; test_preconditioner(A, b); } { deallog << "PreconditionPSOR" << std::endl; - typedef PreconditionPSOR> PREC; - std::vector permutation(b.size()); + using PREC = PreconditionPSOR>; + std::vector permutation(b.size()); std::vector inverse_permutation(b.size()); test_preconditioner( A, b, typename PREC::AdditionalData(permutation, inverse_permutation)); } { deallog << "PreconditionRichardson" << std::endl; - typedef PreconditionRichardson PREC; + using PREC = PreconditionRichardson; test_preconditioner(A, b); } { @@ -283,28 +283,28 @@ main() } { deallog << "PreconditionSOR" << std::endl; - typedef PreconditionSOR> PREC; + using PREC = PreconditionSOR>; test_preconditioner(A, b); } { deallog << "PreconditionSSOR" << std::endl; - typedef PreconditionSSOR> PREC; + using PREC = PreconditionSSOR>; test_preconditioner(A, b); } { deallog << "SparseILU" << std::endl; - typedef SparseILU PREC; + using PREC = SparseILU; test_preconditioner(A, b); } { deallog << "SparseMIC" << std::endl; - typedef SparseMIC PREC; + using PREC = SparseMIC; test_preconditioner(A, b); } { deallog << "SparseVanka" << std::endl; - typedef SparseVanka PREC; - typedef typename PREC::AdditionalData PREC_AD; + using PREC = SparseVanka; + using PREC_AD = typename PREC::AdditionalData; test_preconditioner(A, b, PREC_AD(std::vector(rc, true))); } deallog.pop(); @@ -316,42 +316,42 @@ main() { deallog << "SolverBicgstab" << std::endl; - typedef SolverBicgstab> SLVR; + using SLVR = SolverBicgstab>; test_solver(A, b); } { deallog << "SolverCG" << std::endl; - typedef SolverCG> SLVR; + using SLVR = SolverCG>; test_solver(A, b); } { deallog << "SolverFGMRES" << std::endl; - typedef SolverFGMRES> SLVR; + using SLVR = SolverFGMRES>; test_solver(A, b); } { deallog << "SolverGMRES" << std::endl; - typedef SolverGMRES> SLVR; + using SLVR = SolverGMRES>; test_solver(A, b); } { deallog << "SolverMinRes" << std::endl; - typedef SolverMinRes> SLVR; + using SLVR = SolverMinRes>; test_solver(A, b); } { deallog << "SolverQMRS" << std::endl; - typedef SolverQMRS> SLVR; + using SLVR = SolverQMRS>; test_solver(A, b); } { deallog << "SolverRelaxation" << std::endl; - typedef SolverRelaxation> SLVR; + using SLVR = SolverRelaxation>; test_solver(A, b); } { deallog << "SolverRichardson" << std::endl; - typedef SolverRichardson> SLVR; + using SLVR = SolverRichardson>; test_solver(A, b); } { @@ -416,7 +416,7 @@ main() // === PRECONDITIONERS === { deallog << "PreconditionBlockIdentity" << std::endl; - typedef PreconditionBlockIdentity> PREC; + using PREC = PreconditionBlockIdentity>; test_preconditioner_block(A, b); } diff --git a/tests/lac/linear_operator_09.cc b/tests/lac/linear_operator_09.cc index 02c27a2bd4..f9dc592073 100644 --- a/tests/lac/linear_operator_09.cc +++ b/tests/lac/linear_operator_09.cc @@ -34,7 +34,7 @@ int main(int argc, char *argv[]) { - typedef PETScWrappers::MPI::SparseMatrix::size_type size_type; + using size_type = PETScWrappers::MPI::SparseMatrix::size_type; Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1); diff --git a/tests/lac/linear_operator_10.cc b/tests/lac/linear_operator_10.cc index 5a41367404..c579c4d7c1 100644 --- a/tests/lac/linear_operator_10.cc +++ b/tests/lac/linear_operator_10.cc @@ -60,9 +60,9 @@ test_preconditioner(const MATRIX & A, PRECONDITIONER preconditioner; preconditioner.initialize(A, data); - typedef TrilinosWrappers::SolverCG SOLVER; - SolverControl solver_control(100, 1.0e-10); - SOLVER solver(solver_control); + using SOLVER = TrilinosWrappers::SolverCG; + SolverControl solver_control(100, 1.0e-10); + SOLVER solver(solver_control); // Exact inverse const auto lo_A_inv = inverse_operator(lo_A, solver, preconditioner); @@ -125,9 +125,9 @@ test_preconditioner(const MATRIX & A, { // Stand-alone deallog.push("S.A."); - typedef dealii::TrilinosWrappers::internal::LinearOperatorImplementation:: - TrilinosPayload PAYLOAD; - const auto lo_A_inv_approx = + using PAYLOAD = dealii::TrilinosWrappers::internal:: + LinearOperatorImplementation::TrilinosPayload; + const auto lo_A_inv_approx = linear_operator(preconditioner); // Singular operation @@ -165,8 +165,8 @@ test_solver(const MATRIX &A, const VECTOR &b) SolverControl solver_control(100, 1.0e-10); SOLVER solver(solver_control); - typedef TrilinosWrappers::PreconditionJacobi PRECONDITIONER; - PRECONDITIONER preconditioner; + using PRECONDITIONER = TrilinosWrappers::PreconditionJacobi; + PRECONDITIONER preconditioner; preconditioner.initialize(A); { @@ -248,7 +248,7 @@ main(int argc, char *argv[]) { deallog.push("PreconditionAMG"); - typedef TrilinosWrappers::PreconditionAMG PREC; + using PREC = TrilinosWrappers::PreconditionAMG; test_preconditioner(A, b); test_preconditioner(A, c); deallog.pop(); @@ -257,7 +257,7 @@ main(int argc, char *argv[]) #ifdef DEAL_II_TRILINOS_WITH_MUELU { deallog.push("PreconditionAMGMueLu"); - typedef TrilinosWrappers::PreconditionAMGMueLu PREC; + using PREC = TrilinosWrappers::PreconditionAMGMueLu; test_preconditioner(A, b); test_preconditioner(A, c); deallog.pop(); @@ -266,7 +266,7 @@ main(int argc, char *argv[]) { deallog.push("PreconditionChebyshev"); - typedef TrilinosWrappers::PreconditionChebyshev PREC; + using PREC = TrilinosWrappers::PreconditionChebyshev; test_preconditioner(A, b); test_preconditioner(A, c); deallog.pop(); @@ -274,7 +274,7 @@ main(int argc, char *argv[]) { deallog.push("PreconditionIC"); - typedef TrilinosWrappers::PreconditionIC PREC; + using PREC = TrilinosWrappers::PreconditionIC; test_preconditioner(A, b); test_preconditioner(A, c); deallog.pop(); @@ -282,7 +282,7 @@ main(int argc, char *argv[]) { deallog.push("PreconditionIdentity"); - typedef TrilinosWrappers::PreconditionIdentity PREC; + using PREC = TrilinosWrappers::PreconditionIdentity; test_preconditioner(A, b); test_preconditioner(A, c); deallog.pop(); @@ -290,7 +290,7 @@ main(int argc, char *argv[]) { deallog.push("PreconditionILU"); - typedef TrilinosWrappers::PreconditionILU PREC; + using PREC = TrilinosWrappers::PreconditionILU; test_preconditioner(A, b); test_preconditioner(A, c); deallog.pop(); @@ -298,7 +298,7 @@ main(int argc, char *argv[]) { deallog.push("PreconditionILUT"); - typedef TrilinosWrappers::PreconditionILUT PREC; + using PREC = TrilinosWrappers::PreconditionILUT; test_preconditioner(A, b); test_preconditioner(A, c); deallog.pop(); @@ -306,7 +306,7 @@ main(int argc, char *argv[]) { deallog.push("PreconditionJacobi"); - typedef TrilinosWrappers::PreconditionJacobi PREC; + using PREC = TrilinosWrappers::PreconditionJacobi; test_preconditioner(A, b); test_preconditioner(A, c); deallog.pop(); @@ -314,7 +314,7 @@ main(int argc, char *argv[]) { deallog.push("PreconditionSOR"); - typedef TrilinosWrappers::PreconditionSOR PREC; + using PREC = TrilinosWrappers::PreconditionSOR; test_preconditioner(A, b); test_preconditioner(A, c); deallog.pop(); @@ -322,7 +322,7 @@ main(int argc, char *argv[]) { deallog.push("PreconditionSSOR"); - typedef TrilinosWrappers::PreconditionSSOR PREC; + using PREC = TrilinosWrappers::PreconditionSSOR; test_preconditioner(A, b); test_preconditioner(A, c); deallog.pop(); @@ -342,7 +342,7 @@ main(int argc, char *argv[]) // Note: Even though this test fails, we would still like to check // that we can build LinearOperators with this solver deallog.push("SolverBicgstab"); - typedef TrilinosWrappers::SolverBicgstab SLVR; + using SLVR = TrilinosWrappers::SolverBicgstab; test_solver(A, b); deallog.pop(); } @@ -356,14 +356,14 @@ main(int argc, char *argv[]) { deallog.push("SolverCG"); - typedef TrilinosWrappers::SolverCG SLVR; + using SLVR = TrilinosWrappers::SolverCG; test_solver(A, b); deallog.pop(); } { deallog.push("SolverCGS"); - typedef TrilinosWrappers::SolverCGS SLVR; + using SLVR = TrilinosWrappers::SolverCGS; test_solver(A, b); deallog.pop(); } @@ -372,10 +372,10 @@ main(int argc, char *argv[]) // the LinearOperator class. // { // deallog.push("SolverDirect"); - // typedef TrilinosWrappers::SolverDirect SLVR; + // using SLVR = TrilinosWrappers::SolverDirect; // // test_solver (A, b); // - // typedef dealii::TrilinosWrappers::MPI::Vector VectorType; + // using VectorType = dealii::TrilinosWrappers::MPI::Vector; // typedef // dealii::TrilinosWrappers::internal::LinearOperatorImplementation::TrilinosPayload // PayloadType; @@ -415,7 +415,7 @@ main(int argc, char *argv[]) { deallog.push("SolverGMRES"); - typedef TrilinosWrappers::SolverGMRES SLVR; + using SLVR = TrilinosWrappers::SolverGMRES; test_solver(A, b); deallog.pop(); } @@ -427,7 +427,7 @@ main(int argc, char *argv[]) // Note: Even though this test fails, we would still like to check // that we can build LinearOperators with this solver deallog.push("SolverTFQMR"); - typedef TrilinosWrappers::SolverTFQMR SLVR; + using SLVR = TrilinosWrappers::SolverTFQMR; test_solver(A, b); deallog.pop(); } diff --git a/tests/lac/linear_operator_10a.cc b/tests/lac/linear_operator_10a.cc index 27f2212747..411461223d 100644 --- a/tests/lac/linear_operator_10a.cc +++ b/tests/lac/linear_operator_10a.cc @@ -65,9 +65,9 @@ test_preconditioner(const MATRIX & A, PRECONDITIONER preconditioner; preconditioner.initialize(A, data); - typedef SolverCG SOLVER; - SolverControl solver_control(100, 1.0e-10, false, false); - SOLVER solver(solver_control); + using SOLVER = SolverCG; + SolverControl solver_control(100, 1.0e-10, false, false); + SOLVER solver(solver_control); // Exact inverse const auto lo_A_inv = inverse_operator(lo_A, solver, preconditioner); @@ -130,9 +130,9 @@ test_preconditioner(const MATRIX & A, { // Stand-alone deallog.push("S.A."); - typedef dealii::TrilinosWrappers::internal::LinearOperatorImplementation:: - TrilinosPayload PAYLOAD; - const auto lo_A_inv_approx = + using PAYLOAD = dealii::TrilinosWrappers::internal:: + LinearOperatorImplementation::TrilinosPayload; + const auto lo_A_inv_approx = linear_operator(preconditioner); // Singular operation @@ -170,8 +170,8 @@ test_solver(const MATRIX &A, const VECTOR &b) SolverControl solver_control(100, 1.0e-10, false, false); SOLVER solver(solver_control); - typedef TrilinosWrappers::PreconditionJacobi PRECONDITIONER; - PRECONDITIONER preconditioner; + using PRECONDITIONER = TrilinosWrappers::PreconditionJacobi; + PRECONDITIONER preconditioner; preconditioner.initialize(A); { @@ -253,7 +253,7 @@ main(int argc, char *argv[]) { deallog.push("PreconditionAMG"); - typedef TrilinosWrappers::PreconditionAMG PREC; + using PREC = TrilinosWrappers::PreconditionAMG; test_preconditioner(A, b); test_preconditioner(A, c); deallog.pop(); @@ -262,7 +262,7 @@ main(int argc, char *argv[]) #ifdef DEAL_II_TRILINOS_WITH_MUELU { deallog.push("PreconditionAMGMueLu"); - typedef TrilinosWrappers::PreconditionAMGMueLu PREC; + using PREC = TrilinosWrappers::PreconditionAMGMueLu; test_preconditioner(A, b); test_preconditioner(A, c); deallog.pop(); @@ -271,7 +271,7 @@ main(int argc, char *argv[]) { deallog.push("PreconditionChebyshev"); - typedef TrilinosWrappers::PreconditionChebyshev PREC; + using PREC = TrilinosWrappers::PreconditionChebyshev; test_preconditioner(A, b); test_preconditioner(A, c); deallog.pop(); @@ -279,7 +279,7 @@ main(int argc, char *argv[]) { deallog.push("PreconditionIC"); - typedef TrilinosWrappers::PreconditionIC PREC; + using PREC = TrilinosWrappers::PreconditionIC; test_preconditioner(A, b); test_preconditioner(A, c); deallog.pop(); @@ -287,7 +287,7 @@ main(int argc, char *argv[]) { deallog.push("PreconditionIdentity"); - typedef TrilinosWrappers::PreconditionIdentity PREC; + using PREC = TrilinosWrappers::PreconditionIdentity; test_preconditioner(A, b); test_preconditioner(A, c); deallog.pop(); @@ -295,7 +295,7 @@ main(int argc, char *argv[]) { deallog.push("PreconditionILU"); - typedef TrilinosWrappers::PreconditionILU PREC; + using PREC = TrilinosWrappers::PreconditionILU; test_preconditioner(A, b); test_preconditioner(A, c); deallog.pop(); @@ -303,7 +303,7 @@ main(int argc, char *argv[]) { deallog.push("PreconditionILUT"); - typedef TrilinosWrappers::PreconditionILUT PREC; + using PREC = TrilinosWrappers::PreconditionILUT; test_preconditioner(A, b); test_preconditioner(A, c); deallog.pop(); @@ -311,7 +311,7 @@ main(int argc, char *argv[]) { deallog.push("PreconditionJacobi"); - typedef TrilinosWrappers::PreconditionJacobi PREC; + using PREC = TrilinosWrappers::PreconditionJacobi; test_preconditioner(A, b); test_preconditioner(A, c); deallog.pop(); @@ -319,7 +319,7 @@ main(int argc, char *argv[]) { deallog.push("PreconditionSOR"); - typedef TrilinosWrappers::PreconditionSOR PREC; + using PREC = TrilinosWrappers::PreconditionSOR; test_preconditioner(A, b); test_preconditioner(A, c); deallog.pop(); @@ -327,7 +327,7 @@ main(int argc, char *argv[]) { deallog.push("PreconditionSSOR"); - typedef TrilinosWrappers::PreconditionSSOR PREC; + using PREC = TrilinosWrappers::PreconditionSSOR; test_preconditioner(A, b); test_preconditioner(A, c); deallog.pop(); @@ -342,49 +342,49 @@ main(int argc, char *argv[]) { deallog.push("SolverBicgstab"); - typedef SolverBicgstab SLVR; + using SLVR = SolverBicgstab; test_solver(A, b); deallog.pop(); } { deallog.push("SolverCG"); - typedef SolverCG SLVR; + using SLVR = SolverCG; test_solver(A, b); deallog.pop(); } { deallog.push("SolverGMRES"); - typedef SolverGMRES SLVR; + using SLVR = SolverGMRES; test_solver(A, b); deallog.pop(); } { deallog.push("SolverFGMRES"); - typedef SolverFGMRES SLVR; + using SLVR = SolverFGMRES; test_solver(A, b); deallog.pop(); } { deallog.push("SolverMinRes"); - typedef SolverMinRes SLVR; + using SLVR = SolverMinRes; test_solver(A, b); deallog.pop(); } { deallog.push("SolverQMRS"); - typedef SolverQMRS SLVR; + using SLVR = SolverQMRS; test_solver(A, b); deallog.pop(); } { deallog.push("SolverRichardson"); - typedef SolverRichardson SLVR; + using SLVR = SolverRichardson; test_solver(A, b); deallog.pop(); } diff --git a/tests/lac/linear_operator_11.cc b/tests/lac/linear_operator_11.cc index 4d7f9cdcd0..937c8d113b 100644 --- a/tests/lac/linear_operator_11.cc +++ b/tests/lac/linear_operator_11.cc @@ -236,8 +236,8 @@ Step4::solve() deallog.pop(); } - typedef TrilinosWrappers::MPI::Vector VectorType; - VectorType output(solution); + using VectorType = TrilinosWrappers::MPI::Vector; + VectorType output(solution); { deallog.push("Trilinos_CG_SSOR"); output = 0; diff --git a/tests/lac/linear_operator_12.cc b/tests/lac/linear_operator_12.cc index 1d58b116ec..5ae900a8f8 100644 --- a/tests/lac/linear_operator_12.cc +++ b/tests/lac/linear_operator_12.cc @@ -284,7 +284,7 @@ template void Step4::solve() { - typedef TrilinosWrappers::MPI::Vector VectorType; + using VectorType = TrilinosWrappers::MPI::Vector; // Compute 'reference' solution with direct solver VectorType temp_solution(system_rhs); diff --git a/tests/lac/linear_operator_12a.cc b/tests/lac/linear_operator_12a.cc index 95cbdf2277..4dcf0bd96c 100644 --- a/tests/lac/linear_operator_12a.cc +++ b/tests/lac/linear_operator_12a.cc @@ -285,7 +285,7 @@ template void Step4::solve() { - typedef TrilinosWrappers::MPI::Vector VectorType; + using VectorType = TrilinosWrappers::MPI::Vector; // Compute 'reference' solution with direct solver VectorType temp_solution(system_rhs); diff --git a/tests/lac/linear_operator_13.cc b/tests/lac/linear_operator_13.cc index 3687dbaa23..15b7474e52 100644 --- a/tests/lac/linear_operator_13.cc +++ b/tests/lac/linear_operator_13.cc @@ -143,13 +143,13 @@ void evaluate_ops(const TrilinosWrappers::BlockSparseMatrix &matrix, const TrilinosWrappers::MPI::BlockVector & vector) { - const double tol = 1e-12; - typedef dealii::TrilinosWrappers::SparseMatrix MatrixType; - typedef dealii::TrilinosWrappers::MPI::Vector VectorType; - typedef dealii::TrilinosWrappers::internal::LinearOperatorImplementation:: - TrilinosPayload PayloadType; - typedef typename PayloadType::VectorType PayloadVectorType; - typedef dealii::types::global_dof_index size_type; + const double tol = 1e-12; + using MatrixType = dealii::TrilinosWrappers::SparseMatrix; + using VectorType = dealii::TrilinosWrappers::MPI::Vector; + using PayloadType = dealii::TrilinosWrappers::internal:: + LinearOperatorImplementation::TrilinosPayload; + using PayloadVectorType = typename PayloadType::VectorType; + using size_type = dealii::types::global_dof_index; deallog.push("System info"); { diff --git a/tests/lac/linear_operator_14.cc b/tests/lac/linear_operator_14.cc index 55d68d263f..dd47485844 100644 --- a/tests/lac/linear_operator_14.cc +++ b/tests/lac/linear_operator_14.cc @@ -189,13 +189,13 @@ void evaluate_ops(const TrilinosWrappers::BlockSparseMatrix &matrix, const TrilinosWrappers::MPI::BlockVector & vector) { - const double tol = 1e-12; - typedef dealii::TrilinosWrappers::SparseMatrix MatrixType; - typedef dealii::TrilinosWrappers::MPI::Vector VectorType; - typedef dealii::TrilinosWrappers::internal::LinearOperatorImplementation:: - TrilinosPayload PayloadType; - typedef typename PayloadType::VectorType PayloadVectorType; - typedef dealii::types::global_dof_index size_type; + const double tol = 1e-12; + using MatrixType = dealii::TrilinosWrappers::SparseMatrix; + using VectorType = dealii::TrilinosWrappers::MPI::Vector; + using PayloadType = dealii::TrilinosWrappers::internal:: + LinearOperatorImplementation::TrilinosPayload; + using PayloadVectorType = typename PayloadType::VectorType; + using size_type = dealii::types::global_dof_index; deallog.push("System info"); { diff --git a/tests/lac/linear_operator_18.cc b/tests/lac/linear_operator_18.cc index 1ff91bb7ad..c42313129a 100644 --- a/tests/lac/linear_operator_18.cc +++ b/tests/lac/linear_operator_18.cc @@ -32,8 +32,8 @@ main(int argc, char *argv[]) initlog(); deallog << std::setprecision(10); - typedef LinearAlgebra::distributed::Vector vector_t; - typedef TrilinosWrappers::SparseMatrix matrix_t; + using vector_t = LinearAlgebra::distributed::Vector; + using matrix_t = TrilinosWrappers::SparseMatrix; matrix_t a(5U, 4U, 3U); a.compress(VectorOperation::add); diff --git a/tests/lac/qr.cc b/tests/lac/qr.cc index aff4f82edf..3225a2a4e4 100644 --- a/tests/lac/qr.cc +++ b/tests/lac/qr.cc @@ -62,8 +62,8 @@ template void test() { - typedef Vector VectorType; - QR qr; + using VectorType = Vector; + QR qr; const unsigned int v_size = 5; VectorType v(v_size); diff --git a/tests/lac/qr_02.cc b/tests/lac/qr_02.cc index b6d7757098..886d9bdcb9 100644 --- a/tests/lac/qr_02.cc +++ b/tests/lac/qr_02.cc @@ -101,8 +101,8 @@ template void test() { - typedef Vector VectorType; - QR qr; + using VectorType = Vector; + QR qr; auto print_givens = [](const unsigned int i, const unsigned int j, diff --git a/tests/lac/qr_03.cc b/tests/lac/qr_03.cc index d23f77f785..d9286b2884 100644 --- a/tests/lac/qr_03.cc +++ b/tests/lac/qr_03.cc @@ -64,7 +64,7 @@ template void test() { - typedef Vector VectorType; + using VectorType = Vector; ImplicitQR qr; const unsigned int v_size = 5; diff --git a/tests/lac/qr_04.cc b/tests/lac/qr_04.cc index bc8924607d..8af5e33c91 100644 --- a/tests/lac/qr_04.cc +++ b/tests/lac/qr_04.cc @@ -101,7 +101,7 @@ template void test() { - typedef Vector VectorType; + using VectorType = Vector; ImplicitQR qr; auto print_givens = [](const unsigned int i, diff --git a/tests/lac/qr_05.cc b/tests/lac/qr_05.cc index ad1157e689..ec6125f0c4 100644 --- a/tests/lac/qr_05.cc +++ b/tests/lac/qr_05.cc @@ -54,8 +54,8 @@ template void test() { - typedef Vector VectorType; - QR qr; + using VectorType = Vector; + QR qr; const unsigned int v_size = 5; VectorType v(v_size); diff --git a/tests/lac/qr_06.cc b/tests/lac/qr_06.cc index dafd9b1ec8..34a830aefc 100644 --- a/tests/lac/qr_06.cc +++ b/tests/lac/qr_06.cc @@ -58,8 +58,8 @@ template void test() { - typedef Vector VectorType; - QR qr; + using VectorType = Vector; + QR qr; const unsigned int v_size = 5; VectorType v(v_size); diff --git a/tests/lac/qr_07.cc b/tests/lac/qr_07.cc index ba4f812478..7dff22e0e5 100644 --- a/tests/lac/qr_07.cc +++ b/tests/lac/qr_07.cc @@ -59,7 +59,7 @@ template void test() { - typedef Vector VectorType; + using VectorType = Vector; ImplicitQR qr; const unsigned int v_size = 5; diff --git a/tests/lac/qr_08.cc b/tests/lac/qr_08.cc index bcb4b03872..51debcdee1 100644 --- a/tests/lac/qr_08.cc +++ b/tests/lac/qr_08.cc @@ -139,8 +139,8 @@ template void test() { - typedef Vector VectorType; - QR qr; + using VectorType = Vector; + QR qr; const unsigned int v_size = 6; VectorType v(v_size); diff --git a/tests/lac/qr_09.cc b/tests/lac/qr_09.cc index dc82cbb78e..d9b10dc28d 100644 --- a/tests/lac/qr_09.cc +++ b/tests/lac/qr_09.cc @@ -123,7 +123,7 @@ template void test() { - typedef Vector VectorType; + using VectorType = Vector; QR qr; ImplicitQR pqr; diff --git a/tests/lac/qr_10.cc b/tests/lac/qr_10.cc index 52f8c60be2..28b0097697 100644 --- a/tests/lac/qr_10.cc +++ b/tests/lac/qr_10.cc @@ -66,7 +66,7 @@ template void test() { - typedef Vector VectorType; + using VectorType = Vector; ImplicitQR qr; const unsigned int v_size = 5; diff --git a/tests/lac/schur_complement_04.cc b/tests/lac/schur_complement_04.cc index 2bf823d02c..96c79fe1dc 100644 --- a/tests/lac/schur_complement_04.cc +++ b/tests/lac/schur_complement_04.cc @@ -94,8 +94,8 @@ main(int argc, char **argv) */ - const unsigned int rc = 1; - typedef TrilinosWrappers::MPI::Vector VectorType; + const unsigned int rc = 1; + using VectorType = TrilinosWrappers::MPI::Vector; TrilinosWrappers::SparseMatrix A(rc, rc, rc); TrilinosWrappers::SparseMatrix B(rc, rc, rc); diff --git a/tests/matrix_free/advect_1d.cc b/tests/matrix_free/advect_1d.cc index 929d10685f..c27bc0e180 100644 --- a/tests/matrix_free/advect_1d.cc +++ b/tests/matrix_free/advect_1d.cc @@ -131,11 +131,11 @@ private: data, true, 0, 0, start_vector_component); FEFaceEvaluation phi_p( data, false, 0, 0, start_vector_component); - typedef typename FEFaceEvaluation::value_type value_type; + using value_type = typename FEFaceEvaluation::value_type; for (unsigned int face = face_range.first; face < face_range.second; face++) { @@ -175,12 +175,12 @@ private: const std::pair &face_range) const { FEFaceEvaluation - fe_eval(data, true, 0, 0, start_vector_component); - typedef typename FEFaceEvaluation::value_type value_type; + fe_eval(data, true, 0, 0, start_vector_component); + using value_type = typename FEFaceEvaluation::value_type; for (unsigned int face = face_range.first; face < face_range.second; face++) { diff --git a/tests/matrix_free/advect_1d_system.cc b/tests/matrix_free/advect_1d_system.cc index 4db30ed364..5e7edd4829 100644 --- a/tests/matrix_free/advect_1d_system.cc +++ b/tests/matrix_free/advect_1d_system.cc @@ -138,11 +138,11 @@ private: data, true, 0, 0, start_vector_component); FEFaceEvaluation phi_p( data, false, 0, 0, start_vector_component); - typedef typename FEFaceEvaluation::value_type value_type; + using value_type = typename FEFaceEvaluation::value_type; for (unsigned int face = face_range.first; face < face_range.second; face++) { @@ -182,12 +182,12 @@ private: const std::pair &face_range) const { FEFaceEvaluation - fe_eval(data, true, 0, 0, start_vector_component); - typedef typename FEFaceEvaluation::value_type value_type; + fe_eval(data, true, 0, 0, start_vector_component); + using value_type = typename FEFaceEvaluation::value_type; for (unsigned int face = face_range.first; face < face_range.second; face++) { diff --git a/tests/matrix_free/advect_1d_vectorization_mask.cc b/tests/matrix_free/advect_1d_vectorization_mask.cc index 230b332308..17cd4cc222 100644 --- a/tests/matrix_free/advect_1d_vectorization_mask.cc +++ b/tests/matrix_free/advect_1d_vectorization_mask.cc @@ -137,11 +137,11 @@ private: data, true, 0, 0, start_vector_component); FEFaceEvaluation phi_p( data, false, 0, 0, start_vector_component); - typedef typename FEFaceEvaluation::value_type value_type; + using value_type = typename FEFaceEvaluation::value_type; const unsigned int n_vect = VectorizedArray::size(); @@ -193,12 +193,12 @@ private: const std::pair &face_range) const { FEFaceEvaluation - fe_eval(data, true, 0, 0, start_vector_component); - typedef typename FEFaceEvaluation::value_type value_type; + fe_eval(data, true, 0, 0, start_vector_component); + using value_type = typename FEFaceEvaluation::value_type; const unsigned int n_vect = VectorizedArray::size(); diff --git a/tests/matrix_free/compare_faces_by_cells.cc b/tests/matrix_free/compare_faces_by_cells.cc index 5e200c5991..bdbfcdae9a 100644 --- a/tests/matrix_free/compare_faces_by_cells.cc +++ b/tests/matrix_free/compare_faces_by_cells.cc @@ -51,7 +51,7 @@ template class MatrixFreeTest { public: - typedef typename DoFHandler::active_cell_iterator CellIterator; - typedef double Number; + using CellIterator = typename DoFHandler::active_cell_iterator; + using Number = double; MatrixFreeTest(const MatrixFree &data_in) : data(data_in){}; @@ -68,7 +68,7 @@ public: const VectorType & src, const std::pair &cell_range) const { - typedef VectorizedArray vector_t; + using vector_t = VectorizedArray; // allocate FEEvaluation. This test will test proper alignment AlignedVector> velocity; diff --git a/tests/matrix_free/estimate_condition_number_mass.cc b/tests/matrix_free/estimate_condition_number_mass.cc index 6df78f7b8f..0ab24550fa 100644 --- a/tests/matrix_free/estimate_condition_number_mass.cc +++ b/tests/matrix_free/estimate_condition_number_mass.cc @@ -75,7 +75,7 @@ template class MatrixFreeTest { public: - typedef VectorizedArray vector_t; + using vector_t = VectorizedArray; MatrixFreeTest(const MatrixFree &data_in) : data(data_in){}; @@ -102,7 +102,7 @@ template void test(const FiniteElement &fe, const unsigned int n_iterations) { - typedef double number; + using number = double; Triangulation tria; GridGenerator::hyper_cube(tria); diff --git a/tests/matrix_free/faces_value_optimization.cc b/tests/matrix_free/faces_value_optimization.cc index d495d287fe..ab305ef853 100644 --- a/tests/matrix_free/faces_value_optimization.cc +++ b/tests/matrix_free/faces_value_optimization.cc @@ -208,7 +208,7 @@ test() AffineConstraints constraints; constraints.close(); - typedef double number; + using number = double; MatrixFree mf_data; { diff --git a/tests/matrix_free/faces_value_optimization_02.cc b/tests/matrix_free/faces_value_optimization_02.cc index 5dcb0ff071..86c282b90d 100644 --- a/tests/matrix_free/faces_value_optimization_02.cc +++ b/tests/matrix_free/faces_value_optimization_02.cc @@ -208,7 +208,7 @@ test() AffineConstraints constraints; constraints.close(); - typedef double number; + using number = double; MatrixFree mf_data; { diff --git a/tests/matrix_free/get_functions_gl.cc b/tests/matrix_free/get_functions_gl.cc index 120b8d3b40..13be5776b4 100644 --- a/tests/matrix_free/get_functions_gl.cc +++ b/tests/matrix_free/get_functions_gl.cc @@ -31,7 +31,7 @@ template void test() { - typedef double number; + using number = double; const SphericalManifold manifold; Triangulation tria; GridGenerator::hyper_ball(tria); diff --git a/tests/matrix_free/get_functions_mappingq.cc b/tests/matrix_free/get_functions_mappingq.cc index 2bf3fd9c35..00ce36569e 100644 --- a/tests/matrix_free/get_functions_mappingq.cc +++ b/tests/matrix_free/get_functions_mappingq.cc @@ -30,7 +30,7 @@ template void test() { - typedef double number; + using number = double; const SphericalManifold manifold; Triangulation tria; GridGenerator::hyper_ball(tria); diff --git a/tests/matrix_free/get_functions_multife.cc b/tests/matrix_free/get_functions_multife.cc index cb1432826a..0b836d9fa0 100644 --- a/tests/matrix_free/get_functions_multife.cc +++ b/tests/matrix_free/get_functions_multife.cc @@ -52,7 +52,7 @@ template > VectorType; + using VectorType = std::vector>; MatrixFreeTest(const MatrixFree &data_in) : data(data_in) @@ -206,7 +206,7 @@ template void test() { - typedef double number; + using number = double; Triangulation tria; GridGenerator::hyper_cube(tria); tria.refine_global(1); diff --git a/tests/matrix_free/get_functions_multife2.cc b/tests/matrix_free/get_functions_multife2.cc index c5e3851956..e3792da3cf 100644 --- a/tests/matrix_free/get_functions_multife2.cc +++ b/tests/matrix_free/get_functions_multife2.cc @@ -54,7 +54,7 @@ template > VectorType; + using VectorType = std::vector>; MatrixFreeTest(const MatrixFree &data_in) : data(data_in) @@ -247,7 +247,7 @@ template void test() { - typedef double number; + using number = double; Triangulation tria; GridGenerator::hyper_cube(tria); tria.refine_global(1); diff --git a/tests/matrix_free/get_functions_notempl.cc b/tests/matrix_free/get_functions_notempl.cc index 5fe59876e5..1b9e7b01d4 100644 --- a/tests/matrix_free/get_functions_notempl.cc +++ b/tests/matrix_free/get_functions_notempl.cc @@ -52,7 +52,7 @@ template void test() { - typedef double number; + using number = double; const SphericalManifold manifold; Triangulation tria; GridGenerator::hyper_ball(tria); diff --git a/tests/matrix_free/get_functions_q_hierarchical.cc b/tests/matrix_free/get_functions_q_hierarchical.cc index 7ca704858f..4778e5ea48 100644 --- a/tests/matrix_free/get_functions_q_hierarchical.cc +++ b/tests/matrix_free/get_functions_q_hierarchical.cc @@ -38,7 +38,7 @@ template void test() { - typedef double number; + using number = double; const SphericalManifold manifold; Triangulation tria; GridGenerator::hyper_ball(tria); diff --git a/tests/matrix_free/get_functions_rect.cc b/tests/matrix_free/get_functions_rect.cc index eb0072dd77..fcd743e0f1 100644 --- a/tests/matrix_free/get_functions_rect.cc +++ b/tests/matrix_free/get_functions_rect.cc @@ -52,7 +52,7 @@ template void test() { - typedef double number; + using number = double; const SphericalManifold manifold; Triangulation tria; GridGenerator::hyper_ball(tria); diff --git a/tests/matrix_free/get_functions_variants.cc b/tests/matrix_free/get_functions_variants.cc index 2d24772755..945e506992 100644 --- a/tests/matrix_free/get_functions_variants.cc +++ b/tests/matrix_free/get_functions_variants.cc @@ -48,7 +48,7 @@ template class MatrixFreeTest { public: - typedef Vector VectorType; + using VectorType = Vector; MatrixFreeTest(const MatrixFree &data_in) : data(data_in){}; diff --git a/tests/matrix_free/get_functions_variants_gl.cc b/tests/matrix_free/get_functions_variants_gl.cc index 89919d5ea8..b8f72bc509 100644 --- a/tests/matrix_free/get_functions_variants_gl.cc +++ b/tests/matrix_free/get_functions_variants_gl.cc @@ -44,7 +44,7 @@ template class MatrixFreeTest { public: - typedef Vector VectorType; + using VectorType = Vector; MatrixFreeTest(const MatrixFree &data_in) : data(data_in){}; diff --git a/tests/matrix_free/integrate_functions.cc b/tests/matrix_free/integrate_functions.cc index 4f5f3d0403..d5496289fb 100644 --- a/tests/matrix_free/integrate_functions.cc +++ b/tests/matrix_free/integrate_functions.cc @@ -49,7 +49,7 @@ template class MatrixFreeTest { public: - typedef std::vector *> VectorType; + using VectorType = std::vector *>; MatrixFreeTest(const MatrixFree &data_in) : data(data_in) @@ -151,7 +151,7 @@ template void test() { - typedef double number; + using number = double; const SphericalManifold manifold; Triangulation tria; GridGenerator::hyper_ball(tria); diff --git a/tests/matrix_free/integrate_functions_multife.cc b/tests/matrix_free/integrate_functions_multife.cc index e65ae60de0..fc2767347f 100644 --- a/tests/matrix_free/integrate_functions_multife.cc +++ b/tests/matrix_free/integrate_functions_multife.cc @@ -50,7 +50,7 @@ template class MatrixFreeTest { public: - typedef std::vector> VectorType; + using VectorType = std::vector>; MatrixFreeTest(const MatrixFree &data_in) : data(data_in) diff --git a/tests/matrix_free/integrate_functions_multife2.cc b/tests/matrix_free/integrate_functions_multife2.cc index e98c2a0809..baabbdb981 100644 --- a/tests/matrix_free/integrate_functions_multife2.cc +++ b/tests/matrix_free/integrate_functions_multife2.cc @@ -53,7 +53,7 @@ template class MatrixFreeTest { public: - typedef std::vector> VectorType; + using VectorType = std::vector>; MatrixFreeTest(const MatrixFree &data_in) : data(data_in) diff --git a/tests/matrix_free/laplace_operator_01.cc b/tests/matrix_free/laplace_operator_01.cc index da80af12ed..f31a0ecba6 100644 --- a/tests/matrix_free/laplace_operator_01.cc +++ b/tests/matrix_free/laplace_operator_01.cc @@ -49,7 +49,7 @@ template void test() { - typedef double number; + using number = double; parallel::distributed::Triangulation tria(MPI_COMM_WORLD); GridGenerator::hyper_cube(tria); diff --git a/tests/matrix_free/laplace_operator_02.cc b/tests/matrix_free/laplace_operator_02.cc index a69c57974d..789e234fa2 100644 --- a/tests/matrix_free/laplace_operator_02.cc +++ b/tests/matrix_free/laplace_operator_02.cc @@ -89,8 +89,8 @@ template void test() { - typedef double number; - F function(3, 1); + using number = double; + F function(3, 1); parallel::distributed::Triangulation tria(MPI_COMM_WORLD); GridGenerator::hyper_cube(tria); diff --git a/tests/matrix_free/laplace_operator_03.cc b/tests/matrix_free/laplace_operator_03.cc index ef666ea2e6..7e521ac181 100644 --- a/tests/matrix_free/laplace_operator_03.cc +++ b/tests/matrix_free/laplace_operator_03.cc @@ -49,7 +49,7 @@ template void test() { - typedef double number; + using number = double; parallel::distributed::Triangulation tria(MPI_COMM_WORLD); GridGenerator::hyper_cube(tria); diff --git a/tests/matrix_free/mass_operator_01.cc b/tests/matrix_free/mass_operator_01.cc index ae347994c7..7df8d5f886 100644 --- a/tests/matrix_free/mass_operator_01.cc +++ b/tests/matrix_free/mass_operator_01.cc @@ -57,7 +57,7 @@ template void test() { - typedef double number; + using number = double; parallel::distributed::Triangulation tria(MPI_COMM_WORLD); GridGenerator::hyper_cube(tria); diff --git a/tests/matrix_free/mass_operator_02.cc b/tests/matrix_free/mass_operator_02.cc index aa12b4fc86..53c4d1cf1c 100644 --- a/tests/matrix_free/mass_operator_02.cc +++ b/tests/matrix_free/mass_operator_02.cc @@ -50,7 +50,7 @@ template void test() { - typedef double number; + using number = double; parallel::distributed::Triangulation tria(MPI_COMM_WORLD); GridGenerator::hyper_cube(tria); diff --git a/tests/matrix_free/mass_operator_03.cc b/tests/matrix_free/mass_operator_03.cc index 15e17d32f0..b3cf9e1150 100644 --- a/tests/matrix_free/mass_operator_03.cc +++ b/tests/matrix_free/mass_operator_03.cc @@ -51,7 +51,7 @@ template void test() { - typedef double number; + using number = double; parallel::distributed::Triangulation tria(MPI_COMM_WORLD); GridGenerator::hyper_cube(tria); diff --git a/tests/matrix_free/mass_operator_04.cc b/tests/matrix_free/mass_operator_04.cc index ad6bbd6e2a..a25bb69ed2 100644 --- a/tests/matrix_free/mass_operator_04.cc +++ b/tests/matrix_free/mass_operator_04.cc @@ -46,7 +46,7 @@ template void test() { - typedef double number; + using number = double; parallel::distributed::Triangulation tria(MPI_COMM_WORLD); GridGenerator::hyper_cube(tria); diff --git a/tests/matrix_free/matrix_vector_10.cc b/tests/matrix_free/matrix_vector_10.cc index 52b2b573d2..3fdb8e61f1 100644 --- a/tests/matrix_free/matrix_vector_10.cc +++ b/tests/matrix_free/matrix_vector_10.cc @@ -56,7 +56,7 @@ template void test() { - typedef double number; + using number = double; parallel::distributed::Triangulation tria(MPI_COMM_WORLD); GridGenerator::hyper_cube(tria); diff --git a/tests/matrix_free/matrix_vector_11.cc b/tests/matrix_free/matrix_vector_11.cc index e74ab0c0c6..baa61d81e1 100644 --- a/tests/matrix_free/matrix_vector_11.cc +++ b/tests/matrix_free/matrix_vector_11.cc @@ -49,7 +49,7 @@ template void test() { - typedef double number; + using number = double; parallel::distributed::Triangulation tria(MPI_COMM_WORLD); GridGenerator::hyper_cube(tria); diff --git a/tests/matrix_free/matrix_vector_12.cc b/tests/matrix_free/matrix_vector_12.cc index a67a8b3a88..5e21936dc2 100644 --- a/tests/matrix_free/matrix_vector_12.cc +++ b/tests/matrix_free/matrix_vector_12.cc @@ -82,8 +82,8 @@ template class MatrixFreeTest { public: - typedef VectorizedArray vector_t; - static const std::size_t n_vectors = VectorizedArray::size(); + using vector_t = VectorizedArray; + static const std::size_t n_vectors = VectorizedArray::size(); MatrixFreeTest(const MatrixFree &data_in) : data(data_in){}; @@ -114,7 +114,7 @@ template void test() { - typedef double number; + using number = double; parallel::distributed::Triangulation tria(MPI_COMM_WORLD); GridGenerator::hyper_cube(tria); diff --git a/tests/matrix_free/matrix_vector_13.cc b/tests/matrix_free/matrix_vector_13.cc index 52bbdfb85c..4518e9f502 100644 --- a/tests/matrix_free/matrix_vector_13.cc +++ b/tests/matrix_free/matrix_vector_13.cc @@ -82,8 +82,8 @@ template class MatrixFreeTest { public: - typedef VectorizedArray vector_t; - static const std::size_t n_vectors = VectorizedArray::size(); + using vector_t = VectorizedArray; + static const std::size_t n_vectors = VectorizedArray::size(); MatrixFreeTest(const MatrixFree &data_in) : data(data_in){}; @@ -112,7 +112,7 @@ template void test() { - typedef double number; + using number = double; parallel::distributed::Triangulation tria(MPI_COMM_WORLD); GridGenerator::hyper_cube(tria); diff --git a/tests/matrix_free/matrix_vector_19.cc b/tests/matrix_free/matrix_vector_19.cc index b481e5bbe8..ee27059f77 100644 --- a/tests/matrix_free/matrix_vector_19.cc +++ b/tests/matrix_free/matrix_vector_19.cc @@ -50,7 +50,7 @@ template void test() { - typedef double number; + using number = double; parallel::shared::Triangulation tria( MPI_COMM_WORLD, diff --git a/tests/matrix_free/matrix_vector_20.cc b/tests/matrix_free/matrix_vector_20.cc index 9088fdd9bc..c1ba0f16d6 100644 --- a/tests/matrix_free/matrix_vector_20.cc +++ b/tests/matrix_free/matrix_vector_20.cc @@ -94,8 +94,8 @@ template class MatrixFreeTest { public: - typedef VectorizedArray vector_t; - static const std::size_t n_vectors = VectorizedArray::size(); + using vector_t = VectorizedArray; + static const std::size_t n_vectors = VectorizedArray::size(); MatrixFreeTest(const MatrixFree &data_in) : data(data_in){}; @@ -125,7 +125,7 @@ template void test() { - typedef double number; + using number = double; Triangulation tria; GridGenerator::hyper_cube(tria); diff --git a/tests/matrix_free/matrix_vector_21.cc b/tests/matrix_free/matrix_vector_21.cc index d4a054650b..85fef93c8b 100644 --- a/tests/matrix_free/matrix_vector_21.cc +++ b/tests/matrix_free/matrix_vector_21.cc @@ -84,8 +84,8 @@ template class MatrixFreeTest { public: - typedef VectorizedArray vector_t; - static const std::size_t n_vectors = VectorizedArray::size(); + using vector_t = VectorizedArray; + static const std::size_t n_vectors = VectorizedArray::size(); MatrixFreeTest(const MatrixFree &data_in) : data(data_in){}; @@ -115,7 +115,7 @@ template void test() { - typedef double number; + using number = double; Triangulation tria; GridGenerator::hyper_cube(tria); diff --git a/tests/matrix_free/matrix_vector_22.cc b/tests/matrix_free/matrix_vector_22.cc index eff583f7fc..752af23c32 100644 --- a/tests/matrix_free/matrix_vector_22.cc +++ b/tests/matrix_free/matrix_vector_22.cc @@ -83,8 +83,8 @@ template class MatrixFreeTest { public: - typedef VectorizedArray vector_t; - static const std::size_t n_vectors = VectorizedArray::size(); + using vector_t = VectorizedArray; + static const std::size_t n_vectors = VectorizedArray::size(); MatrixFreeTest(const MatrixFree &data_in) : data(data_in){}; @@ -115,7 +115,7 @@ template void test() { - typedef double number; + using number = double; parallel::distributed::Triangulation tria(MPI_COMM_WORLD); GridGenerator::hyper_cube(tria); diff --git a/tests/matrix_free/matrix_vector_23.cc b/tests/matrix_free/matrix_vector_23.cc index 6cf998969a..fc4ca90bee 100644 --- a/tests/matrix_free/matrix_vector_23.cc +++ b/tests/matrix_free/matrix_vector_23.cc @@ -95,8 +95,8 @@ template class MatrixFreeTest { public: - typedef VectorizedArray vector_t; - static const std::size_t n_vectors = VectorizedArray::size(); + using vector_t = VectorizedArray; + static const std::size_t n_vectors = VectorizedArray::size(); MatrixFreeTest(const MatrixFree &data_in) : data(data_in){}; @@ -127,7 +127,7 @@ template void test() { - typedef double number; + using number = double; parallel::distributed::Triangulation tria(MPI_COMM_WORLD); GridGenerator::hyper_cube(tria); diff --git a/tests/matrix_free/matrix_vector_24.cc b/tests/matrix_free/matrix_vector_24.cc index 9791a65823..4768e957d9 100644 --- a/tests/matrix_free/matrix_vector_24.cc +++ b/tests/matrix_free/matrix_vector_24.cc @@ -50,7 +50,7 @@ template vector_t; + using vector_t = VectorizedArray; MatrixFreeVariant(const MatrixFree &data_in) : data(data_in) diff --git a/tests/matrix_free/matrix_vector_blocks.cc b/tests/matrix_free/matrix_vector_blocks.cc index 2ed5668a92..37ad92a2ec 100644 --- a/tests/matrix_free/matrix_vector_blocks.cc +++ b/tests/matrix_free/matrix_vector_blocks.cc @@ -99,7 +99,7 @@ template void test() { - typedef double number; + using number = double; parallel::distributed::Triangulation tria(MPI_COMM_WORLD); GridGenerator::hyper_cube(tria); diff --git a/tests/matrix_free/matrix_vector_curl.cc b/tests/matrix_free/matrix_vector_curl.cc index 9323a28595..ee6e9cb16d 100644 --- a/tests/matrix_free/matrix_vector_curl.cc +++ b/tests/matrix_free/matrix_vector_curl.cc @@ -57,8 +57,8 @@ template class MatrixFreeTest { public: - typedef typename DoFHandler::active_cell_iterator CellIterator; - typedef double Number; + using CellIterator = typename DoFHandler::active_cell_iterator; + using Number = double; MatrixFreeTest(const MatrixFree &data_in) : data(data_in){}; @@ -69,7 +69,7 @@ public: const VectorType & src, const std::pair &cell_range) const { - typedef VectorizedArray vector_t; + using vector_t = VectorizedArray; FEEvaluation phi(data); vector_t coeff = make_vectorized_array(global_coefficient); diff --git a/tests/matrix_free/matrix_vector_div.cc b/tests/matrix_free/matrix_vector_div.cc index fb8a00ac7c..3676552224 100644 --- a/tests/matrix_free/matrix_vector_div.cc +++ b/tests/matrix_free/matrix_vector_div.cc @@ -59,8 +59,8 @@ template class MatrixFreeTest { public: - typedef typename DoFHandler::active_cell_iterator CellIterator; - typedef double Number; + using CellIterator = typename DoFHandler::active_cell_iterator; + using Number = double; MatrixFreeTest(const MatrixFree &data_in) : data(data_in){}; @@ -71,7 +71,7 @@ public: const VectorType & src, const std::pair &cell_range) const { - typedef VectorizedArray vector_t; + using vector_t = VectorizedArray; FEEvaluation phi(data); vector_t coeff = make_vectorized_array(global_coefficient); @@ -264,7 +264,7 @@ test() system_matrix.vmult(solution, system_rhs); - typedef std::vector> VectorType; + using VectorType = std::vector>; MatrixFreeTest mf(mf_data); mf.vmult(vec2, vec1); diff --git a/tests/matrix_free/matrix_vector_faces_common.h b/tests/matrix_free/matrix_vector_faces_common.h index c2bdeccddf..1ddd76e44b 100644 --- a/tests/matrix_free/matrix_vector_faces_common.h +++ b/tests/matrix_free/matrix_vector_faces_common.h @@ -136,13 +136,13 @@ private: number, VectorizedArrayType> fe_eval_neighbor(data, false); - typedef + using value_type = typename FEFaceEvaluation::value_type value_type; + VectorizedArrayType>::value_type; const int actual_degree = data.get_dof_handler().get_fe().degree; for (unsigned int face = face_range.first; face < face_range.second; face++) @@ -202,13 +202,13 @@ private: number, VectorizedArrayType> fe_eval(data, true); - typedef + using value_type = typename FEFaceEvaluation::value_type value_type; + VectorizedArrayType>::value_type; const int actual_degree = data.get_dof_handler().get_fe().degree; for (unsigned int face = face_range.first; face < face_range.second; face++) { @@ -340,13 +340,13 @@ private: number, VectorizedArrayType> fe_eval_neighbor(data, false, 0, 0, start_vector_component); - typedef + using value_type = typename FEFaceEvaluation::value_type value_type; + VectorizedArrayType>::value_type; const int actual_degree = data.get_dof_handler().get_fe().degree; for (unsigned int face = face_range.first; face < face_range.second; face++) @@ -408,13 +408,13 @@ private: number, VectorizedArrayType> fe_eval(data, true, 0, 0, start_vector_component); - typedef + using value_type = typename FEFaceEvaluation::value_type value_type; + VectorizedArrayType>::value_type; const int actual_degree = data.get_dof_handler().get_fe().degree; for (unsigned int face = face_range.first; face < face_range.second; face++) { @@ -578,13 +578,13 @@ private: number, VectorizedArrayType> phi_p(data, false, 0, 0, start_vector_component); - typedef + using value_type = typename FEFaceEvaluation::value_type value_type; + VectorizedArrayType>::value_type; for (unsigned int face = face_range.first; face < face_range.second; face++) { @@ -626,14 +626,14 @@ private: number, VectorizedArrayType> fe_eval(data, true, 0, 0, start_vector_component); - typedef + using value_type = typename FEFaceEvaluation::value_type value_type; - value_type u_plus; + VectorizedArrayType>::value_type; + value_type u_plus; u_plus = make_vectorized_array(1.3); for (unsigned int face = face_range.first; face < face_range.second; face++) diff --git a/tests/matrix_free/matrix_vector_hp.cc b/tests/matrix_free/matrix_vector_hp.cc index dbf4028d09..ac18292b62 100644 --- a/tests/matrix_free/matrix_vector_hp.cc +++ b/tests/matrix_free/matrix_vector_hp.cc @@ -111,7 +111,7 @@ test() if (fe_degree > 1) return; - typedef double number; + using number = double; const SphericalManifold manifold; Triangulation tria; GridGenerator::hyper_ball(tria); diff --git a/tests/matrix_free/matrix_vector_hp_no_template.cc b/tests/matrix_free/matrix_vector_hp_no_template.cc index 660349b3d1..fe8915a07d 100644 --- a/tests/matrix_free/matrix_vector_hp_no_template.cc +++ b/tests/matrix_free/matrix_vector_hp_no_template.cc @@ -76,7 +76,7 @@ test() if (fe_degree > 1) return; - typedef double number; + using number = double; const SphericalManifold manifold; Triangulation tria; GridGenerator::hyper_ball(tria); diff --git a/tests/matrix_free/matrix_vector_hp_parallel_01.cc b/tests/matrix_free/matrix_vector_hp_parallel_01.cc index 0635b85abd..fbc2aceecb 100644 --- a/tests/matrix_free/matrix_vector_hp_parallel_01.cc +++ b/tests/matrix_free/matrix_vector_hp_parallel_01.cc @@ -117,7 +117,7 @@ test() if (fe_degree > 1) return; - typedef double number; + using number = double; const SphericalManifold manifold; parallel::distributed::Triangulation tria(MPI_COMM_WORLD); GridGenerator::hyper_ball(tria); diff --git a/tests/matrix_free/matrix_vector_large_degree_02.cc b/tests/matrix_free/matrix_vector_large_degree_02.cc index 98ab770ba5..6a0fea3d97 100644 --- a/tests/matrix_free/matrix_vector_large_degree_02.cc +++ b/tests/matrix_free/matrix_vector_large_degree_02.cc @@ -50,7 +50,7 @@ template void test() { - typedef double number; + using number = double; Triangulation tria; GridGenerator::hyper_cube(tria); diff --git a/tests/matrix_free/matrix_vector_mf.h b/tests/matrix_free/matrix_vector_mf.h index 8a77fccac9..03b8553f3e 100644 --- a/tests/matrix_free/matrix_vector_mf.h +++ b/tests/matrix_free/matrix_vector_mf.h @@ -35,7 +35,7 @@ helmholtz_operator(const MatrixFree &data, const VectorType & src, const std::pair &cell_range) { - typedef typename VectorType::value_type Number; + using Number = typename VectorType::value_type; FEEvaluation fe_eval(data); const unsigned int n_q_points = fe_eval.n_q_points; @@ -66,8 +66,8 @@ helmholtz_operator_no_template( const unsigned int active_fe_index, const unsigned int active_quad_index) { - typedef typename VectorType::value_type Number; - FEEvaluation fe_eval( + using Number = typename VectorType::value_type; + FEEvaluation fe_eval( data, 0, 0, 0, active_fe_index, active_quad_index); const unsigned int n_q_points = fe_eval.n_q_points; @@ -96,7 +96,7 @@ template vector_t; + using vector_t = VectorizedArray; MatrixFreeTest(const MatrixFree &data_in) : data(data_in) diff --git a/tests/matrix_free/matrix_vector_mg.cc b/tests/matrix_free/matrix_vector_mg.cc index ccfbdec34c..f074be9e45 100644 --- a/tests/matrix_free/matrix_vector_mg.cc +++ b/tests/matrix_free/matrix_vector_mg.cc @@ -83,8 +83,8 @@ test() system_matrix.reinit(sparsity); // setup MG levels - const unsigned int nlevels = tria.n_levels(); - typedef MatrixFree MatrixFreeTestType; + const unsigned int nlevels = tria.n_levels(); + using MatrixFreeTestType = MatrixFree; MGLevelObject mg_matrices; MGLevelObject> mg_constraints; MGLevelObject mg_sparsities; diff --git a/tests/matrix_free/matrix_vector_stokes.cc b/tests/matrix_free/matrix_vector_stokes.cc index 73ca41dcd7..0a4fc0316d 100644 --- a/tests/matrix_free/matrix_vector_stokes.cc +++ b/tests/matrix_free/matrix_vector_stokes.cc @@ -57,8 +57,8 @@ template class MatrixFreeTest { public: - typedef typename DoFHandler::active_cell_iterator CellIterator; - typedef double Number; + using CellIterator = typename DoFHandler::active_cell_iterator; + using Number = double; MatrixFreeTest(const MatrixFree &data_in) : data(data_in){}; @@ -69,7 +69,7 @@ public: const VectorType & src, const std::pair &cell_range) const { - typedef VectorizedArray vector_t; + using vector_t = VectorizedArray; FEEvaluation velocity(data, 0); FEEvaluation pressure(data, 1); @@ -295,7 +295,7 @@ test() system_matrix.vmult(solution, system_rhs); - typedef std::vector> VectorType; + using VectorType = std::vector>; MatrixFreeTest mf(mf_data); mf.vmult(vec2, vec1); diff --git a/tests/matrix_free/matrix_vector_stokes_base.cc b/tests/matrix_free/matrix_vector_stokes_base.cc index 18253664bc..00f0b6ed2e 100644 --- a/tests/matrix_free/matrix_vector_stokes_base.cc +++ b/tests/matrix_free/matrix_vector_stokes_base.cc @@ -39,8 +39,8 @@ template class MatrixFreeTest : public MatrixFreeOperators::Base { public: - typedef typename BlockVectorType::value_type Number; - typedef typename MatrixFreeOperators::Base Base; + using Number = typename BlockVectorType::value_type; + using Base = typename MatrixFreeOperators::Base; void compute_diagonal() @@ -62,7 +62,7 @@ protected: const BlockVectorType & src, const std::pair &cell_range) const { - typedef VectorizedArray vector_t; + using vector_t = VectorizedArray; FEEvaluation velocity(data, 0); FEEvaluation pressure(data, 1); diff --git a/tests/matrix_free/matrix_vector_stokes_flux.cc b/tests/matrix_free/matrix_vector_stokes_flux.cc index 648a55c0cf..510c0b6949 100644 --- a/tests/matrix_free/matrix_vector_stokes_flux.cc +++ b/tests/matrix_free/matrix_vector_stokes_flux.cc @@ -60,8 +60,8 @@ template class MatrixFreeTest { public: - typedef typename DoFHandler::active_cell_iterator CellIterator; - typedef double Number; + using CellIterator = typename DoFHandler::active_cell_iterator; + using Number = double; MatrixFreeTest(const MatrixFree &data_in) : data(data_in) @@ -73,7 +73,7 @@ public: const VectorType & src, const std::pair &cell_range) const { - typedef VectorizedArray vector_t; + using vector_t = VectorizedArray; FEEvaluation velocity(data, 0, 0, diff --git a/tests/matrix_free/matrix_vector_stokes_noflux.cc b/tests/matrix_free/matrix_vector_stokes_noflux.cc index 7f4e88da90..adcefb5211 100644 --- a/tests/matrix_free/matrix_vector_stokes_noflux.cc +++ b/tests/matrix_free/matrix_vector_stokes_noflux.cc @@ -57,8 +57,8 @@ template class MatrixFreeTest { public: - typedef typename DoFHandler::active_cell_iterator CellIterator; - typedef double Number; + using CellIterator = typename DoFHandler::active_cell_iterator; + using Number = double; MatrixFreeTest(const MatrixFree &data_in) : data(data_in){}; @@ -69,7 +69,7 @@ public: const VectorType & src, const std::pair &cell_range) const { - typedef VectorizedArray vector_t; + using vector_t = VectorizedArray; FEEvaluation velocity(data, 0); FEEvaluation pressure(data, 1); diff --git a/tests/matrix_free/matrix_vector_stokes_notempl.cc b/tests/matrix_free/matrix_vector_stokes_notempl.cc index f4f4d226cf..990e4a3226 100644 --- a/tests/matrix_free/matrix_vector_stokes_notempl.cc +++ b/tests/matrix_free/matrix_vector_stokes_notempl.cc @@ -54,8 +54,8 @@ template class MatrixFreeTest { public: - typedef typename DoFHandler::active_cell_iterator CellIterator; - typedef double Number; + using CellIterator = typename DoFHandler::active_cell_iterator; + using Number = double; MatrixFreeTest(const MatrixFree &data_in) : data(data_in){}; @@ -66,7 +66,7 @@ public: const VectorType & src, const std::pair &cell_range) const { - typedef VectorizedArray vector_t; + using vector_t = VectorizedArray; FEEvaluation velocity(data, 0); FEEvaluation pressure(data, 1); diff --git a/tests/matrix_free/matrix_vector_stokes_onedof.cc b/tests/matrix_free/matrix_vector_stokes_onedof.cc index 53d3d1cf55..ffa91c7e28 100644 --- a/tests/matrix_free/matrix_vector_stokes_onedof.cc +++ b/tests/matrix_free/matrix_vector_stokes_onedof.cc @@ -58,8 +58,8 @@ template class MatrixFreeTest { public: - typedef typename DoFHandler::active_cell_iterator CellIterator; - typedef double Number; + using CellIterator = typename DoFHandler::active_cell_iterator; + using Number = double; MatrixFreeTest(const MatrixFree &data_in) : data(data_in){}; @@ -70,7 +70,7 @@ public: const VectorType & src, const std::pair &cell_range) const { - typedef VectorizedArray vector_t; + using vector_t = VectorizedArray; FEEvaluation velocity(data, 0, 0, diff --git a/tests/matrix_free/matrix_vector_stokes_qdg0.cc b/tests/matrix_free/matrix_vector_stokes_qdg0.cc index 25e877dec7..6a1b9fa2fe 100644 --- a/tests/matrix_free/matrix_vector_stokes_qdg0.cc +++ b/tests/matrix_free/matrix_vector_stokes_qdg0.cc @@ -58,8 +58,8 @@ template class MatrixFreeTest { public: - typedef typename DoFHandler::active_cell_iterator CellIterator; - typedef double Number; + using CellIterator = typename DoFHandler::active_cell_iterator; + using Number = double; MatrixFreeTest(const MatrixFree &data_in) : data(data_in){}; @@ -70,7 +70,7 @@ public: const VectorType & src, const std::pair &cell_range) const { - typedef VectorizedArray vector_t; + using vector_t = VectorizedArray; FEEvaluation velocity(data, 0); FEEvaluation pressure(data, 1); @@ -297,7 +297,7 @@ test() system_matrix.vmult(solution, system_rhs); - typedef std::vector> VectorType; + using VectorType = std::vector>; MatrixFreeTest mf(mf_data); mf.vmult(vec2, vec1); diff --git a/tests/matrix_free/matrix_vector_stokes_qdg0b.cc b/tests/matrix_free/matrix_vector_stokes_qdg0b.cc index 5996466cbe..3512777ce0 100644 --- a/tests/matrix_free/matrix_vector_stokes_qdg0b.cc +++ b/tests/matrix_free/matrix_vector_stokes_qdg0b.cc @@ -59,8 +59,8 @@ template class MatrixFreeTest { public: - typedef typename DoFHandler::active_cell_iterator CellIterator; - typedef double Number; + using CellIterator = typename DoFHandler::active_cell_iterator; + using Number = double; MatrixFreeTest(const MatrixFree &data_in) : data(data_in){}; @@ -71,7 +71,7 @@ public: const VectorType & src, const std::pair &cell_range) const { - typedef VectorizedArray vector_t; + using vector_t = VectorizedArray; FEEvaluation velocity(data, 0); FEEvaluation pressure(data, 1); @@ -294,8 +294,8 @@ test(const unsigned int fe_degree) system_matrix.vmult(solution, system_rhs); - typedef std::vector> VectorType; - MatrixFreeTest mf(mf_data); + using VectorType = std::vector>; + MatrixFreeTest mf(mf_data); mf.vmult(vec2, vec1); // Verification diff --git a/tests/matrix_free/multigrid_dg_periodic.cc b/tests/matrix_free/multigrid_dg_periodic.cc index 08d012120a..f8354ea66b 100644 --- a/tests/matrix_free/multigrid_dg_periodic.cc +++ b/tests/matrix_free/multigrid_dg_periodic.cc @@ -59,7 +59,7 @@ template class LaplaceOperator : public Subscriptor { public: - typedef number value_type; + using value_type = number; LaplaceOperator(){}; @@ -545,7 +545,7 @@ do_test(const DoFHandler &dof, const unsigned int n_q_points_1d) in = 1.; // set up multigrid in analogy to step-37 - typedef LaplaceOperator LevelMatrixType; + using LevelMatrixType = LaplaceOperator; MGLevelObject mg_matrices; mg_matrices.resize(0, dof.get_triangulation().n_global_levels() - 1); @@ -558,9 +558,9 @@ do_test(const DoFHandler &dof, const unsigned int n_q_points_1d) MGCoarseIterative mg_coarse; mg_coarse.initialize(mg_matrices[0]); - typedef PreconditionChebyshev> - SMOOTHER; + using SMOOTHER = + PreconditionChebyshev>; MGSmootherPrecondition> diff --git a/tests/matrix_free/multigrid_dg_sip_01.cc b/tests/matrix_free/multigrid_dg_sip_01.cc index 4149a28792..8d51236ec0 100644 --- a/tests/matrix_free/multigrid_dg_sip_01.cc +++ b/tests/matrix_free/multigrid_dg_sip_01.cc @@ -58,7 +58,7 @@ template class LaplaceOperator : public Subscriptor { public: - typedef number value_type; + using value_type = number; LaplaceOperator(){}; @@ -554,7 +554,7 @@ do_test(const DoFHandler &dof, const unsigned n_q_points_1d) in = 1.; // set up multigrid in analogy to step-37 - typedef LaplaceOperator LevelMatrixType; + using LevelMatrixType = LaplaceOperator; MGLevelObject mg_matrices; mg_matrices.resize(0, dof.get_triangulation().n_global_levels() - 1); @@ -568,9 +568,9 @@ do_test(const DoFHandler &dof, const unsigned n_q_points_1d) MGCoarseIterative mg_coarse; mg_coarse.initialize(mg_matrices[0]); - typedef PreconditionChebyshev> - SMOOTHER; + using SMOOTHER = + PreconditionChebyshev>; MGSmootherPrecondition> diff --git a/tests/matrix_free/multigrid_dg_sip_02.cc b/tests/matrix_free/multigrid_dg_sip_02.cc index 7b82ffe11b..f8281cddc7 100644 --- a/tests/matrix_free/multigrid_dg_sip_02.cc +++ b/tests/matrix_free/multigrid_dg_sip_02.cc @@ -59,7 +59,7 @@ template class LaplaceOperator : public Subscriptor { public: - typedef number value_type; + using value_type = number; LaplaceOperator(){}; @@ -460,7 +460,7 @@ do_test(const DoFHandler &dof, const unsigned int n_q_points_1d) in = 1.; // set up multigrid in analogy to step-37 - typedef LaplaceOperator LevelMatrixType; + using LevelMatrixType = LaplaceOperator; MGLevelObject mg_matrices; mg_matrices.resize(0, dof.get_triangulation().n_global_levels() - 1); @@ -474,9 +474,9 @@ do_test(const DoFHandler &dof, const unsigned int n_q_points_1d) MGCoarseIterative mg_coarse; mg_coarse.initialize(mg_matrices[0]); - typedef PreconditionChebyshev> - SMOOTHER; + using SMOOTHER = + PreconditionChebyshev>; MGSmootherPrecondition> diff --git a/tests/matrix_free/parallel_multigrid.cc b/tests/matrix_free/parallel_multigrid.cc index 125c601dbb..f0f085b465 100644 --- a/tests/matrix_free/parallel_multigrid.cc +++ b/tests/matrix_free/parallel_multigrid.cc @@ -363,8 +363,8 @@ do_test(const DoFHandler &dof) in = 1.; // set up multigrid in analogy to step-37 - typedef LaplaceOperator - LevelMatrixType; + using LevelMatrixType = + LaplaceOperator; MGLevelObject mg_matrices; mg_matrices.resize(0, dof.get_triangulation().n_global_levels() - 1); @@ -381,9 +381,9 @@ do_test(const DoFHandler &dof) MGCoarseIterative mg_coarse; mg_coarse.initialize(mg_matrices[0]); - typedef PreconditionChebyshev> - SMOOTHER; + using SMOOTHER = + PreconditionChebyshev>; MGSmootherPrecondition> diff --git a/tests/matrix_free/parallel_multigrid_02.cc b/tests/matrix_free/parallel_multigrid_02.cc index 502521d8a0..eec7041995 100644 --- a/tests/matrix_free/parallel_multigrid_02.cc +++ b/tests/matrix_free/parallel_multigrid_02.cc @@ -151,12 +151,12 @@ do_test(const DoFHandler &dof) in = 1.; // set up multigrid in analogy to step-37 - typedef LaplaceOperator> - LevelMatrixType; + using LevelMatrixType = + LaplaceOperator>; MGLevelObject mg_matrices; MGLevelObject> mg_level_data; @@ -197,9 +197,9 @@ do_test(const DoFHandler &dof) MGCoarseIterative mg_coarse; mg_coarse.initialize(mg_matrices[0]); - typedef PreconditionChebyshev> - SMOOTHER; + using SMOOTHER = + PreconditionChebyshev>; MGSmootherPrecondition> diff --git a/tests/matrix_free/parallel_multigrid_adaptive_01.cc b/tests/matrix_free/parallel_multigrid_adaptive_01.cc index 112bdbcee0..e249f0d769 100644 --- a/tests/matrix_free/parallel_multigrid_adaptive_01.cc +++ b/tests/matrix_free/parallel_multigrid_adaptive_01.cc @@ -539,8 +539,8 @@ do_test(const DoFHandler &dof) in.local_element(i) = 1.; // set up multigrid in analogy to step-37 - typedef LaplaceOperator - LevelMatrixType; + using LevelMatrixType = + LaplaceOperator; MGLevelObject mg_matrices; mg_matrices.resize(0, dof.get_triangulation().n_global_levels() - 1); @@ -565,9 +565,9 @@ do_test(const DoFHandler &dof) MGCoarseIterative mg_coarse; mg_coarse.initialize(mg_matrices[0]); - typedef PreconditionChebyshev> - SMOOTHER; + using SMOOTHER = + PreconditionChebyshev>; MGSmootherPrecondition> diff --git a/tests/matrix_free/parallel_multigrid_adaptive_02.cc b/tests/matrix_free/parallel_multigrid_adaptive_02.cc index ab5be7e828..a03fd425e3 100644 --- a/tests/matrix_free/parallel_multigrid_adaptive_02.cc +++ b/tests/matrix_free/parallel_multigrid_adaptive_02.cc @@ -201,12 +201,12 @@ do_test(const DoFHandler &dof) } // set up multigrid in analogy to step-37 - typedef LaplaceOperator> - LevelMatrixType; + using LevelMatrixType = + LaplaceOperator>; MGLevelObject mg_matrices; MGLevelObject> mg_level_data; @@ -256,9 +256,9 @@ do_test(const DoFHandler &dof) MGCoarseIterative mg_coarse; mg_coarse.initialize(mg_matrices[0]); - typedef PreconditionChebyshev> - SMOOTHER; + using SMOOTHER = + PreconditionChebyshev>; MGSmootherPrecondition> diff --git a/tests/matrix_free/parallel_multigrid_adaptive_03.cc b/tests/matrix_free/parallel_multigrid_adaptive_03.cc index 69a95e3863..1c8582ba1f 100644 --- a/tests/matrix_free/parallel_multigrid_adaptive_03.cc +++ b/tests/matrix_free/parallel_multigrid_adaptive_03.cc @@ -58,7 +58,7 @@ template &dof, const bool threaded) in.local_element(i) = 1.; // set up multigrid in analogy to step-37 - typedef LaplaceOperator - LevelMatrixType; + using LevelMatrixType = + LaplaceOperator; MGLevelObject mg_matrices; mg_matrices.resize(0, dof.get_triangulation().n_global_levels() - 1); @@ -575,9 +575,9 @@ do_test(const DoFHandler &dof, const bool threaded) MGCoarseIterative mg_coarse; mg_coarse.initialize(mg_matrices[0]); - typedef PreconditionChebyshev> - SMOOTHER; + using SMOOTHER = + PreconditionChebyshev>; MGSmootherPrecondition> diff --git a/tests/matrix_free/parallel_multigrid_adaptive_04.cc b/tests/matrix_free/parallel_multigrid_adaptive_04.cc index f4ff27044f..ecd39e11ca 100644 --- a/tests/matrix_free/parallel_multigrid_adaptive_04.cc +++ b/tests/matrix_free/parallel_multigrid_adaptive_04.cc @@ -201,12 +201,12 @@ do_test(const DoFHandler &dof) } // set up multigrid in analogy to step-37 - typedef LaplaceOperator> - LevelMatrixType; + using LevelMatrixType = + LaplaceOperator>; MGLevelObject mg_matrices; MGLevelObject> mg_level_data; @@ -256,9 +256,9 @@ do_test(const DoFHandler &dof) MGCoarseIterative mg_coarse; mg_coarse.initialize(mg_matrices[0]); - typedef PreconditionChebyshev> - SMOOTHER; + using SMOOTHER = + PreconditionChebyshev>; mg::SmootherRelaxation> mg_smoother; diff --git a/tests/matrix_free/parallel_multigrid_adaptive_05.cc b/tests/matrix_free/parallel_multigrid_adaptive_05.cc index 10af8b4820..069f004b31 100644 --- a/tests/matrix_free/parallel_multigrid_adaptive_05.cc +++ b/tests/matrix_free/parallel_multigrid_adaptive_05.cc @@ -55,7 +55,7 @@ template &dof, const bool threaded) in.local_element(i) = 1.; // set up multigrid in analogy to step-37 - typedef LaplaceOperator - LevelMatrixType; + using LevelMatrixType = + LaplaceOperator; MGLevelObject mg_matrices; mg_matrices.resize(0, dof.get_triangulation().n_global_levels() - 1); @@ -572,9 +572,9 @@ do_test(const DoFHandler &dof, const bool threaded) MGCoarseIterative mg_coarse; mg_coarse.initialize(mg_matrices[0]); - typedef PreconditionChebyshev> - SMOOTHER; + using SMOOTHER = + PreconditionChebyshev>; MGSmootherPrecondition> diff --git a/tests/matrix_free/parallel_multigrid_adaptive_06.cc b/tests/matrix_free/parallel_multigrid_adaptive_06.cc index b17a08d117..86a0078b86 100644 --- a/tests/matrix_free/parallel_multigrid_adaptive_06.cc +++ b/tests/matrix_free/parallel_multigrid_adaptive_06.cc @@ -79,8 +79,8 @@ template &dof, const unsigned int nb) } // set up multigrid in analogy to step-37 - typedef BlockLaplace> - LevelMatrixType; + using LevelMatrixType = + BlockLaplace>; MGLevelObject mg_matrices; MGLevelObject> mg_level_data; @@ -347,7 +347,7 @@ do_test(const DoFHandler &dof, const unsigned int nb) MGCoarseIterative mg_coarse; mg_coarse.initialize(mg_matrices[0]); - typedef PreconditionJacobi SMOOTHER; + using SMOOTHER = PreconditionJacobi; MGSmootherPrecondition> diff --git a/tests/matrix_free/parallel_multigrid_adaptive_06ref.cc b/tests/matrix_free/parallel_multigrid_adaptive_06ref.cc index f83983f149..3611bf46f4 100644 --- a/tests/matrix_free/parallel_multigrid_adaptive_06ref.cc +++ b/tests/matrix_free/parallel_multigrid_adaptive_06ref.cc @@ -202,12 +202,12 @@ do_test(const DoFHandler &dof) } // set up multigrid in analogy to step-37 - typedef LaplaceOperator> - LevelMatrixType; + using LevelMatrixType = + LaplaceOperator>; MGLevelObject mg_matrices; MGLevelObject> mg_level_data; @@ -257,7 +257,7 @@ do_test(const DoFHandler &dof) MGCoarseIterative mg_coarse; mg_coarse.initialize(mg_matrices[0]); - typedef PreconditionJacobi SMOOTHER; + using SMOOTHER = PreconditionJacobi; MGSmootherPrecondition> diff --git a/tests/matrix_free/parallel_multigrid_adaptive_07.cc b/tests/matrix_free/parallel_multigrid_adaptive_07.cc index d58cbb863a..711a5885ba 100644 --- a/tests/matrix_free/parallel_multigrid_adaptive_07.cc +++ b/tests/matrix_free/parallel_multigrid_adaptive_07.cc @@ -72,8 +72,8 @@ template *> &dof) } // set up multigrid in analogy to step-37 - typedef BlockLaplace> - LevelMatrixType; + using LevelMatrixType = + BlockLaplace>; MGLevelObject mg_matrices; MGLevelObject> mg_level_data; @@ -383,7 +383,7 @@ do_test(const std::vector *> &dof) MGCoarseIterative mg_coarse; mg_coarse.initialize(mg_matrices[0]); - typedef PreconditionJacobi SMOOTHER; + using SMOOTHER = PreconditionJacobi; MGSmootherPrecondition> diff --git a/tests/matrix_free/parallel_multigrid_adaptive_08.cc b/tests/matrix_free/parallel_multigrid_adaptive_08.cc index 103c214855..04e0c5427d 100644 --- a/tests/matrix_free/parallel_multigrid_adaptive_08.cc +++ b/tests/matrix_free/parallel_multigrid_adaptive_08.cc @@ -327,9 +327,9 @@ do_test(const DoFHandler &dof) MGCoarseIterative mg_coarse; mg_coarse.initialize(mg_matrices[0]); - typedef PreconditionChebyshev> - SMOOTHER; + using SMOOTHER = + PreconditionChebyshev>; MGSmootherPrecondition> diff --git a/tests/matrix_free/parallel_multigrid_fullydistributed.cc b/tests/matrix_free/parallel_multigrid_fullydistributed.cc index cd7f36afdc..36dc78a95a 100644 --- a/tests/matrix_free/parallel_multigrid_fullydistributed.cc +++ b/tests/matrix_free/parallel_multigrid_fullydistributed.cc @@ -60,7 +60,7 @@ template &dof) in = 1.; // set up multigrid in analogy to step-37 - typedef LaplaceOperator - LevelMatrixType; + using LevelMatrixType = + LaplaceOperator; MGLevelObject mg_matrices; mg_matrices.resize(0, dof.get_triangulation().n_global_levels() - 1); @@ -388,9 +388,9 @@ do_test(const DoFHandler &dof) MGCoarseIterative mg_coarse; mg_coarse.initialize(mg_matrices[0]); - typedef PreconditionChebyshev> - SMOOTHER; + using SMOOTHER = + PreconditionChebyshev>; MGSmootherPrecondition> diff --git a/tests/matrix_free/parallel_multigrid_mf.cc b/tests/matrix_free/parallel_multigrid_mf.cc index 8943074e68..b9b4593be5 100644 --- a/tests/matrix_free/parallel_multigrid_mf.cc +++ b/tests/matrix_free/parallel_multigrid_mf.cc @@ -56,7 +56,7 @@ template &dof) in = 1.; // set up multigrid in analogy to step-37 - typedef LaplaceOperator - LevelMatrixType; + using LevelMatrixType = + LaplaceOperator; MGLevelObject mg_matrices; mg_matrices.resize(0, dof.get_triangulation().n_global_levels() - 1); @@ -384,9 +384,9 @@ do_test(const DoFHandler &dof) MGCoarseIterative mg_coarse; mg_coarse.initialize(mg_matrices[0]); - typedef PreconditionChebyshev> - SMOOTHER; + using SMOOTHER = + PreconditionChebyshev>; MGSmootherPrecondition> diff --git a/tests/matrix_free/parallel_multigrid_mf_02.cc b/tests/matrix_free/parallel_multigrid_mf_02.cc index 31f4362ca9..3451ed427e 100644 --- a/tests/matrix_free/parallel_multigrid_mf_02.cc +++ b/tests/matrix_free/parallel_multigrid_mf_02.cc @@ -138,13 +138,12 @@ do_test(const DoFHandler &dof) mg_constrained_dofs.initialize(dof); mg_constrained_dofs.make_zero_boundary_constraints(dof, {0}); - typedef MatrixFreeOperators::LaplaceOperator< + using LevelMatrixType = MatrixFreeOperators::LaplaceOperator< dim, fe_degree, n_q_points_1d, 1, - LinearAlgebra::distributed::Vector> - LevelMatrixType; + LinearAlgebra::distributed::Vector>; MGLevelObject mg_matrices; MGLevelObject>> mg_level_data; @@ -191,9 +190,9 @@ do_test(const DoFHandler &dof) MGCoarseIterative mg_coarse; mg_coarse.initialize(mg_matrices[0]); - typedef PreconditionChebyshev> - SMOOTHER; + using SMOOTHER = + PreconditionChebyshev>; MGSmootherPrecondition> diff --git a/tests/matrix_free/quadrature_points.cc b/tests/matrix_free/quadrature_points.cc index 7bff563c64..f173f5c2e0 100644 --- a/tests/matrix_free/quadrature_points.cc +++ b/tests/matrix_free/quadrature_points.cc @@ -48,7 +48,7 @@ template void test() { - typedef double number; + using number = double; const SphericalManifold manifold; Triangulation tria; GridGenerator::hyper_ball(tria); @@ -90,7 +90,7 @@ test() mf_data.get_quadrature(), update_quadrature_points); - typedef VectorizedArray vector_t; + using vector_t = VectorizedArray; for (unsigned int cell = 0; cell < n_cells; ++cell) { fe_eval.reinit(cell); diff --git a/tests/matrix_free/step-37.cc b/tests/matrix_free/step-37.cc index e1c83a5b85..52595d375d 100644 --- a/tests/matrix_free/step-37.cc +++ b/tests/matrix_free/step-37.cc @@ -376,9 +376,9 @@ namespace Step37 void output_results(const unsigned int cycle) const; - typedef LaplaceOperator - SystemMatrixType; - typedef LaplaceOperator LevelMatrixType; + using SystemMatrixType = + LaplaceOperator; + using LevelMatrixType = LaplaceOperator; Triangulation triangulation; FE_Q fe; @@ -578,7 +578,7 @@ namespace Step37 MGCoarseGridHouseholder> mg_coarse; mg_coarse.initialize(coarse_matrix); - typedef PreconditionChebyshev> SMOOTHER; + using SMOOTHER = PreconditionChebyshev>; MGSmootherPrecondition> mg_smoother; diff --git a/tests/matrix_free/stokes_computation.cc b/tests/matrix_free/stokes_computation.cc index fd119f2df3..2da582f0fd 100644 --- a/tests/matrix_free/stokes_computation.cc +++ b/tests/matrix_free/stokes_computation.cc @@ -506,7 +506,7 @@ namespace StokesClass const LinearAlgebra::distributed::BlockVector &src, const std::pair & cell_range) const { - typedef VectorizedArray vector_t; + using vector_t = VectorizedArray; FEEvaluation velocity(data, 0); FEEvaluation pressure(data, 1); @@ -934,12 +934,12 @@ namespace StokesClass void solve(); - typedef LinearAlgebra::distributed::Vector vector_t; - typedef LinearAlgebra::distributed::BlockVector block_vector_t; + using vector_t = LinearAlgebra::distributed::Vector; + using block_vector_t = LinearAlgebra::distributed::BlockVector; - typedef StokesOperator StokesMatrixType; - typedef MassMatrixOperator MassMatrixType; - typedef ABlockOperator LevelMatrixType; + using StokesMatrixType = StokesOperator; + using MassMatrixType = MassMatrixOperator; + using LevelMatrixType = ABlockOperator; unsigned int degree_u; @@ -1270,7 +1270,7 @@ namespace StokesClass false, false); - typedef MGTransferMatrixFree Transfer; + using Transfer = MGTransferMatrixFree; Transfer mg_transfer(mg_constrained_dofs); mg_transfer.initialize_constraints(mg_constrained_dofs); @@ -1288,9 +1288,9 @@ namespace StokesClass mg_coarse; mg_coarse.initialize(coarse_solver, coarse_matrix, coarse_prec_identity); - typedef PreconditionChebyshev SmootherType; - mg::SmootherRelaxation mg_smoother; - MGLevelObject smoother_data; + using SmootherType = PreconditionChebyshev; + mg::SmootherRelaxation mg_smoother; + MGLevelObject smoother_data; smoother_data.resize(0, triangulation.n_global_levels() - 1); for (unsigned int level = 0; level < triangulation.n_global_levels(); ++level) @@ -1331,16 +1331,16 @@ namespace StokesClass mg, mg_transfer); - typedef PreconditionChebyshev MassPrec; - MassPrec prec_S; - typename MassPrec::AdditionalData prec_S_data; + using MassPrec = PreconditionChebyshev; + MassPrec prec_S; + typename MassPrec::AdditionalData prec_S_data; prec_S_data.smoothing_range = 1e-3; prec_S_data.degree = numbers::invalid_unsigned_int; prec_S_data.eig_cg_n_iterations = mass_matrix.m(); prec_S_data.preconditioner = mass_matrix.get_matrix_diagonal_inverse(); prec_S.initialize(mass_matrix, prec_S_data); - typedef PreconditionMG A_prec_type; + using A_prec_type = PreconditionMG; // create a cheap preconditioner that consists of only a single V-cycle const StokesSolver::BlockSchurPreconditionerid() diff --git a/tests/meshworker/mesh_loop_mpi_01.cc b/tests/meshworker/mesh_loop_mpi_01.cc index ec683c0bb3..f721a9de1d 100644 --- a/tests/meshworker/mesh_loop_mpi_01.cc +++ b/tests/meshworker/mesh_loop_mpi_01.cc @@ -67,7 +67,7 @@ test() auto cell = tria.begin_active(); auto endc = tria.end(); - typedef decltype(cell) Iterator; + using Iterator = decltype(cell); auto cell_worker = [](const Iterator &cell, ScratchData &s, CopyData &c) { deallog << "Cell worker on : " << cell << " ghost? " << cell->is_ghost() diff --git a/tests/meshworker/scratch_data_01.cc b/tests/meshworker/scratch_data_01.cc index 04ffe1f12a..0560785e8f 100644 --- a/tests/meshworker/scratch_data_01.cc +++ b/tests/meshworker/scratch_data_01.cc @@ -64,7 +64,7 @@ test() auto cell = dh.begin_active(); auto endc = dh.end(); - typedef decltype(cell) Iterator; + using Iterator = decltype(cell); auto measures = std::make_tuple(0.0, 0.0, 0.0); diff --git a/tests/meshworker/scratch_data_02.cc b/tests/meshworker/scratch_data_02.cc index 54ccb3244b..cafbdf7469 100644 --- a/tests/meshworker/scratch_data_02.cc +++ b/tests/meshworker/scratch_data_02.cc @@ -108,7 +108,7 @@ test() auto cell = dh.begin_active(); auto endc = dh.end(); - typedef decltype(cell) Iterator; + using Iterator = decltype(cell); auto cell_worker = [&rhs_function](const Iterator &cell, ScratchData &s, CopyData &c) { diff --git a/tests/meshworker/scratch_data_03.cc b/tests/meshworker/scratch_data_03.cc index b9f4805390..2e69e5acee 100644 --- a/tests/meshworker/scratch_data_03.cc +++ b/tests/meshworker/scratch_data_03.cc @@ -108,7 +108,7 @@ test() auto cell = dh.begin_active(); auto endc = dh.end(); - typedef decltype(cell) Iterator; + using Iterator = decltype(cell); auto cell_worker = [&rhs_function](const Iterator &cell, ScratchData &s, CopyData &c) { diff --git a/tests/meshworker/scratch_data_04.cc b/tests/meshworker/scratch_data_04.cc index 7a58ddbb59..d59775a82c 100644 --- a/tests/meshworker/scratch_data_04.cc +++ b/tests/meshworker/scratch_data_04.cc @@ -89,7 +89,7 @@ test() auto cell = dh.begin_active(); auto endc = dh.end(); - typedef decltype(cell) Iterator; + using Iterator = decltype(cell); auto cell_integrator = [&H1_norm, &solution, &scalar](const Iterator &cell, diff --git a/tests/meshworker/scratch_data_05.cc b/tests/meshworker/scratch_data_05.cc index fd5166597f..aa8a8eadad 100644 --- a/tests/meshworker/scratch_data_05.cc +++ b/tests/meshworker/scratch_data_05.cc @@ -54,8 +54,8 @@ using namespace MeshWorker; -typedef Sacado::Fad::DFad Sdouble; -typedef Sacado::Fad::DFad SSdouble; +using Sdouble = Sacado::Fad::DFad; +using SSdouble = Sacado::Fad::DFad; template void @@ -112,7 +112,7 @@ test() auto cell = dh.begin_active(); auto endc = dh.end(); - typedef decltype(cell) Iterator; + using Iterator = decltype(cell); FEValuesExtractors::Scalar scalar(0); diff --git a/tests/meshworker/scratch_data_06.cc b/tests/meshworker/scratch_data_06.cc index 936dc1c70e..5d3924a0e6 100644 --- a/tests/meshworker/scratch_data_06.cc +++ b/tests/meshworker/scratch_data_06.cc @@ -55,8 +55,8 @@ using namespace MeshWorker; -typedef Sacado::Fad::DFad Sdouble; -typedef Sacado::Fad::DFad SSdouble; +using Sdouble = Sacado::Fad::DFad; +using SSdouble = Sacado::Fad::DFad; template void @@ -113,7 +113,7 @@ test() auto cell = dh.begin_active(); auto endc = dh.end(); - typedef decltype(cell) Iterator; + using Iterator = decltype(cell); FEValuesExtractors::Scalar scalar(0); diff --git a/tests/meshworker/scratch_data_07.cc b/tests/meshworker/scratch_data_07.cc index 6456c51780..83bc7199ec 100644 --- a/tests/meshworker/scratch_data_07.cc +++ b/tests/meshworker/scratch_data_07.cc @@ -55,9 +55,9 @@ using namespace MeshWorker; -typedef Sacado::Fad::DFad Sdouble; -typedef Sacado::Fad::DFad SSdouble; -typedef Sacado::Rad::ADvar RSdouble; +using Sdouble = Sacado::Fad::DFad; +using SSdouble = Sacado::Fad::DFad; +using RSdouble = Sacado::Rad::ADvar; template void @@ -114,7 +114,7 @@ test() auto cell = dh.begin_active(); auto endc = dh.end(); - typedef decltype(cell) Iterator; + using Iterator = decltype(cell); FEValuesExtractors::Scalar scalar(0); diff --git a/tests/meshworker/scratch_data_08.cc b/tests/meshworker/scratch_data_08.cc index c78a66a22e..5e72e85d08 100644 --- a/tests/meshworker/scratch_data_08.cc +++ b/tests/meshworker/scratch_data_08.cc @@ -102,7 +102,7 @@ test() auto cell = dh.begin_active(); auto endc = dh.end(); - typedef decltype(cell) Iterator; + using Iterator = decltype(cell); struct CopyDataFace { diff --git a/tests/meshworker/step-11-mesh_loop.cc b/tests/meshworker/step-11-mesh_loop.cc index 2e4584a373..6d4e750fe7 100644 --- a/tests/meshworker/step-11-mesh_loop.cc +++ b/tests/meshworker/step-11-mesh_loop.cc @@ -220,7 +220,7 @@ namespace Step11 void LaplaceProblem::assemble_and_solve() { - typedef decltype(dof_handler.begin_active()) Iterator; + using Iterator = decltype(dof_handler.begin_active()); auto cell_worker = [](const Iterator & cell, ScratchData &scratch_data, diff --git a/tests/meshworker/step-50-mesh_loop.cc b/tests/meshworker/step-50-mesh_loop.cc index 423130e986..cbdd34ae39 100644 --- a/tests/meshworker/step-50-mesh_loop.cc +++ b/tests/meshworker/step-50-mesh_loop.cc @@ -141,8 +141,8 @@ namespace Step50 FE_Q fe; DoFHandler mg_dof_handler; - typedef LA::MPI::SparseMatrix matrix_t; - typedef LA::MPI::Vector vector_t; + using matrix_t = LA::MPI::SparseMatrix; + using vector_t = LA::MPI::Vector; matrix_t system_matrix; @@ -461,7 +461,7 @@ namespace Step50 PreconditionIdentity> coarse_grid_solver(coarse_solver, coarse_matrix, id); - typedef LA::MPI::PreconditionJacobi Smoother; + using Smoother = LA::MPI::PreconditionJacobi; MGSmootherPrecondition mg_smoother; mg_smoother.initialize(mg_matrices, Smoother::AdditionalData(0.5)); mg_smoother.set_steps(2); diff --git a/tests/mpi/flux_edge_01.cc b/tests/mpi/flux_edge_01.cc index aafbee0176..75df9f6182 100644 --- a/tests/mpi/flux_edge_01.cc +++ b/tests/mpi/flux_edge_01.cc @@ -66,7 +66,7 @@ namespace Step39 class InteriorPenaltyProblem { public: - typedef MeshWorker::IntegrationInfo CellInfo; + using CellInfo = MeshWorker::IntegrationInfo; InteriorPenaltyProblem(const FiniteElement &fe); diff --git a/tests/mpi/mesh_worker_01.cc b/tests/mpi/mesh_worker_01.cc index 894ad6300f..fabe35d221 100644 --- a/tests/mpi/mesh_worker_01.cc +++ b/tests/mpi/mesh_worker_01.cc @@ -34,7 +34,7 @@ template class myIntegrator : public dealii::MeshWorker::LocalIntegrator { public: - typedef MeshWorker::IntegrationInfo CellInfo; + using CellInfo = MeshWorker::IntegrationInfo; void cell(MeshWorker::DoFInfo &dinfo, CellInfo &info) const; diff --git a/tests/mpi/mesh_worker_02.cc b/tests/mpi/mesh_worker_02.cc index 7e8571e9b2..ad9e7f8353 100644 --- a/tests/mpi/mesh_worker_02.cc +++ b/tests/mpi/mesh_worker_02.cc @@ -34,7 +34,7 @@ template class myIntegrator : public dealii::MeshWorker::LocalIntegrator { public: - typedef MeshWorker::IntegrationInfo CellInfo; + using CellInfo = MeshWorker::IntegrationInfo; void cell(MeshWorker::DoFInfo &dinfo, CellInfo &info) const; diff --git a/tests/mpi/mesh_worker_03.cc b/tests/mpi/mesh_worker_03.cc index 123ecbb4cb..9eae47eea6 100644 --- a/tests/mpi/mesh_worker_03.cc +++ b/tests/mpi/mesh_worker_03.cc @@ -34,7 +34,7 @@ template class myIntegrator : public dealii::MeshWorker::LocalIntegrator { public: - typedef MeshWorker::IntegrationInfo CellInfo; + using CellInfo = MeshWorker::IntegrationInfo; void cell(MeshWorker::DoFInfo &dinfo, CellInfo &info) const; diff --git a/tests/mpi/mesh_worker_04.cc b/tests/mpi/mesh_worker_04.cc index b7dec8c267..6c292c5258 100644 --- a/tests/mpi/mesh_worker_04.cc +++ b/tests/mpi/mesh_worker_04.cc @@ -35,7 +35,7 @@ template class myIntegrator : public dealii::MeshWorker::LocalIntegrator { public: - typedef MeshWorker::IntegrationInfo CellInfo; + using CellInfo = MeshWorker::IntegrationInfo; void cell(MeshWorker::DoFInfo &dinfo, CellInfo &info) const; diff --git a/tests/mpi/mesh_worker_05.cc b/tests/mpi/mesh_worker_05.cc index 822777d806..f83880d44e 100644 --- a/tests/mpi/mesh_worker_05.cc +++ b/tests/mpi/mesh_worker_05.cc @@ -35,7 +35,7 @@ template class myIntegrator : public dealii::MeshWorker::LocalIntegrator { public: - typedef MeshWorker::IntegrationInfo CellInfo; + using CellInfo = MeshWorker::IntegrationInfo; void cell(MeshWorker::DoFInfo &dinfo, CellInfo &info) const; diff --git a/tests/mpi/mesh_worker_matrix_01.cc b/tests/mpi/mesh_worker_matrix_01.cc index abb8892987..64992084e0 100644 --- a/tests/mpi/mesh_worker_matrix_01.cc +++ b/tests/mpi/mesh_worker_matrix_01.cc @@ -50,7 +50,7 @@ template class Local : public Subscriptor { public: - typedef MeshWorker::IntegrationInfo CellInfo; + using CellInfo = MeshWorker::IntegrationInfo; void cell(MeshWorker::DoFInfo &dinfo, CellInfo &info) const; diff --git a/tests/mpi/multigrid_adaptive.cc b/tests/mpi/multigrid_adaptive.cc index abf722e920..29e4e7318c 100644 --- a/tests/mpi/multigrid_adaptive.cc +++ b/tests/mpi/multigrid_adaptive.cc @@ -92,8 +92,8 @@ namespace Step50 FE_Q fe; DoFHandler mg_dof_handler; - typedef TrilinosWrappers::SparseMatrix matrix_t; - typedef TrilinosWrappers::MPI::Vector vector_t; + using matrix_t = TrilinosWrappers::SparseMatrix; + using vector_t = TrilinosWrappers::MPI::Vector; matrix_t system_matrix; @@ -416,7 +416,7 @@ namespace Step50 PreconditionIdentity> coarse_grid_solver(coarse_solver, coarse_matrix, id); - typedef TrilinosWrappers::PreconditionJacobi Smoother; + using Smoother = TrilinosWrappers::PreconditionJacobi; MGSmootherPrecondition mg_smoother; mg_smoother.initialize(mg_matrices); mg_smoother.set_steps(2); diff --git a/tests/mpi/multigrid_uniform.cc b/tests/mpi/multigrid_uniform.cc index 07d1818050..2709bf27d3 100644 --- a/tests/mpi/multigrid_uniform.cc +++ b/tests/mpi/multigrid_uniform.cc @@ -92,8 +92,8 @@ namespace Step50 FE_Q fe; DoFHandler mg_dof_handler; - typedef TrilinosWrappers::SparseMatrix matrix_t; - typedef TrilinosWrappers::MPI::Vector vector_t; + using matrix_t = TrilinosWrappers::SparseMatrix; + using vector_t = TrilinosWrappers::MPI::Vector; matrix_t system_matrix; @@ -403,7 +403,7 @@ namespace Step50 PreconditionIdentity> coarse_grid_solver(coarse_solver, coarse_matrix, id); - typedef TrilinosWrappers::PreconditionJacobi Smoother; + using Smoother = TrilinosWrappers::PreconditionJacobi; MGSmootherPrecondition mg_smoother; mg_smoother.initialize(mg_matrices); mg_smoother.set_steps(2); diff --git a/tests/mpi/parallel_block_vector_05.cc b/tests/mpi/parallel_block_vector_05.cc index 9f11828565..3dfb3cea7d 100644 --- a/tests/mpi/parallel_block_vector_05.cc +++ b/tests/mpi/parallel_block_vector_05.cc @@ -49,7 +49,7 @@ template void test(const unsigned int n_blocks = 5) { - typedef double number; + using number = double; parallel::distributed::Triangulation tria(MPI_COMM_WORLD); GridGenerator::hyper_cube(tria); diff --git a/tests/mpi/parallel_block_vector_06.cc b/tests/mpi/parallel_block_vector_06.cc index 7ab286e997..a3ebaeb728 100644 --- a/tests/mpi/parallel_block_vector_06.cc +++ b/tests/mpi/parallel_block_vector_06.cc @@ -51,7 +51,7 @@ template void test(const unsigned int n_blocks = 5) { - typedef double number; + using number = double; parallel::distributed::Triangulation tria(MPI_COMM_WORLD); GridGenerator::hyper_cube(tria); diff --git a/tests/mpi/parallel_block_vector_07.cc b/tests/mpi/parallel_block_vector_07.cc index 82d87269ed..e40d9e2cb2 100644 --- a/tests/mpi/parallel_block_vector_07.cc +++ b/tests/mpi/parallel_block_vector_07.cc @@ -49,7 +49,7 @@ template void test(const unsigned int n_blocks = 5) { - typedef double number; + using number = double; parallel::distributed::Triangulation tria(MPI_COMM_WORLD); GridGenerator::hyper_cube(tria); diff --git a/tests/mpi/parallel_block_vector_08.cc b/tests/mpi/parallel_block_vector_08.cc index fced3da188..9e0598b50c 100644 --- a/tests/mpi/parallel_block_vector_08.cc +++ b/tests/mpi/parallel_block_vector_08.cc @@ -49,7 +49,7 @@ template void test(const unsigned int n_blocks = 5) { - typedef double number; + using number = double; parallel::distributed::Triangulation tria(MPI_COMM_WORLD); GridGenerator::hyper_cube(tria); diff --git a/tests/mpi/parallel_block_vector_09.cc b/tests/mpi/parallel_block_vector_09.cc index 4a2150142c..9addd761eb 100644 --- a/tests/mpi/parallel_block_vector_09.cc +++ b/tests/mpi/parallel_block_vector_09.cc @@ -52,7 +52,7 @@ template void test(const unsigned int n_blocks = 5) { - typedef double number; + using number = double; parallel::distributed::Triangulation tria(MPI_COMM_WORLD); GridGenerator::hyper_cube(tria); diff --git a/tests/mpi/parallel_block_vector_10.cc b/tests/mpi/parallel_block_vector_10.cc index e2a254fd7a..c00a34ce83 100644 --- a/tests/mpi/parallel_block_vector_10.cc +++ b/tests/mpi/parallel_block_vector_10.cc @@ -48,7 +48,7 @@ template void test(const unsigned int n_blocks = 5) { - typedef double number; + using number = double; parallel::distributed::Triangulation tria(MPI_COMM_WORLD); GridGenerator::hyper_cube(tria); diff --git a/tests/mpi/parallel_block_vector_11.cc b/tests/mpi/parallel_block_vector_11.cc index 606e879c65..a14f016972 100644 --- a/tests/mpi/parallel_block_vector_11.cc +++ b/tests/mpi/parallel_block_vector_11.cc @@ -50,7 +50,7 @@ template void test(const unsigned int n_blocks = 5) { - typedef double number; + using number = double; parallel::distributed::Triangulation tria(MPI_COMM_WORLD); GridGenerator::hyper_cube(tria); diff --git a/tests/mpi/parallel_block_vector_12.cc b/tests/mpi/parallel_block_vector_12.cc index 749cc527b2..546607d8f0 100644 --- a/tests/mpi/parallel_block_vector_12.cc +++ b/tests/mpi/parallel_block_vector_12.cc @@ -50,7 +50,7 @@ template void test(const unsigned int n = 5, const unsigned int m = 3) { - typedef double number; + using number = double; parallel::distributed::Triangulation tria(MPI_COMM_WORLD); GridGenerator::hyper_cube(tria); diff --git a/tests/mpi/periodic_neighbor_01.cc b/tests/mpi/periodic_neighbor_01.cc index e6051b37f8..8a0bd78486 100644 --- a/tests/mpi/periodic_neighbor_01.cc +++ b/tests/mpi/periodic_neighbor_01.cc @@ -108,9 +108,9 @@ template struct periodicity_tests { - typedef TriaIterator> cell_iterator; - typedef - typename Triangulation::active_cell_iterator active_cell_iterator; + using cell_iterator = TriaIterator>; + using active_cell_iterator = + typename Triangulation::active_cell_iterator; periodicity_tests(); unsigned refn_cycle; @@ -230,9 +230,9 @@ template void periodicity_tests::check_periodicity() { - typedef std::pair cell_face_pair; - typedef typename std::map::iterator - cell_face_map_it; + using cell_face_pair = std::pair; + using cell_face_map_it = + typename std::map::iterator; for (int rank_i = 0; rank_i < comm_size; ++rank_i) { diff --git a/tests/mpi/periodicity_04.cc b/tests/mpi/periodicity_04.cc index b44a967ca7..9c09fd236c 100644 --- a/tests/mpi/periodicity_04.cc +++ b/tests/mpi/periodicity_04.cc @@ -258,8 +258,8 @@ check(const unsigned int orientation, bool reverse) triangulation.execute_coarsening_and_refinement(); - typedef std::pair::cell_iterator, unsigned int> - CellFace; + using CellFace = + std::pair::cell_iterator, unsigned int>; const typename std::map>> &face_map = triangulation.get_periodic_face_map(); typename std::map constraints; AffineConstraints non_homogeneous_constraints; - typedef MatrixFreeOperators::LaplaceOperator< + using SystemMatrixType = MatrixFreeOperators::LaplaceOperator< dim, degree_finite_element, degree_finite_element + 1, 1, - LinearAlgebra::distributed::Vector> - SystemMatrixType; + LinearAlgebra::distributed::Vector>; SystemMatrixType system_matrix; MGConstrainedDoFs mg_constrained_dofs; - typedef MatrixFreeOperators::LaplaceOperator< + using LevelMatrixType = MatrixFreeOperators::LaplaceOperator< dim, degree_finite_element, degree_finite_element + 1, 1, - LinearAlgebra::distributed::Vector> - LevelMatrixType; + LinearAlgebra::distributed::Vector>; MGLevelObject mg_matrices; LinearAlgebra::distributed::Vector solution; @@ -378,9 +376,9 @@ namespace Step37 MGTransferMatrixFree mg_transfer(mg_constrained_dofs); mg_transfer.build(dof_handler); - typedef PreconditionChebyshev> - SmootherType; + using SmootherType = + PreconditionChebyshev>; mg::SmootherRelaxation> mg_smoother; diff --git a/tests/mpi/step-39-block.cc b/tests/mpi/step-39-block.cc index 5f1773aec6..9f325e424c 100644 --- a/tests/mpi/step-39-block.cc +++ b/tests/mpi/step-39-block.cc @@ -395,7 +395,7 @@ namespace Step39 class InteriorPenaltyProblem { public: - typedef MeshWorker::IntegrationInfo CellInfo; + using CellInfo = MeshWorker::IntegrationInfo; InteriorPenaltyProblem(const FiniteElement &fe); @@ -641,10 +641,9 @@ namespace Step39 PreconditionIdentity> coarse_grid_solver(coarse_solver, coarse_matrix, identity); - typedef RelaxationBlockJacobi - Smoother; + using Smoother = RelaxationBlockJacobi; MGLevelObject smoother_data; smoother_data.resize(0, triangulation.n_levels() - 1); diff --git a/tests/mpi/step-39.cc b/tests/mpi/step-39.cc index f7a279e798..8466dd105f 100644 --- a/tests/mpi/step-39.cc +++ b/tests/mpi/step-39.cc @@ -396,7 +396,7 @@ namespace Step39 class InteriorPenaltyProblem { public: - typedef MeshWorker::IntegrationInfo CellInfo; + using CellInfo = MeshWorker::IntegrationInfo; InteriorPenaltyProblem(const FiniteElement &fe); @@ -642,7 +642,7 @@ namespace Step39 PreconditionIdentity> coarse_grid_solver(coarse_solver, coarse_matrix, identity); - typedef TrilinosWrappers::PreconditionJacobi Smoother; + using Smoother = TrilinosWrappers::PreconditionJacobi; MGSmootherPrecondition diff --git a/tests/mpi/torus.cc b/tests/mpi/torus.cc index f4d44bb1c4..4abeb90249 100644 --- a/tests/mpi/torus.cc +++ b/tests/mpi/torus.cc @@ -62,7 +62,7 @@ #include "../tests.h" -typedef parallel::distributed::Triangulation<2, 3>::cell_iterator cell_iterator; +using cell_iterator = parallel::distributed::Triangulation<2, 3>::cell_iterator; DeclException1(ExcMissingCell, cell_iterator, << "Trying to find cell " << arg1 diff --git a/tests/mpi/tria_signals_01.cc b/tests/mpi/tria_signals_01.cc index a782ac7072..d4c3836cca 100644 --- a/tests/mpi/tria_signals_01.cc +++ b/tests/mpi/tria_signals_01.cc @@ -109,7 +109,7 @@ test() signal_counter_clear = 0; signal_counter_any_change = 0; - typedef parallel::distributed::Triangulation TriaType; + using TriaType = parallel::distributed::Triangulation; { const std::string prefix = Utilities::int_to_string(dim, 1) + "d-" + diff --git a/tests/mpi/tria_signals_02.cc b/tests/mpi/tria_signals_02.cc index 628cc08e4b..358b212836 100644 --- a/tests/mpi/tria_signals_02.cc +++ b/tests/mpi/tria_signals_02.cc @@ -86,7 +86,7 @@ template void test() { - typedef parallel::distributed::Triangulation TriaType; + using TriaType = parallel::distributed::Triangulation; { const std::string prefix = Utilities::int_to_string(dim, 1) + "d-" + diff --git a/tests/mpi/tria_signals_03.cc b/tests/mpi/tria_signals_03.cc index a642b89171..67870372ef 100644 --- a/tests/mpi/tria_signals_03.cc +++ b/tests/mpi/tria_signals_03.cc @@ -89,7 +89,7 @@ template void test() { - typedef parallel::distributed::Triangulation TriaType; + using TriaType = parallel::distributed::Triangulation; { const std::string prefix = Utilities::int_to_string(dim, 1) + "d-" + diff --git a/tests/mpi/tria_signals_04.cc b/tests/mpi/tria_signals_04.cc index 997480de38..d5ef15ea43 100644 --- a/tests/mpi/tria_signals_04.cc +++ b/tests/mpi/tria_signals_04.cc @@ -90,7 +90,7 @@ template void test() { - typedef parallel::distributed::Triangulation TriaType; + using TriaType = parallel::distributed::Triangulation; { const std::string prefix = Utilities::int_to_string(dim, 1) + "d-" + diff --git a/tests/mpi/tria_signals_05.cc b/tests/mpi/tria_signals_05.cc index 6954774082..dc94d30441 100644 --- a/tests/mpi/tria_signals_05.cc +++ b/tests/mpi/tria_signals_05.cc @@ -90,7 +90,7 @@ template void test() { - typedef parallel::distributed::Triangulation TriaType; + using TriaType = parallel::distributed::Triangulation; { const std::string prefix = Utilities::int_to_string(dim, 1) + "d-" + diff --git a/tests/mpi/tria_signals_06.cc b/tests/mpi/tria_signals_06.cc index 53667f557f..f0833062c8 100644 --- a/tests/mpi/tria_signals_06.cc +++ b/tests/mpi/tria_signals_06.cc @@ -89,7 +89,7 @@ template void test() { - typedef parallel::distributed::Triangulation TriaType; + using TriaType = parallel::distributed::Triangulation; { const std::string prefix = Utilities::int_to_string(dim, 1) + "d-" + diff --git a/tests/multigrid/cycles.cc b/tests/multigrid/cycles.cc index aa0d18af5c..c3cfab7fe6 100644 --- a/tests/multigrid/cycles.cc +++ b/tests/multigrid/cycles.cc @@ -33,7 +33,7 @@ #define N 3 -typedef Vector VectorType; +using VectorType = Vector; class MGAll : public MGSmootherBase, public MGTransferBase, diff --git a/tests/multigrid/events_01.cc b/tests/multigrid/events_01.cc index 02bd6b8486..6bba6dc7bb 100644 --- a/tests/multigrid/events_01.cc +++ b/tests/multigrid/events_01.cc @@ -82,8 +82,8 @@ namespace Step50 run(); private: - typedef LA::MPI::SparseMatrix matrix_t; - typedef LA::MPI::Vector vector_t; + using matrix_t = LA::MPI::SparseMatrix; + using vector_t = LA::MPI::Vector; void setup_system(); @@ -391,7 +391,7 @@ namespace Step50 MGTransferPrebuilt mg_transfer(mg_constrained_dofs); mg_transfer.build(mg_dof_handler); - typedef LA::MPI::PreconditionJacobi Smoother; + using Smoother = LA::MPI::PreconditionJacobi; MGSmootherPrecondition mg_smoother; mg_smoother.initialize(mg_matrices, Smoother::AdditionalData(0.5)); mg_smoother.set_steps(2); diff --git a/tests/multigrid/mg_coarse_01.cc b/tests/multigrid/mg_coarse_01.cc index b344975e96..73b5dafb56 100644 --- a/tests/multigrid/mg_coarse_01.cc +++ b/tests/multigrid/mg_coarse_01.cc @@ -82,8 +82,8 @@ namespace Step50 run(); private: - typedef LA::MPI::SparseMatrix matrix_t; - typedef LA::MPI::Vector vector_t; + using matrix_t = LA::MPI::SparseMatrix; + using vector_t = LA::MPI::Vector; void setup_system(); @@ -462,7 +462,7 @@ namespace Step50 MGTransferPrebuilt mg_transfer(mg_constrained_dofs); mg_transfer.build(mg_dof_handler); - typedef LA::MPI::PreconditionJacobi Smoother; + using Smoother = LA::MPI::PreconditionJacobi; MGSmootherPrecondition mg_smoother; mg_smoother.initialize(mg_matrices, Smoother::AdditionalData(0.5)); mg_smoother.set_steps(2); diff --git a/tests/multigrid/mg_renumbered_01.cc b/tests/multigrid/mg_renumbered_01.cc index c15107f1d6..29eb33c936 100644 --- a/tests/multigrid/mg_renumbered_01.cc +++ b/tests/multigrid/mg_renumbered_01.cc @@ -371,7 +371,7 @@ LaplaceProblem::test() MGCoarseGridHouseholder> mg_coarse_renumbered; mg_coarse_renumbered.initialize(coarse_matrix_renumbered); - typedef PreconditionIdentity RELAXATION; + using RELAXATION = PreconditionIdentity; MGSmootherPrecondition, RELAXATION, Vector> mg_smoother; diff --git a/tests/multigrid/mg_renumbered_02.cc b/tests/multigrid/mg_renumbered_02.cc index 6c1cc2a02e..64a1e034b9 100644 --- a/tests/multigrid/mg_renumbered_02.cc +++ b/tests/multigrid/mg_renumbered_02.cc @@ -179,7 +179,7 @@ template class LaplaceProblem { public: - typedef MeshWorker::IntegrationInfo CellInfo; + using CellInfo = MeshWorker::IntegrationInfo; LaplaceProblem(const unsigned int deg); void diff --git a/tests/multigrid/mg_renumbered_03.cc b/tests/multigrid/mg_renumbered_03.cc index 9bc0e7d459..93e993a25e 100644 --- a/tests/multigrid/mg_renumbered_03.cc +++ b/tests/multigrid/mg_renumbered_03.cc @@ -226,7 +226,7 @@ template class LaplaceProblem { public: - typedef MeshWorker::IntegrationInfo CellInfo; + using CellInfo = MeshWorker::IntegrationInfo; LaplaceProblem(const unsigned int deg); void diff --git a/tests/multigrid/step-16-02.cc b/tests/multigrid/step-16-02.cc index 1ccc1c8c8f..c23bbc4eda 100644 --- a/tests/multigrid/step-16-02.cc +++ b/tests/multigrid/step-16-02.cc @@ -481,7 +481,7 @@ LaplaceProblem::solve() MGCoarseGridHouseholder<> coarse_grid_solver; coarse_grid_solver.initialize(coarse_matrix); - typedef PreconditionSOR> Smoother; + using Smoother = PreconditionSOR>; MGSmootherRelaxation, Smoother, Vector> mg_smoother; mg_smoother.initialize(mg_matrices); diff --git a/tests/multigrid/step-16-03.cc b/tests/multigrid/step-16-03.cc index 8ee966bf5c..557dcaf910 100644 --- a/tests/multigrid/step-16-03.cc +++ b/tests/multigrid/step-16-03.cc @@ -374,8 +374,8 @@ LaplaceProblem::solve() MGCoarseGridHouseholder<> coarse_grid_solver; coarse_grid_solver.initialize(coarse_matrix); - typedef PreconditionSOR> Smoother; - GrowingVectorMemory<> vector_memory; + using Smoother = PreconditionSOR>; + GrowingVectorMemory<> vector_memory; MGSmootherRelaxation, Smoother, Vector> mg_smoother; mg_smoother.initialize(mg_matrices); diff --git a/tests/multigrid/step-16-04.cc b/tests/multigrid/step-16-04.cc index 832ba2c1a4..cbb32979fe 100644 --- a/tests/multigrid/step-16-04.cc +++ b/tests/multigrid/step-16-04.cc @@ -390,9 +390,9 @@ LaplaceProblem::solve() deallog << " Size of coarse grid matrix: " << mg_matrices[min_level].m() << std::endl; - typedef PreconditionChebyshev, - LinearAlgebra::distributed::Vector> - Smoother; + using Smoother = + PreconditionChebyshev, + LinearAlgebra::distributed::Vector>; GrowingVectorMemory> vector_memory; MGSmootherPrecondition, Smoother, diff --git a/tests/multigrid/step-16-05.cc b/tests/multigrid/step-16-05.cc index 9319d1b687..3e8179a450 100644 --- a/tests/multigrid/step-16-05.cc +++ b/tests/multigrid/step-16-05.cc @@ -391,9 +391,9 @@ LaplaceProblem::solve() deallog << " Size of coarse grid matrix: " << mg_matrices[min_level].m() << std::endl; - typedef PreconditionChebyshev, - LinearAlgebra::distributed::Vector> - Smoother; + using Smoother = + PreconditionChebyshev, + LinearAlgebra::distributed::Vector>; GrowingVectorMemory> vector_memory; MGSmootherPrecondition, Smoother, diff --git a/tests/multigrid/step-16-06.cc b/tests/multigrid/step-16-06.cc index 6f4ccece2e..0cc688a200 100644 --- a/tests/multigrid/step-16-06.cc +++ b/tests/multigrid/step-16-06.cc @@ -391,9 +391,9 @@ LaplaceProblem::solve() deallog << " Size of coarse grid matrix: " << mg_matrices[min_level].m() << std::endl; - typedef PreconditionChebyshev, - LinearAlgebra::distributed::Vector> - Smoother; + using Smoother = + PreconditionChebyshev, + LinearAlgebra::distributed::Vector>; GrowingVectorMemory> vector_memory; MGSmootherPrecondition, Smoother, diff --git a/tests/multigrid/step-16-07.cc b/tests/multigrid/step-16-07.cc index e39c49c165..03e9ca02df 100644 --- a/tests/multigrid/step-16-07.cc +++ b/tests/multigrid/step-16-07.cc @@ -455,7 +455,7 @@ LaplaceProblem::solve() MGCoarseGridHouseholder<> coarse_grid_solver; coarse_grid_solver.initialize(coarse_matrix); - typedef PreconditionJacobi> Smoother; + using Smoother = PreconditionJacobi>; MGSmootherPrecondition, Smoother, Vector> mg_smoother; mg_smoother.initialize(mg_matrices, typename Smoother::AdditionalData(0.678)); diff --git a/tests/multigrid/step-16-08.cc b/tests/multigrid/step-16-08.cc index 807f7e8add..d3b415d14e 100644 --- a/tests/multigrid/step-16-08.cc +++ b/tests/multigrid/step-16-08.cc @@ -462,8 +462,8 @@ LaplaceProblem::solve() MGCoarseGridHouseholder<> coarse_grid_solver; coarse_grid_solver.initialize(coarse_matrix); - typedef PreconditionSOR> Smoother; - GrowingVectorMemory<> vector_memory; + using Smoother = PreconditionSOR>; + GrowingVectorMemory<> vector_memory; MGSmootherRelaxation, Smoother, Vector> mg_smoother; mg_smoother.initialize(mg_matrices); diff --git a/tests/multigrid/step-16-50-mpi-linear-operator.cc b/tests/multigrid/step-16-50-mpi-linear-operator.cc index 8304a8f551..7a8efb5ea4 100644 --- a/tests/multigrid/step-16-50-mpi-linear-operator.cc +++ b/tests/multigrid/step-16-50-mpi-linear-operator.cc @@ -103,8 +103,8 @@ namespace Step50 FE_Q fe; DoFHandler mg_dof_handler; - typedef LA::MPI::SparseMatrix matrix_t; - typedef LA::MPI::Vector vector_t; + using matrix_t = LA::MPI::SparseMatrix; + using vector_t = LA::MPI::Vector; matrix_t system_matrix; @@ -449,7 +449,7 @@ namespace Step50 PreconditionIdentity> coarse_grid_solver(coarse_solver, coarse_matrix, id); - typedef LA::MPI::PreconditionJacobi Smoother; + using Smoother = LA::MPI::PreconditionJacobi; MGSmootherPrecondition mg_smoother; mg_smoother.initialize(mg_matrices, Smoother::AdditionalData(0.5)); mg_smoother.set_steps(2); diff --git a/tests/multigrid/step-16-50-mpi-smoother.cc b/tests/multigrid/step-16-50-mpi-smoother.cc index 3c3a6caad3..24759a59a3 100644 --- a/tests/multigrid/step-16-50-mpi-smoother.cc +++ b/tests/multigrid/step-16-50-mpi-smoother.cc @@ -103,8 +103,8 @@ namespace Step50 FE_Q fe; DoFHandler mg_dof_handler; - typedef LA::MPI::SparseMatrix matrix_t; - typedef LA::MPI::Vector vector_t; + using matrix_t = LA::MPI::SparseMatrix; + using vector_t = LA::MPI::Vector; matrix_t system_matrix; @@ -438,7 +438,7 @@ namespace Step50 mg_transfer.build(mg_dof_handler); // pre and post smoothers: - typedef LA::MPI::PreconditionJacobi Smoother; + using Smoother = LA::MPI::PreconditionJacobi; MGSmootherPrecondition mg_smoother; mg_smoother.initialize(mg_matrices, Smoother::AdditionalData(0.5)); mg_smoother.set_steps(2); diff --git a/tests/multigrid/step-16-50-mpi.cc b/tests/multigrid/step-16-50-mpi.cc index 085f191062..b3c8670d20 100644 --- a/tests/multigrid/step-16-50-mpi.cc +++ b/tests/multigrid/step-16-50-mpi.cc @@ -103,8 +103,8 @@ namespace Step50 FE_Q fe; DoFHandler mg_dof_handler; - typedef LA::MPI::SparseMatrix matrix_t; - typedef LA::MPI::Vector vector_t; + using matrix_t = LA::MPI::SparseMatrix; + using vector_t = LA::MPI::Vector; matrix_t system_matrix; @@ -449,7 +449,7 @@ namespace Step50 PreconditionIdentity> coarse_grid_solver(coarse_solver, coarse_matrix, id); - typedef LA::MPI::PreconditionJacobi Smoother; + using Smoother = LA::MPI::PreconditionJacobi; MGSmootherPrecondition mg_smoother; mg_smoother.initialize(mg_matrices, Smoother::AdditionalData(0.5)); mg_smoother.set_steps(2); diff --git a/tests/multigrid/step-16-50-serial.cc b/tests/multigrid/step-16-50-serial.cc index cd4d0e0559..a1ed55fbf3 100644 --- a/tests/multigrid/step-16-50-serial.cc +++ b/tests/multigrid/step-16-50-serial.cc @@ -365,8 +365,8 @@ template void LaplaceProblem::solve() { - typedef SparseMatrix matrix_t; - typedef Vector vector_t; + using matrix_t = SparseMatrix; + using vector_t = Vector; MGTransferPrebuilt mg_transfer(mg_constrained_dofs); mg_transfer.build(mg_dof_handler); @@ -382,7 +382,7 @@ LaplaceProblem::solve() PreconditionIdentity> coarse_grid_solver(coarse_solver, coarse_matrix, id); - typedef PreconditionJacobi Smoother; + using Smoother = PreconditionJacobi; MGSmootherPrecondition mg_smoother; mg_smoother.initialize(mg_matrices, Smoother::AdditionalData(0.5)); mg_smoother.set_steps(2); diff --git a/tests/multigrid/step-16-bdry1.cc b/tests/multigrid/step-16-bdry1.cc index 9b0e7ac925..da7f0d6fa4 100644 --- a/tests/multigrid/step-16-bdry1.cc +++ b/tests/multigrid/step-16-bdry1.cc @@ -498,7 +498,7 @@ LaplaceProblem::solve(bool use_mw) MGCoarseGridHouseholder<> coarse_grid_solver; coarse_grid_solver.initialize(coarse_matrix); - typedef PreconditionSOR> Smoother; + using Smoother = PreconditionSOR>; MGSmootherRelaxation, Smoother, Vector> mg_smoother; mg_smoother.initialize(mg_matrices); diff --git a/tests/multigrid/step-16.cc b/tests/multigrid/step-16.cc index 679697373f..0a67e07e5e 100644 --- a/tests/multigrid/step-16.cc +++ b/tests/multigrid/step-16.cc @@ -455,8 +455,8 @@ LaplaceProblem::solve() MGCoarseGridHouseholder<> coarse_grid_solver; coarse_grid_solver.initialize(coarse_matrix); - typedef PreconditionSOR> Smoother; - GrowingVectorMemory<> vector_memory; + using Smoother = PreconditionSOR>; + GrowingVectorMemory<> vector_memory; MGSmootherRelaxation, Smoother, Vector> mg_smoother; mg_smoother.initialize(mg_matrices); diff --git a/tests/multigrid/step-39-02.cc b/tests/multigrid/step-39-02.cc index aab173d8fd..8238daea12 100644 --- a/tests/multigrid/step-39-02.cc +++ b/tests/multigrid/step-39-02.cc @@ -386,7 +386,7 @@ namespace Step39 class InteriorPenaltyProblem { public: - typedef MeshWorker::IntegrationInfo CellInfo; + using CellInfo = MeshWorker::IntegrationInfo; InteriorPenaltyProblem(const FiniteElement &fe); @@ -596,8 +596,8 @@ namespace Step39 MGCoarseGridHouseholder> mg_coarse; mg_coarse.initialize(coarse_matrix); - GrowingVectorMemory> mem; - typedef PreconditionSOR> RELAXATION; + GrowingVectorMemory> mem; + using RELAXATION = PreconditionSOR>; mg::SmootherRelaxation> mg_smoother; RELAXATION::AdditionalData smoother_data(1.); mg_smoother.initialize(mg_matrix, smoother_data); diff --git a/tests/multigrid/step-39-02a.cc b/tests/multigrid/step-39-02a.cc index bc2032d6c5..ff98a19f68 100644 --- a/tests/multigrid/step-39-02a.cc +++ b/tests/multigrid/step-39-02a.cc @@ -388,7 +388,7 @@ namespace Step39 class InteriorPenaltyProblem { public: - typedef MeshWorker::IntegrationInfo CellInfo; + using CellInfo = MeshWorker::IntegrationInfo; InteriorPenaltyProblem(const FiniteElement &fe); @@ -603,8 +603,8 @@ namespace Step39 MGCoarseGridHouseholder> mg_coarse; mg_coarse.initialize(coarse_matrix); - GrowingVectorMemory> mem; - typedef PreconditionSOR> RELAXATION; + GrowingVectorMemory> mem; + using RELAXATION = PreconditionSOR>; mg::SmootherRelaxation> mg_smoother; RELAXATION::AdditionalData smoother_data(1.); mg_smoother.initialize(mg_matrix, smoother_data); diff --git a/tests/multigrid/step-39-03.cc b/tests/multigrid/step-39-03.cc index f22e5c8638..39cc1abaa2 100644 --- a/tests/multigrid/step-39-03.cc +++ b/tests/multigrid/step-39-03.cc @@ -392,7 +392,7 @@ namespace Step39 class InteriorPenaltyProblem { public: - typedef MeshWorker::IntegrationInfo CellInfo; + using CellInfo = MeshWorker::IntegrationInfo; InteriorPenaltyProblem(const FiniteElement &fe); @@ -602,8 +602,8 @@ namespace Step39 MGCoarseGridHouseholder> mg_coarse; mg_coarse.initialize(coarse_matrix); - GrowingVectorMemory> mem; - typedef PreconditionSOR> RELAXATION; + GrowingVectorMemory> mem; + using RELAXATION = PreconditionSOR>; mg::SmootherRelaxation> mg_smoother; RELAXATION::AdditionalData smoother_data(1.); mg_smoother.initialize(mg_matrix, smoother_data); diff --git a/tests/multigrid/step-39.cc b/tests/multigrid/step-39.cc index 0ae498d4c9..271da3b377 100644 --- a/tests/multigrid/step-39.cc +++ b/tests/multigrid/step-39.cc @@ -387,7 +387,7 @@ namespace Step39 class InteriorPenaltyProblem { public: - typedef MeshWorker::IntegrationInfo CellInfo; + using CellInfo = MeshWorker::IntegrationInfo; InteriorPenaltyProblem(const FiniteElement &fe); @@ -586,8 +586,8 @@ namespace Step39 MGCoarseGridHouseholder> mg_coarse; mg_coarse.initialize(coarse_matrix); - GrowingVectorMemory> mem; - typedef PreconditionSOR> RELAXATION; + GrowingVectorMemory> mem; + using RELAXATION = PreconditionSOR>; mg::SmootherRelaxation> mg_smoother; RELAXATION::AdditionalData smoother_data(1.); mg_smoother.initialize(mg_matrix, smoother_data); diff --git a/tests/multigrid/step-50_01.cc b/tests/multigrid/step-50_01.cc index 2d0b542ed4..09652e3428 100644 --- a/tests/multigrid/step-50_01.cc +++ b/tests/multigrid/step-50_01.cc @@ -101,8 +101,8 @@ namespace Step50 FE_Q fe; DoFHandler mg_dof_handler; - typedef LA::MPI::SparseMatrix matrix_t; - typedef LA::MPI::Vector vector_t; + using matrix_t = LA::MPI::SparseMatrix; + using vector_t = LA::MPI::Vector; matrix_t system_matrix; @@ -450,7 +450,7 @@ namespace Step50 PreconditionIdentity> coarse_grid_solver(coarse_solver, coarse_matrix, id); - typedef LA::MPI::PreconditionJacobi Smoother; + using Smoother = LA::MPI::PreconditionJacobi; MGSmootherPrecondition mg_smoother; mg_smoother.initialize(mg_matrices, Smoother::AdditionalData(0.5)); mg_smoother.set_steps(2); diff --git a/tests/multigrid/step-50_02.cc b/tests/multigrid/step-50_02.cc index acd2556295..507a7890dd 100644 --- a/tests/multigrid/step-50_02.cc +++ b/tests/multigrid/step-50_02.cc @@ -102,8 +102,8 @@ namespace Step50 FE_Q fe; DoFHandler mg_dof_handler; - typedef LA::MPI::SparseMatrix matrix_t; - typedef LA::MPI::Vector vector_t; + using matrix_t = LA::MPI::SparseMatrix; + using vector_t = LA::MPI::Vector; matrix_t system_matrix; @@ -456,7 +456,7 @@ namespace Step50 PreconditionIdentity> coarse_grid_solver(coarse_solver, coarse_matrix, id); - typedef LA::MPI::PreconditionJacobi Smoother; + using Smoother = LA::MPI::PreconditionJacobi; MGSmootherPrecondition mg_smoother; mg_smoother.initialize(mg_matrices, Smoother::AdditionalData(0.5)); mg_smoother.set_steps(2); diff --git a/tests/multigrid/transfer_04.cc b/tests/multigrid/transfer_04.cc index 18dcaaf260..937e111438 100644 --- a/tests/multigrid/transfer_04.cc +++ b/tests/multigrid/transfer_04.cc @@ -123,7 +123,7 @@ check_fe(FiniteElement &fe) DoFHandler dofh(tr); dofh.distribute_dofs(fe); dofh.distribute_mg_dofs(); - typedef TrilinosWrappers::MPI::Vector vector_t; + using vector_t = TrilinosWrappers::MPI::Vector; MGConstrainedDoFs mg_constrained_dofs; mg_constrained_dofs.initialize(dofh); diff --git a/tests/multigrid/transfer_04a.cc b/tests/multigrid/transfer_04a.cc index 7dd1e53f03..f3cc28ce0f 100644 --- a/tests/multigrid/transfer_04a.cc +++ b/tests/multigrid/transfer_04a.cc @@ -127,7 +127,7 @@ check_fe(FiniteElement &fe) DoFHandler dofh(tr); dofh.distribute_dofs(fe); dofh.distribute_mg_dofs(); - typedef TrilinosWrappers::MPI::Vector vector_t; + using vector_t = TrilinosWrappers::MPI::Vector; {} MGTransferPrebuilt transfer; transfer.build(dofh); diff --git a/tests/multigrid/transfer_04b.cc b/tests/multigrid/transfer_04b.cc index 83f5356267..a1a0e17c75 100644 --- a/tests/multigrid/transfer_04b.cc +++ b/tests/multigrid/transfer_04b.cc @@ -127,7 +127,7 @@ check_fe(FiniteElement &fe) DoFHandler dofh(tr); dofh.distribute_dofs(fe); dofh.distribute_mg_dofs(); - typedef PETScWrappers::MPI::Vector vector_t; + using vector_t = PETScWrappers::MPI::Vector; {} MGTransferPrebuilt transfer; transfer.build(dofh); diff --git a/tests/optimization/bfgs_03.cc b/tests/optimization/bfgs_03.cc index 40f5dc8180..6053382498 100644 --- a/tests/optimization/bfgs_03.cc +++ b/tests/optimization/bfgs_03.cc @@ -39,7 +39,7 @@ template void test() { - typedef Vector VectorType; + using VectorType = Vector; // size of the problem const unsigned int N = 10; diff --git a/tests/optimization/bfgs_04.cc b/tests/optimization/bfgs_04.cc index 21f625437a..d21219d362 100644 --- a/tests/optimization/bfgs_04.cc +++ b/tests/optimization/bfgs_04.cc @@ -40,7 +40,7 @@ test() auto &out = deallog.get_file_stream(); out << std::setprecision(5) << std::fixed << std::right; - typedef Vector VectorType; + using VectorType = Vector; // size of the problem const unsigned int N = 20; diff --git a/tests/optimization/bfgs_05.cc b/tests/optimization/bfgs_05.cc index 5377566fc9..d0a3bfdede 100644 --- a/tests/optimization/bfgs_05.cc +++ b/tests/optimization/bfgs_05.cc @@ -62,7 +62,7 @@ test() auto &out = deallog.get_file_stream(); out << std::setprecision(5) << std::fixed << std::right; - typedef Vector VectorType; + using VectorType = Vector; // size of the problem const unsigned int N = 21; diff --git a/tests/optimization/bfgs_05b.cc b/tests/optimization/bfgs_05b.cc index 08aa8fc725..d75941f23e 100644 --- a/tests/optimization/bfgs_05b.cc +++ b/tests/optimization/bfgs_05b.cc @@ -40,7 +40,7 @@ test() auto &out = deallog.get_file_stream(); out << std::setprecision(5) << std::fixed << std::right; - typedef Vector VectorType; + using VectorType = Vector; // size of the problem const unsigned int N = 21; diff --git a/tests/parameter_handler/patterns_13.cc b/tests/parameter_handler/patterns_13.cc index 3c962f0563..7376fcbbc1 100644 --- a/tests/parameter_handler/patterns_13.cc +++ b/tests/parameter_handler/patterns_13.cc @@ -29,7 +29,7 @@ main() { initlog(); - typedef std::tuple, unsigned int> T; + using T = std::tuple, unsigned int>; T a; a = Convert::to_value("Ciao : 1.0, 2.0, 3.0 : 33"); diff --git a/tests/parameter_handler/patterns_14.cc b/tests/parameter_handler/patterns_14.cc index 668705b56f..46a30da973 100644 --- a/tests/parameter_handler/patterns_14.cc +++ b/tests/parameter_handler/patterns_14.cc @@ -30,7 +30,7 @@ main() { initlog(); - typedef std::unique_ptr> T; + using T = std::unique_ptr>; T a; a = Convert::to_value("x*y,y-t"); diff --git a/tests/parameter_handler/patterns_15.cc b/tests/parameter_handler/patterns_15.cc index c30a237b27..add13a0294 100644 --- a/tests/parameter_handler/patterns_15.cc +++ b/tests/parameter_handler/patterns_15.cc @@ -31,7 +31,7 @@ main() { initlog(); - typedef ComponentMask T; + using T = ComponentMask; T a; a = Convert::to_value("true,false,true"); diff --git a/tests/parameter_handler/patterns_16.cc b/tests/parameter_handler/patterns_16.cc index ef75c6192b..3a85bab519 100644 --- a/tests/parameter_handler/patterns_16.cc +++ b/tests/parameter_handler/patterns_16.cc @@ -32,7 +32,7 @@ main() { initlog(); - typedef std::map>> T; + using T = std::map>>; T a; a = Convert::to_value("0:x,y,z*t"); diff --git a/tests/petsc/52.cc b/tests/petsc/52.cc index a6e5731d86..ab4d89189d 100644 --- a/tests/petsc/52.cc +++ b/tests/petsc/52.cc @@ -65,7 +65,7 @@ main(int argc, char **argv) { Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1); { - typedef PETScWrappers::SparseMatrix::size_type size_type; + using size_type = PETScWrappers::SparseMatrix::size_type; std::vector row_lengths(5, 3U); row_lengths.back() = 2; diff --git a/tests/petsc/67.cc b/tests/petsc/67.cc index 6fe7203ec4..e5df64c7f7 100644 --- a/tests/petsc/67.cc +++ b/tests/petsc/67.cc @@ -29,7 +29,7 @@ void test(PETScWrappers::MatrixBase &m) { - typedef PETScWrappers::MatrixBase::size_type size_type; + using size_type = PETScWrappers::MatrixBase::size_type; Assert(m.m() != 0, ExcInternalError()); Assert(m.n() != 0, ExcInternalError()); diff --git a/tests/petsc/69.cc b/tests/petsc/69.cc index 087b7c57c8..ab2a023e05 100644 --- a/tests/petsc/69.cc +++ b/tests/petsc/69.cc @@ -32,7 +32,7 @@ test(PETScWrappers::MatrixBase &m) Assert(m.m() != 0, ExcInternalError()); Assert(m.n() != 0, ExcInternalError()); - typedef PETScWrappers::MatrixBase::size_type size_type; + using size_type = PETScWrappers::MatrixBase::size_type; // build a tri-diagonal pattern double norm_sqr = 0; diff --git a/tests/petsc/parallel_sparse_matrix_01.cc b/tests/petsc/parallel_sparse_matrix_01.cc index 9a59de20f8..523c6d0e4d 100644 --- a/tests/petsc/parallel_sparse_matrix_01.cc +++ b/tests/petsc/parallel_sparse_matrix_01.cc @@ -56,7 +56,7 @@ get_this_mpi_process() void test() { - typedef PETScWrappers::MPI::SparseMatrix::size_type size_type; + using size_type = PETScWrappers::MPI::SparseMatrix::size_type; // create a parallel matrix where the first // process has 10 rows, the second one 20, diff --git a/tests/physics/notation-kelvin_01.cc b/tests/physics/notation-kelvin_01.cc index 8e979886c2..942297f17c 100644 --- a/tests/physics/notation-kelvin_01.cc +++ b/tests/physics/notation-kelvin_01.cc @@ -122,7 +122,7 @@ test_scalars() const Vector vA = Notation::Kelvin::to_vector(A); const FullMatrix mA = Notation::Kelvin::to_matrix(A); - typedef typename std::decay::type InpType; + using InpType = typename std::decay::type; const auto vA_conv = Notation::Kelvin::to_tensor(vA); const auto mA_conv = Notation::Kelvin::to_tensor(mA); @@ -141,7 +141,7 @@ test_rank_0_tensors() const Vector vA = Notation::Kelvin::to_vector(A); const FullMatrix mA = Notation::Kelvin::to_matrix(A); - typedef typename std::decay::type InpType; + using InpType = typename std::decay::type; const auto vA_conv = Notation::Kelvin::to_tensor(vA); const auto mA_conv = Notation::Kelvin::to_tensor(mA); @@ -160,7 +160,7 @@ test_rank_1_tensors() const Vector vA = Notation::Kelvin::to_vector(A); - typedef typename std::decay::type InpType; + using InpType = typename std::decay::type; const auto vA_conv = Notation::Kelvin::to_tensor(vA); Assert((vA_conv - A).norm() < 1e-12, @@ -179,7 +179,7 @@ test_rank_2_tensors() const Vector vA = Notation::Kelvin::to_vector(A); const FullMatrix mA = Notation::Kelvin::to_matrix(A); - typedef typename std::decay::type InpType; + using InpType = typename std::decay::type; const auto vA_conv = Notation::Kelvin::to_tensor(vA); const auto mA_conv = Notation::Kelvin::to_tensor(mA); @@ -197,7 +197,7 @@ test_rank_2_tensors() const Vector vA = Notation::Kelvin::to_vector(A); const FullMatrix mA = Notation::Kelvin::to_matrix(A); - typedef typename std::decay::type InpType; + using InpType = typename std::decay::type; const auto vA_conv = Notation::Kelvin::to_tensor(vA); const auto mA_conv = Notation::Kelvin::to_tensor(mA); @@ -220,7 +220,7 @@ test_rank_3_tensors() const FullMatrix mA = Notation::Kelvin::to_matrix, Tensor<2, dim>>(A); - typedef typename std::decay::type InpType; + using InpType = typename std::decay::type; const auto mA_conv = Notation::Kelvin::to_tensor(mA); Assert((mA_conv - A).norm() < 1e-12, @@ -235,7 +235,7 @@ test_rank_3_tensors() const FullMatrix mA = Notation::Kelvin::to_matrix, Tensor<1, dim>>(A); - typedef typename std::decay::type InpType; + using InpType = typename std::decay::type; const auto mA_conv = Notation::Kelvin::to_tensor(mA); Assert((mA_conv - A).norm() < 1e-12, @@ -251,7 +251,7 @@ test_rank_3_tensors() Notation::Kelvin::to_matrix, Tensor<1, dim>>( A); - typedef typename std::decay::type InpType; + using InpType = typename std::decay::type; const auto mA_conv = Notation::Kelvin::to_tensor(mA); Assert((mA_conv - A).norm() < 1e-12, @@ -267,7 +267,7 @@ test_rank_3_tensors() Notation::Kelvin::to_matrix, SymmetricTensor<2, dim>>( A); - typedef typename std::decay::type InpType; + using InpType = typename std::decay::type; const auto mA_conv = Notation::Kelvin::to_tensor(mA); Assert((mA_conv - A).norm() < 1e-12, @@ -286,7 +286,7 @@ test_rank_4_tensors() const FullMatrix mA = Notation::Kelvin::to_matrix(A); - typedef typename std::decay::type InpType; + using InpType = typename std::decay::type; const auto mA_conv = Notation::Kelvin::to_tensor(mA); Assert((mA_conv - A).norm() < 1e-12, @@ -300,7 +300,7 @@ test_rank_4_tensors() const FullMatrix mA = Notation::Kelvin::to_matrix(A); - typedef typename std::decay::type InpType; + using InpType = typename std::decay::type; const auto mA_conv = Notation::Kelvin::to_tensor(mA); Assert((mA_conv - A).norm() < 1e-12, diff --git a/tests/physics/notation-kelvin_02.cc b/tests/physics/notation-kelvin_02.cc index e622df8b5f..691c754912 100644 --- a/tests/physics/notation-kelvin_02.cc +++ b/tests/physics/notation-kelvin_02.cc @@ -129,9 +129,9 @@ test_scalars() Vector vB(mC.m()); mC.vmult(vB, vA); - typedef typename std::decay::type InpVecType; - typedef typename std::decay::type ResVecType; - typedef typename std::decay::type InpMatType; + using InpVecType = typename std::decay::type; + using ResVecType = typename std::decay::type; + using InpMatType = typename std::decay::type; const auto A_conv = Notation::Kelvin::to_tensor(vA); const auto B_conv = Notation::Kelvin::to_tensor(vB); const auto C_conv = Notation::Kelvin::to_tensor(mC); @@ -169,9 +169,9 @@ test_rank_0_tensors() Vector vB(mC.m()); mC.vmult(vB, vA); - typedef typename std::decay::type InpVecType; - typedef typename std::decay::type ResVecType; - typedef typename std::decay::type InpMatType; + using InpVecType = typename std::decay::type; + using ResVecType = typename std::decay::type; + using InpMatType = typename std::decay::type; const auto A_conv = Notation::Kelvin::to_tensor(vA); const auto B_conv = Notation::Kelvin::to_tensor(vB); const auto C_conv = Notation::Kelvin::to_tensor(mC); @@ -213,9 +213,9 @@ test_rank_1_2_tensors() Vector vB(mC.m()); mC.vmult(vB, vA); - typedef typename std::decay::type InpVecType; - typedef typename std::decay::type ResVecType; - typedef typename std::decay::type InpMatType; + using InpVecType = typename std::decay::type; + using ResVecType = typename std::decay::type; + using InpMatType = typename std::decay::type; const auto A_conv = Notation::Kelvin::to_tensor(vA); const auto B_conv = Notation::Kelvin::to_tensor(vB); const auto C_conv = Notation::Kelvin::to_tensor(mC); @@ -253,9 +253,9 @@ test_rank_1_2_tensors() Vector vB(mC.m()); mC.vmult(vB, vA); - typedef typename std::decay::type InpVecType; - typedef typename std::decay::type ResVecType; - typedef typename std::decay::type InpMatType; + using InpVecType = typename std::decay::type; + using ResVecType = typename std::decay::type; + using InpMatType = typename std::decay::type; const auto A_conv = Notation::Kelvin::to_tensor(vA); const auto B_conv = Notation::Kelvin::to_tensor(vB); const auto C_conv = Notation::Kelvin::to_tensor(mC); @@ -298,9 +298,9 @@ test_rank_2_4_tensors() Vector vB(mC.m()); mC.vmult(vB, vA); - typedef typename std::decay::type InpVecType; - typedef typename std::decay::type ResVecType; - typedef typename std::decay::type InpMatType; + using InpVecType = typename std::decay::type; + using ResVecType = typename std::decay::type; + using InpMatType = typename std::decay::type; const auto A_conv = Notation::Kelvin::to_tensor(vA); const auto B_conv = Notation::Kelvin::to_tensor(vB); const auto C_conv = Notation::Kelvin::to_tensor(mC); @@ -338,9 +338,9 @@ test_rank_2_4_tensors() Vector vB(mC.m()); mC.vmult(vB, vA); - typedef typename std::decay::type InpVecType; - typedef typename std::decay::type ResVecType; - typedef typename std::decay::type InpMatType; + using InpVecType = typename std::decay::type; + using ResVecType = typename std::decay::type; + using InpMatType = typename std::decay::type; const auto A_conv = Notation::Kelvin::to_tensor(vA); const auto B_conv = Notation::Kelvin::to_tensor(vB); const auto C_conv = Notation::Kelvin::to_tensor(mC); @@ -381,9 +381,9 @@ test_rank_2_4_tensors() Vector vB(mC.m()); mC.vmult(vB, vA); - typedef typename std::decay::type InpVecType; - typedef typename std::decay::type ResVecType; - typedef typename std::decay::type InpMatType; + using InpVecType = typename std::decay::type; + using ResVecType = typename std::decay::type; + using InpMatType = typename std::decay::type; const auto A_conv = Notation::Kelvin::to_tensor(vA); const auto B_conv = Notation::Kelvin::to_tensor(vB); const auto C_conv = Notation::Kelvin::to_tensor(mC); @@ -428,9 +428,9 @@ test_rank_3_tensors() Vector vB(mC.n()); // Note result size mC.Tvmult(vB, vA); // Note transpose vmult - typedef typename std::decay::type InpVecType; - typedef typename std::decay::type ResVecType; - typedef typename std::decay::type InpMatType; + using InpVecType = typename std::decay::type; + using ResVecType = typename std::decay::type; + using InpMatType = typename std::decay::type; const auto A_conv = Notation::Kelvin::to_tensor(vA); const auto B_conv = Notation::Kelvin::to_tensor(vB); const auto C_conv = Notation::Kelvin::to_tensor(mC); @@ -472,9 +472,9 @@ test_rank_3_tensors() Vector vB(mC.m()); // Note result size mC.vmult(vB, vA); // Note transpose vmult - typedef typename std::decay::type InpVecType; - typedef typename std::decay::type ResVecType; - typedef typename std::decay::type InpMatType; + using InpVecType = typename std::decay::type; + using ResVecType = typename std::decay::type; + using InpMatType = typename std::decay::type; const auto A_conv = Notation::Kelvin::to_tensor(vA); const auto B_conv = Notation::Kelvin::to_tensor(vB); const auto C_conv = Notation::Kelvin::to_tensor(mC); @@ -517,9 +517,9 @@ test_rank_3_tensors() Vector vB(mC.n()); // Note result size mC.Tvmult(vB, vA); // Note transpose vmult - typedef typename std::decay::type InpVecType; - typedef typename std::decay::type ResVecType; - typedef typename std::decay::type InpMatType; + using InpVecType = typename std::decay::type; + using ResVecType = typename std::decay::type; + using InpMatType = typename std::decay::type; const auto A_conv = Notation::Kelvin::to_tensor(vA); const auto B_conv = Notation::Kelvin::to_tensor(vB); const auto C_conv = Notation::Kelvin::to_tensor(mC); @@ -562,9 +562,9 @@ test_rank_3_tensors() Vector vB(mC.m()); // Note result size mC.vmult(vB, vA); // Note transpose vmult - typedef typename std::decay::type InpVecType; - typedef typename std::decay::type ResVecType; - typedef typename std::decay::type InpMatType; + using InpVecType = typename std::decay::type; + using ResVecType = typename std::decay::type; + using InpMatType = typename std::decay::type; const auto A_conv = Notation::Kelvin::to_tensor(vA); const auto B_conv = Notation::Kelvin::to_tensor(vB); const auto C_conv = Notation::Kelvin::to_tensor(mC); diff --git a/tests/rol/vector_adaptor_02.cc b/tests/rol/vector_adaptor_02.cc index 11acd7ab88..59c34e72fd 100644 --- a/tests/rol/vector_adaptor_02.cc +++ b/tests/rol/vector_adaptor_02.cc @@ -72,7 +72,7 @@ public: void test(const double x, const double y) { - typedef double RealT; + using RealT = double; QuadraticObjective quad_objective; diff --git a/tests/sacado/ad_number_traits_03.cc b/tests/sacado/ad_number_traits_03.cc index f6e1e55e65..fab678b44d 100644 --- a/tests/sacado/ad_number_traits_03.cc +++ b/tests/sacado/ad_number_traits_03.cc @@ -78,9 +78,9 @@ main() bfad.val() = Sacado::Fad::DFad(num_deriv, 1, b); // AD typedefs - typedef Sacado::Fad::DFad> ADNumberType; - typedef typename ADNumberType::value_type ADDerivativeType; - typedef typename ADNumberType::scalar_type ADScalarType; // == double + using ADNumberType = Sacado::Fad::DFad>; + using ADDerivativeType = typename ADNumberType::value_type; + using ADScalarType = typename ADNumberType::scalar_type; // == double // Compute function and derivative with AD const ADNumberType rfad = func(afad, bfad, cfad); diff --git a/tests/sacado/sacado_product_type_01.cc b/tests/sacado/sacado_product_type_01.cc index 437696e9be..2c40f7bb57 100644 --- a/tests/sacado/sacado_product_type_01.cc +++ b/tests/sacado/sacado_product_type_01.cc @@ -36,7 +36,7 @@ check() int main() { - typedef Sacado::Fad::DFad Sdouble; + using Sdouble = Sacado::Fad::DFad; initlog(); diff --git a/tests/sacado/sacado_product_type_02.cc b/tests/sacado/sacado_product_type_02.cc index d4438293bf..6e234f3bb8 100644 --- a/tests/sacado/sacado_product_type_02.cc +++ b/tests/sacado/sacado_product_type_02.cc @@ -36,8 +36,8 @@ check() int main() { - typedef Sacado::Fad::DFad Sdouble; - typedef Sacado::Fad::DFad SSdouble; + using Sdouble = Sacado::Fad::DFad; + using SSdouble = Sacado::Fad::DFad; initlog(); diff --git a/tests/sacado/sacado_product_type_03.cc b/tests/sacado/sacado_product_type_03.cc index 3537837753..0691d5e2a0 100644 --- a/tests/sacado/sacado_product_type_03.cc +++ b/tests/sacado/sacado_product_type_03.cc @@ -36,8 +36,8 @@ check() int main() { - typedef Sacado::Fad::DFad Sdouble; - typedef Sacado::Fad::DFad SSdouble; + using Sdouble = Sacado::Fad::DFad; + using SSdouble = Sacado::Fad::DFad; initlog(); diff --git a/tests/sacado/sacado_product_type_04.cc b/tests/sacado/sacado_product_type_04.cc index 39dd18b22b..87fed0706c 100644 --- a/tests/sacado/sacado_product_type_04.cc +++ b/tests/sacado/sacado_product_type_04.cc @@ -36,8 +36,8 @@ check() int main() { - typedef Sacado::Fad::DFad Sdouble; - typedef Sacado::Fad::DFad SSdouble; + using Sdouble = Sacado::Fad::DFad; + using SSdouble = Sacado::Fad::DFad; initlog(); diff --git a/tests/sacado/sacado_product_type_05.cc b/tests/sacado/sacado_product_type_05.cc index 0c9019ffeb..02f4156759 100644 --- a/tests/sacado/sacado_product_type_05.cc +++ b/tests/sacado/sacado_product_type_05.cc @@ -36,8 +36,8 @@ check() int main() { - typedef Sacado::Fad::DFad Sdouble; - typedef Sacado::Fad::DFad SSdouble; + using Sdouble = Sacado::Fad::DFad; + using SSdouble = Sacado::Fad::DFad; initlog(); diff --git a/tests/sacado/sacado_product_type_06.cc b/tests/sacado/sacado_product_type_06.cc index f6cc4d3620..cf32057dc7 100644 --- a/tests/sacado/sacado_product_type_06.cc +++ b/tests/sacado/sacado_product_type_06.cc @@ -27,7 +27,7 @@ int main() { - typedef Sacado::Fad::DFad Sdouble; + using Sdouble = Sacado::Fad::DFad; initlog(); diff --git a/tests/sacado/sacado_product_type_07.cc b/tests/sacado/sacado_product_type_07.cc index b02fd1607b..25e47a5e2f 100644 --- a/tests/sacado/sacado_product_type_07.cc +++ b/tests/sacado/sacado_product_type_07.cc @@ -27,8 +27,8 @@ int main() { - typedef Sacado::Fad::DFad Sdouble; - typedef Sacado::Fad::DFad SSdouble; + using Sdouble = Sacado::Fad::DFad; + using SSdouble = Sacado::Fad::DFad; initlog(); diff --git a/tests/sacado/sacado_product_type_08.cc b/tests/sacado/sacado_product_type_08.cc index 172b17d7e3..8f4ed38b3e 100644 --- a/tests/sacado/sacado_product_type_08.cc +++ b/tests/sacado/sacado_product_type_08.cc @@ -27,7 +27,7 @@ int main() { - typedef Sacado::Fad::DFad Sdouble; + using Sdouble = Sacado::Fad::DFad; initlog(); diff --git a/tests/sacado/sacado_product_type_09.cc b/tests/sacado/sacado_product_type_09.cc index daa7253570..4751699970 100644 --- a/tests/sacado/sacado_product_type_09.cc +++ b/tests/sacado/sacado_product_type_09.cc @@ -27,8 +27,8 @@ int main() { - typedef Sacado::Fad::DFad Sdouble; - typedef Sacado::Fad::DFad SSdouble; + using Sdouble = Sacado::Fad::DFad; + using SSdouble = Sacado::Fad::DFad; initlog(); diff --git a/tests/sacado/zero_val_nonzero_deriv_01.cc b/tests/sacado/zero_val_nonzero_deriv_01.cc index b1df31af0a..22e3b1f514 100644 --- a/tests/sacado/zero_val_nonzero_deriv_01.cc +++ b/tests/sacado/zero_val_nonzero_deriv_01.cc @@ -58,7 +58,7 @@ main() const FEValuesExtractors::Scalar extractor_sclr(0); - typedef Sacado::Fad::DFad ad_type; + using ad_type = Sacado::Fad::DFad; DoFHandler::active_cell_iterator cell = dof_handler.begin_active(); DoFHandler::active_cell_iterator endc = dof_handler.end(); for (; cell != endc; ++cell) diff --git a/tests/sundials/arkode_01.cc b/tests/sundials/arkode_01.cc index 279f2ee6ad..4f368c38b6 100644 --- a/tests/sundials/arkode_01.cc +++ b/tests/sundials/arkode_01.cc @@ -57,7 +57,7 @@ main(int argc, char **argv) Utilities::MPI::MPI_InitFinalize mpi_initialization( argc, argv, numbers::invalid_unsigned_int); - typedef Vector VectorType; + using VectorType = Vector; ParameterHandler prm; SUNDIALS::ARKode::AdditionalData data; diff --git a/tests/sundials/arkode_02.cc b/tests/sundials/arkode_02.cc index 8e4d395981..02bdd523fa 100644 --- a/tests/sundials/arkode_02.cc +++ b/tests/sundials/arkode_02.cc @@ -57,7 +57,7 @@ main(int argc, char **argv) Utilities::MPI::MPI_InitFinalize mpi_initialization( argc, argv, numbers::invalid_unsigned_int); - typedef Vector VectorType; + using VectorType = Vector; ParameterHandler prm; SUNDIALS::ARKode::AdditionalData data; diff --git a/tests/sundials/arkode_04.cc b/tests/sundials/arkode_04.cc index 04116ad06c..3a5eb1b57f 100644 --- a/tests/sundials/arkode_04.cc +++ b/tests/sundials/arkode_04.cc @@ -54,7 +54,7 @@ main(int argc, char **argv) Utilities::MPI::MPI_InitFinalize mpi_initialization( argc, argv, numbers::invalid_unsigned_int); - typedef Vector VectorType; + using VectorType = Vector; ParameterHandler prm; SUNDIALS::ARKode::AdditionalData data; diff --git a/tests/sundials/arkode_05.cc b/tests/sundials/arkode_05.cc index 66d37344f3..ca676b4a57 100644 --- a/tests/sundials/arkode_05.cc +++ b/tests/sundials/arkode_05.cc @@ -54,7 +54,7 @@ main(int argc, char **argv) Utilities::MPI::MPI_InitFinalize mpi_initialization( argc, argv, numbers::invalid_unsigned_int); - typedef Vector VectorType; + using VectorType = Vector; ParameterHandler prm; SUNDIALS::ARKode::AdditionalData data; diff --git a/tests/sundials/arkode_06.cc b/tests/sundials/arkode_06.cc index d0f5a69810..9eaa6c8ff3 100644 --- a/tests/sundials/arkode_06.cc +++ b/tests/sundials/arkode_06.cc @@ -61,7 +61,7 @@ main(int argc, char **argv) Utilities::MPI::MPI_InitFinalize mpi_initialization( argc, argv, numbers::invalid_unsigned_int); - typedef Vector VectorType; + using VectorType = Vector; ParameterHandler prm; SUNDIALS::ARKode::AdditionalData data; diff --git a/tests/sundials/arkode_07.cc b/tests/sundials/arkode_07.cc index 264099ce4f..a5b6a632ab 100644 --- a/tests/sundials/arkode_07.cc +++ b/tests/sundials/arkode_07.cc @@ -61,7 +61,7 @@ main(int argc, char **argv) Utilities::MPI::MPI_InitFinalize mpi_initialization( argc, argv, numbers::invalid_unsigned_int); - typedef Vector VectorType; + using VectorType = Vector; ParameterHandler prm; SUNDIALS::ARKode::AdditionalData data; diff --git a/tests/sundials/arkode_08.cc b/tests/sundials/arkode_08.cc index 7abd387302..f38f9361b3 100644 --- a/tests/sundials/arkode_08.cc +++ b/tests/sundials/arkode_08.cc @@ -51,7 +51,7 @@ main(int argc, char **argv) { initlog(); - typedef Vector VectorType; + using VectorType = Vector; ParameterHandler prm; SUNDIALS::ARKode::AdditionalData data; diff --git a/tests/sundials/ida_01.cc b/tests/sundials/ida_01.cc index 6eaacbd6a7..f0c8f10a41 100644 --- a/tests/sundials/ida_01.cc +++ b/tests/sundials/ida_01.cc @@ -68,7 +68,7 @@ public: , kappa(_kappa) , out("output") { - typedef Vector VectorType; + using VectorType = Vector; time_stepper.reinit_vector = [&](VectorType &v) { v.reinit(2); }; diff --git a/tests/sundials/kinsol_01.cc b/tests/sundials/kinsol_01.cc index 0b616f1db4..6e16c5ce81 100644 --- a/tests/sundials/kinsol_01.cc +++ b/tests/sundials/kinsol_01.cc @@ -37,7 +37,7 @@ main(int argc, char **argv) Utilities::MPI::MPI_InitFinalize mpi_initialization( argc, argv, numbers::invalid_unsigned_int); - typedef Vector VectorType; + using VectorType = Vector; SUNDIALS::KINSOL::AdditionalData data; ParameterHandler prm; diff --git a/tests/symengine/sd_common_tests/batch_optimizer_01.h b/tests/symengine/sd_common_tests/batch_optimizer_01.h index ec5c05943c..3ed6180aa5 100644 --- a/tests/symengine/sd_common_tests/batch_optimizer_01.h +++ b/tests/symengine/sd_common_tests/batch_optimizer_01.h @@ -513,10 +513,10 @@ test_functions() FullMatrix D2psi_sd_sd(n_independent_variables, n_independent_variables); { - typedef SD::Expression SDNumberType; + using SDNumberType = SD::Expression; // Function and its derivatives - typedef FunctionStruct func_sd; + using func_sd = FunctionStruct; deallog.push("Symbolic computation: Function initialisation"); const SDNumberType symb_s0("s1"); diff --git a/tests/symengine/sd_common_tests/batch_optimizer_02.h b/tests/symengine/sd_common_tests/batch_optimizer_02.h index 092cd8148e..a05d29b44b 100644 --- a/tests/symengine/sd_common_tests/batch_optimizer_02.h +++ b/tests/symengine/sd_common_tests/batch_optimizer_02.h @@ -39,7 +39,7 @@ test_scalar(const int n_runs, TimerOutput &timer) std::cout << std::string(80, '-') << std::endl; std::cout << "Scalar" << std::endl; - typedef SD::Expression SD_number_t; + using SD_number_t = SD::Expression; const NumberType a = NumberType(1.5); const SD_number_t x("x"); diff --git a/tests/symengine/sd_common_tests/batch_optimizer_04.h b/tests/symengine/sd_common_tests/batch_optimizer_04.h index 3894ee522f..9b7404e167 100644 --- a/tests/symengine/sd_common_tests/batch_optimizer_04.h +++ b/tests/symengine/sd_common_tests/batch_optimizer_04.h @@ -32,8 +32,8 @@ template &t, const Tensor<1, dim> &v, const double & s) { - typedef SD::Expression SDNumberType; + using SDNumberType = SD::Expression; // Compute the symbolic (derivative) tensors once off // ahead of time, and store them for each run of the function @@ -373,7 +373,7 @@ evaluate_SD_SD_stored_symbols_optimisation(const Tensor<2, dim> &t, if (symbols_initialised == false) { // Function and its derivatives - typedef CoupledFunction func_sd; + using func_sd = CoupledFunction; symb_psi = func_sd::psi(symb_t, symb_v, symb_s); #if DEBUG_EXTRA @@ -484,8 +484,8 @@ evaluate_SD_SD_stored_symbols_optimisation(const Tensor<2, dim> &t, const double d2psi_ds_ds = optimizer.evaluate(symb_d2psi_ds_ds); // Verify the result - typedef CoupledFunction func; - static const double tol = 1e-12; + using func = CoupledFunction; + static const double tol = 1e-12; Assert(std::abs(psi - func::psi(t, v, s)) < tol, ExcMessage("No match for function value.")); Assert(std::abs((dpsi_dt - func::dpsi_dt(t, v, s)).norm()) < tol, diff --git a/tests/symengine/symengine_number_type_02.cc b/tests/symengine/symengine_number_type_02.cc index 5a904d75a8..bc81e2167c 100644 --- a/tests/symengine/symengine_number_type_02.cc +++ b/tests/symengine/symengine_number_type_02.cc @@ -48,11 +48,11 @@ template void test_number_functions() { - typedef SD::Expression SD_number_t; - typedef SE::RCP SE_double_t; - // typedef SD_number_t result_t; - typedef NumberType result_t; - typedef double float_result_t; + using SD_number_t = SD::Expression; + using SE_double_t = SE::RCP; + // using result_t = SD_number_t; + using result_t = NumberType; + using float_result_t = double; // Primitive numbers const NumberType x_(NumberType(2.2)); diff --git a/tests/symengine/symengine_tensor_operations_02.cc b/tests/symengine/symengine_tensor_operations_02.cc index 6048839815..94159681e8 100644 --- a/tests/symengine/symengine_tensor_operations_02.cc +++ b/tests/symengine/symengine_tensor_operations_02.cc @@ -49,9 +49,9 @@ template void test_tensor() { - typedef SD::Expression SD_number_t; - typedef Tensor<2, dim, SD_number_t> SD_tensor_t; - typedef SymmetricTensor<2, dim, SD_number_t> SD_symm_tensor_t; + using SD_number_t = SD::Expression; + using SD_tensor_t = Tensor<2, dim, SD_number_t>; + using SD_symm_tensor_t = SymmetricTensor<2, dim, SD_number_t>; // --- Values --- deallog.push("Initialize"); diff --git a/tests/tensors/symmetric_tensor_24.cc b/tests/tensors/symmetric_tensor_24.cc index 0afe4a26c2..77a6117ea4 100644 --- a/tests/tensors/symmetric_tensor_24.cc +++ b/tests/tensors/symmetric_tensor_24.cc @@ -28,7 +28,7 @@ template void check() { - typedef SymmetricTensor<2, dim> S; + using S = SymmetricTensor<2, dim>; for (unsigned int i = 0; i < S::n_independent_components; ++i) { deallog << i << " -- " << S::unrolled_to_component_indices(i) diff --git a/tests/tensors/tensor_24.cc b/tests/tensors/tensor_24.cc index 28076f8359..fe525f5d65 100644 --- a/tests/tensors/tensor_24.cc +++ b/tests/tensors/tensor_24.cc @@ -28,7 +28,7 @@ template void check() { - typedef Tensor<2, dim> S; + using S = Tensor<2, dim>; for (unsigned int i = 0; i < S::n_independent_components; ++i) { deallog << i << " -- " << S::unrolled_to_component_indices(i) diff --git a/tests/tensors/tensor_25.cc b/tests/tensors/tensor_25.cc index 607151013f..ee790fb55e 100644 --- a/tests/tensors/tensor_25.cc +++ b/tests/tensors/tensor_25.cc @@ -27,8 +27,8 @@ template void check() { - typedef Tensor<3, dim> T; - T t; + using T = Tensor<3, dim>; + T t; for (unsigned int i = 0; i < T::n_independent_components; ++i) t[T::unrolled_to_component_indices(i)] = (i + 1) * (i + 2); diff --git a/tests/tensors/tensor_31.cc b/tests/tensors/tensor_31.cc index 620c16598b..da033b9bb3 100644 --- a/tests/tensors/tensor_31.cc +++ b/tests/tensors/tensor_31.cc @@ -27,19 +27,19 @@ test_symmetric() { constexpr int dim = 3; - typedef std::complex rank0_complex; + using rank0_complex = std::complex; dealii::Tensor<1, dim, rank0_complex> curl_complex; dealii::SymmetricTensor<2, dim, rank0_complex> permeability_complex; - typedef std::complex rank0_complex_float; + using rank0_complex_float = std::complex; dealii::Tensor<1, dim, rank0_complex_float> curl_complex_float; dealii::Tensor<2, dim, rank0_complex_float> permeability_complex_float; - typedef double rank0; + using rank0 = double; dealii::Tensor<1, dim, rank0> curl; dealii::Tensor<2, dim, rank0> permeability; - typedef double rank0_float; + using rank0_float = double; dealii::Tensor<1, dim, rank0_float> curl_float; dealii::Tensor<2, dim, rank0_float> permeability_float; @@ -135,20 +135,20 @@ template void test() { - typedef std::complex rank0_complex; + using rank0_complex = std::complex; dealii::Tensor<1, dim == 2 ? 1 : dim, rank0_complex> curl_complex; dealii::Tensor permeability_complex; - typedef std::complex rank0_complex_float; + using rank0_complex_float = std::complex; dealii::Tensor<1, dim == 2 ? 1 : dim, rank0_complex_float> curl_complex_float; dealii::Tensor permeability_complex_float; - typedef double rank0; + using rank0 = double; dealii::Tensor<1, dim == 2 ? 1 : dim, rank0> curl; dealii::Tensor permeability; - typedef double rank0_float; + using rank0_float = double; dealii::Tensor<1, dim == 2 ? 1 : dim, rank0_float> curl_float; dealii::Tensor permeability_float; diff --git a/tests/trilinos/assemble_matrix_parallel_02.cc b/tests/trilinos/assemble_matrix_parallel_02.cc index 37dcf6cc0d..e21f8e0e91 100644 --- a/tests/trilinos/assemble_matrix_parallel_02.cc +++ b/tests/trilinos/assemble_matrix_parallel_02.cc @@ -263,8 +263,8 @@ LaplaceProblem::setup_system() constraints); constraints.close(); - typedef FilteredIterator::active_cell_iterator> - CellFilter; + using CellFilter = + FilteredIterator::active_cell_iterator>; CellFilter begin(IteratorFilters::LocallyOwnedCell(), dof_handler.begin_active()); CellFilter end(IteratorFilters::LocallyOwnedCell(), dof_handler.end()); diff --git a/tests/trilinos/assemble_matrix_parallel_03.cc b/tests/trilinos/assemble_matrix_parallel_03.cc index 0a1dcc871b..03448f2f79 100644 --- a/tests/trilinos/assemble_matrix_parallel_03.cc +++ b/tests/trilinos/assemble_matrix_parallel_03.cc @@ -264,8 +264,8 @@ LaplaceProblem::setup_system() constraints); constraints.close(); - typedef FilteredIterator::active_cell_iterator> - CellFilter; + using CellFilter = + FilteredIterator::active_cell_iterator>; CellFilter begin(IteratorFilters::LocallyOwnedCell(), dof_handler.begin_active()); CellFilter end(IteratorFilters::LocallyOwnedCell(), dof_handler.end()); diff --git a/tests/trilinos/assemble_matrix_parallel_04.cc b/tests/trilinos/assemble_matrix_parallel_04.cc index 6754c869ff..f863a86432 100644 --- a/tests/trilinos/assemble_matrix_parallel_04.cc +++ b/tests/trilinos/assemble_matrix_parallel_04.cc @@ -268,8 +268,8 @@ LaplaceProblem::setup_system() constraints); constraints.close(); - typedef FilteredIterator::active_cell_iterator> - CellFilter; + using CellFilter = + FilteredIterator::active_cell_iterator>; CellFilter begin(IteratorFilters::LocallyOwnedCell(), dof_handler.begin_active()); CellFilter end(IteratorFilters::LocallyOwnedCell(), dof_handler.end()); diff --git a/tests/trilinos/assemble_matrix_parallel_05.cc b/tests/trilinos/assemble_matrix_parallel_05.cc index d8bc60e668..92232593ce 100644 --- a/tests/trilinos/assemble_matrix_parallel_05.cc +++ b/tests/trilinos/assemble_matrix_parallel_05.cc @@ -265,8 +265,8 @@ LaplaceProblem::setup_system() constraints); constraints.close(); - typedef FilteredIterator::active_cell_iterator> - CellFilter; + using CellFilter = + FilteredIterator::active_cell_iterator>; CellFilter begin(IteratorFilters::LocallyOwnedCell(), dof_handler.begin_active()); CellFilter end(IteratorFilters::LocallyOwnedCell(), dof_handler.end()); diff --git a/tests/trilinos/assemble_matrix_parallel_06.cc b/tests/trilinos/assemble_matrix_parallel_06.cc index 418d225140..43e6d66173 100644 --- a/tests/trilinos/assemble_matrix_parallel_06.cc +++ b/tests/trilinos/assemble_matrix_parallel_06.cc @@ -270,8 +270,8 @@ LaplaceProblem::setup_system() constraints); constraints.close(); - typedef FilteredIterator::active_cell_iterator> - CellFilter; + using CellFilter = + FilteredIterator::active_cell_iterator>; CellFilter begin(IteratorFilters::LocallyOwnedCell(), dof_handler.begin_active()); CellFilter end(IteratorFilters::LocallyOwnedCell(), dof_handler.end()); diff --git a/tests/trilinos/assemble_matrix_parallel_07.cc b/tests/trilinos/assemble_matrix_parallel_07.cc index 745d879275..8b3a8260ae 100644 --- a/tests/trilinos/assemble_matrix_parallel_07.cc +++ b/tests/trilinos/assemble_matrix_parallel_07.cc @@ -264,8 +264,8 @@ LaplaceProblem::setup_system() constraints); constraints.close(); - typedef FilteredIterator::active_cell_iterator> - CellFilter; + using CellFilter = + FilteredIterator::active_cell_iterator>; CellFilter begin(IteratorFilters::LocallyOwnedCell(), dof_handler.begin_active()); CellFilter end(IteratorFilters::LocallyOwnedCell(), dof_handler.end()); diff --git a/tests/trilinos/parallel_block_vector_copy_01.cc b/tests/trilinos/parallel_block_vector_copy_01.cc index fb17bccc10..f6df555738 100644 --- a/tests/trilinos/parallel_block_vector_copy_01.cc +++ b/tests/trilinos/parallel_block_vector_copy_01.cc @@ -30,8 +30,8 @@ int main(int argc, char **argv) { - typedef BlockVector BlockVectorLocal; - typedef TrilinosWrappers::MPI::BlockVector BlockVector; + using BlockVectorLocal = BlockVector; + using BlockVector = TrilinosWrappers::MPI::BlockVector; Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1); MPILogInitAll log; diff --git a/tests/vector_tools/interpolate_with_material_id_01.cc b/tests/vector_tools/interpolate_with_material_id_01.cc index 32e54edb0e..e7b908d59a 100644 --- a/tests/vector_tools/interpolate_with_material_id_01.cc +++ b/tests/vector_tools/interpolate_with_material_id_01.cc @@ -55,7 +55,7 @@ namespace PhaseField { - typedef Vector vectorType; + using vectorType = Vector; ///////////////////////////////////////////////////////////////