From e7e7013e9c418f52f856aa4126eabb85cd4f10b2 Mon Sep 17 00:00:00 2001 From: Daniel Arndt Date: Thu, 13 Dec 2018 00:14:56 +0100 Subject: [PATCH] Avoid some warnings in tests --- tests/cuda/sparse_matrix_01.cu | 4 ++-- ...complex=false.with_gsl=true.with_mpi=true.mpirun=2.output} | 0 tests/optimization/step-44.h | 1 + 3 files changed, 3 insertions(+), 2 deletions(-) rename tests/fe/{fe_enriched_color_07.with_trilinos=true.with_trilinos_with_zoltan=true.with_petsc=true.with_petsc_with_complex=false.with_gsl=true.with_mpi=true.mpirun=2.output => fe_enriched_color_07.with_trilinos=true.with_muparser=true.with_trilinos_with_zoltan=true.with_petsc=true.with_petsc_with_complex=false.with_gsl=true.with_mpi=true.mpirun=2.output} (100%) diff --git a/tests/cuda/sparse_matrix_01.cu b/tests/cuda/sparse_matrix_01.cu index 4ca3de628a..2bd5c0f1ea 100644 --- a/tests/cuda/sparse_matrix_01.cu +++ b/tests/cuda/sparse_matrix_01.cu @@ -93,8 +93,8 @@ test(Utilities::CUDA::Handle &cuda_handle) CUDAWrappers::SparseMatrix A_dev(cuda_handle, A); check_matrix(A, A_dev); - AssertThrow(A.m() == A_dev.m(), ExcInternalError()); - AssertThrow(A.n() == A_dev.n(), ExcInternalError()); + AssertDimension(A.m(), A_dev.m()); + AssertDimension(A.n(), A_dev.n()); // Multiply by a constant A *= 2.; diff --git a/tests/fe/fe_enriched_color_07.with_trilinos=true.with_trilinos_with_zoltan=true.with_petsc=true.with_petsc_with_complex=false.with_gsl=true.with_mpi=true.mpirun=2.output b/tests/fe/fe_enriched_color_07.with_trilinos=true.with_muparser=true.with_trilinos_with_zoltan=true.with_petsc=true.with_petsc_with_complex=false.with_gsl=true.with_mpi=true.mpirun=2.output similarity index 100% rename from tests/fe/fe_enriched_color_07.with_trilinos=true.with_trilinos_with_zoltan=true.with_petsc=true.with_petsc_with_complex=false.with_gsl=true.with_mpi=true.mpirun=2.output rename to tests/fe/fe_enriched_color_07.with_trilinos=true.with_muparser=true.with_trilinos_with_zoltan=true.with_petsc=true.with_petsc_with_complex=false.with_gsl=true.with_mpi=true.mpirun=2.output diff --git a/tests/optimization/step-44.h b/tests/optimization/step-44.h index d5f27ed881..2af76617a1 100644 --- a/tests/optimization/step-44.h +++ b/tests/optimization/step-44.h @@ -1350,6 +1350,7 @@ namespace Step44 tangent_matrix.block(0, 0).frobenius_norm(); (void)tang_mtrx_norm_new; + (void)tang_mtrx_norm_old; if (ss != 0.0) Assert(tang_mtrx_norm_new != tang_mtrx_norm_old, ExcInternalError()); -- 2.39.5