From ebaabd7fa417e17b44e6e983c5c5bf26067b541c Mon Sep 17 00:00:00 2001 From: David Wells Date: Tue, 8 Aug 2017 17:48:26 -0400 Subject: [PATCH] Remove more memory consumption tests. --- tests/base/aligned_vector_03.cc | 3 - tests/base/aligned_vector_03.output | 1 - tests/base/symmetric_tensor_31.cc | 54 -------------- tests/base/symmetric_tensor_31.output | 16 ----- tests/matrix_free/step-37.cc | 21 ------ tests/mpi/parallel_block_vector_03.cc | 71 ------------------- ..._03.with_64bit_indices=off.mpirun=2.output | 8 --- ...3.with_64bit_indices=off.mpirun=2.output.2 | 8 --- ...t_indices=off.mpirun=2.output.clang8-apple | 8 --- ...ith_64bit_indices=off.mpirun=2.output.gcc4 | 8 --- ...ith_64bit_indices=off.mpirun=2.output.gcc6 | 8 --- ...r_03.with_64bit_indices=on.mpirun=2.output | 8 --- ...03.with_64bit_indices=on.mpirun=2.output.2 | 8 --- ...with_64bit_indices=on.mpirun=2.output.gcc4 | 8 --- ...with_64bit_indices=on.mpirun=2.output.gcc6 | 8 --- 15 files changed, 238 deletions(-) delete mode 100644 tests/base/symmetric_tensor_31.cc delete mode 100644 tests/base/symmetric_tensor_31.output delete mode 100644 tests/mpi/parallel_block_vector_03.cc delete mode 100644 tests/mpi/parallel_block_vector_03.with_64bit_indices=off.mpirun=2.output delete mode 100644 tests/mpi/parallel_block_vector_03.with_64bit_indices=off.mpirun=2.output.2 delete mode 100644 tests/mpi/parallel_block_vector_03.with_64bit_indices=off.mpirun=2.output.clang8-apple delete mode 100644 tests/mpi/parallel_block_vector_03.with_64bit_indices=off.mpirun=2.output.gcc4 delete mode 100644 tests/mpi/parallel_block_vector_03.with_64bit_indices=off.mpirun=2.output.gcc6 delete mode 100644 tests/mpi/parallel_block_vector_03.with_64bit_indices=on.mpirun=2.output delete mode 100644 tests/mpi/parallel_block_vector_03.with_64bit_indices=on.mpirun=2.output.2 delete mode 100644 tests/mpi/parallel_block_vector_03.with_64bit_indices=on.mpirun=2.output.gcc4 delete mode 100644 tests/mpi/parallel_block_vector_03.with_64bit_indices=on.mpirun=2.output.gcc6 diff --git a/tests/base/aligned_vector_03.cc b/tests/base/aligned_vector_03.cc index a587d88f17..a34eca6d06 100644 --- a/tests/base/aligned_vector_03.cc +++ b/tests/base/aligned_vector_03.cc @@ -83,9 +83,6 @@ void test () for (unsigned int i=200000; i<400000; ++i) AssertDimension (a[i], true); deallog << "OK" << std::endl; - - deallog << "Memory consumption: " << a.memory_consumption() - << " for a.size()=" << a.size() << std::endl; } diff --git a/tests/base/aligned_vector_03.output b/tests/base/aligned_vector_03.output index 15be0b98c9..28860f954e 100644 --- a/tests/base/aligned_vector_03.output +++ b/tests/base/aligned_vector_03.output @@ -6,4 +6,3 @@ DEAL::Reserve: 0 0 1 0 DEAL::Assignment: 0 0 1 0 1 0 1 DEAL::Check large initialization: OK DEAL::Check large resize: OK -DEAL::Memory consumption: 400024 for a.size()=400000 diff --git a/tests/base/symmetric_tensor_31.cc b/tests/base/symmetric_tensor_31.cc deleted file mode 100644 index 5a0cb87b60..0000000000 --- a/tests/base/symmetric_tensor_31.cc +++ /dev/null @@ -1,54 +0,0 @@ -// --------------------------------------------------------------------- -// -// Copyright (C) 2016 by the deal.II authors -// -// This file is part of the deal.II library. -// -// The deal.II library is free software; you can use it, redistribute -// it, and/or modify it under the terms of the GNU Lesser General -// Public License as published by the Free Software Foundation; either -// version 2.1 of the License, or (at your option) any later version. -// The full text of the license can be found in the file LICENSE at -// the top level of the deal.II distribution. -// -// --------------------------------------------------------------------- - -// Test SymmetricTensor::memory_consumption - -#include "../tests.h" -#include -#include -#include - - -template -void check () -{ - deallog << "dim=" << dim << ", T=double " - << MemoryConsumption::memory_consumption (SymmetricTensor()) - << std::endl; - deallog << "dim=" << dim << ", T=complex " - << MemoryConsumption::memory_consumption (SymmetricTensor >()) - << std::endl; -} - - -int main () -{ - std::ofstream logfile("output"); - deallog << std::setprecision(3); - deallog.attach(logfile); - deallog.threshold_double(1.e-10); - - deallog << "check rank 2 tensors" << std::endl; - check<2,1>(); - check<2,2>(); - check<2,3>(); - - deallog << "check rank 4 tensors" << std::endl; - check<4,1>(); - check<4,2>(); - check<4,3>(); - - deallog << "OK" << std::endl; -} diff --git a/tests/base/symmetric_tensor_31.output b/tests/base/symmetric_tensor_31.output deleted file mode 100644 index b1425dfe58..0000000000 --- a/tests/base/symmetric_tensor_31.output +++ /dev/null @@ -1,16 +0,0 @@ - -DEAL::check rank 2 tensors -DEAL::dim=1, T=double 8 -DEAL::dim=1, T=complex 16 -DEAL::dim=2, T=double 24 -DEAL::dim=2, T=complex 48 -DEAL::dim=3, T=double 48 -DEAL::dim=3, T=complex 96 -DEAL::check rank 4 tensors -DEAL::dim=1, T=double 8 -DEAL::dim=1, T=complex 16 -DEAL::dim=2, T=double 72 -DEAL::dim=2, T=complex 144 -DEAL::dim=3, T=double 288 -DEAL::dim=3, T=complex 576 -DEAL::OK diff --git a/tests/matrix_free/step-37.cc b/tests/matrix_free/step-37.cc index 962c4f1161..942b1092ae 100644 --- a/tests/matrix_free/step-37.cc +++ b/tests/matrix_free/step-37.cc @@ -146,8 +146,6 @@ namespace Step37 const unsigned int col) const; void set_diagonal (const Vector &diagonal); - std::size_t memory_consumption () const; - private: void local_apply (const MatrixFree &data, Vector &dst, @@ -346,19 +344,6 @@ namespace Step37 - template - std::size_t - LaplaceOperator::memory_consumption () const - { - return (data.memory_consumption () + - coefficient.memory_consumption() + - diagonal_values.memory_consumption() + - MemoryConsumption::memory_consumption(diagonal_is_available)); - } - - - - template class LaplaceProblem { @@ -597,11 +582,6 @@ namespace Step37 MGTransferPrebuilt > > preconditioner(dof_handler, mg, mg_transfer); - const std::size_t multigrid_memory - = (mg_matrices.memory_consumption() + - mg_transfer.memory_consumption() + - coarse_matrix.memory_consumption()); - SolverControl solver_control (1000, 1e-12*system_rhs.l2_norm()); SolverCG<> cg (solver_control); @@ -657,4 +637,3 @@ int main () return 0; } - diff --git a/tests/mpi/parallel_block_vector_03.cc b/tests/mpi/parallel_block_vector_03.cc deleted file mode 100644 index 9fdd89369c..0000000000 --- a/tests/mpi/parallel_block_vector_03.cc +++ /dev/null @@ -1,71 +0,0 @@ -// --------------------------------------------------------------------- -// -// Copyright (C) 2016 by the deal.II authors -// -// This file is part of the deal.II library. -// -// The deal.II library is free software; you can use it, redistribute -// it, and/or modify it under the terms of the GNU Lesser General -// Public License as published by the Free Software Foundation; either -// version 2.1 of the License, or (at your option) any later version. -// The full text of the license can be found in the file LICENSE at -// the top level of the deal.II distribution. -// -// --------------------------------------------------------------------- - - -// check memory consumption parallel vector - -#include "../tests.h" -#include -#include -#include -#include -#include -#include - - -void test () -{ - 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; - - - // each processor from processor 1 to 8 owns 2 indices (the other processors - // do not own any dof), and all processors are ghosting element 1 - IndexSet local_owned(30); - if (myid == 0) - local_owned.add_range(0,20); - else - local_owned.add_range(std::min(20U,20*myid),30U); - IndexSet local_relevant(30); - local_relevant = local_owned; - local_relevant.add_range(19,20); - - LinearAlgebra::distributed::Vector v(local_owned, local_relevant, - MPI_COMM_WORLD); - - deallog << v.memory_consumption() << std::endl; - - LinearAlgebra::distributed::BlockVector w(3); - for (unsigned int i=0; i<3; ++i) - { - w.block(i) = v; - w.block(i) *= (i+1); - } - w.collect_sizes(); - - deallog << w.memory_consumption() << std::endl; -} - - - -int main (int argc, char **argv) -{ - Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads()); - - MPILogInitAll log; - test(); -} diff --git a/tests/mpi/parallel_block_vector_03.with_64bit_indices=off.mpirun=2.output b/tests/mpi/parallel_block_vector_03.with_64bit_indices=off.mpirun=2.output deleted file mode 100644 index b9dc03e0e3..0000000000 --- a/tests/mpi/parallel_block_vector_03.with_64bit_indices=off.mpirun=2.output +++ /dev/null @@ -1,8 +0,0 @@ - -DEAL:0::numproc=2 -DEAL:0::599 -DEAL:0::1476 - -DEAL:1::519 -DEAL:1::1254 - diff --git a/tests/mpi/parallel_block_vector_03.with_64bit_indices=off.mpirun=2.output.2 b/tests/mpi/parallel_block_vector_03.with_64bit_indices=off.mpirun=2.output.2 deleted file mode 100644 index 6e54a65e37..0000000000 --- a/tests/mpi/parallel_block_vector_03.with_64bit_indices=off.mpirun=2.output.2 +++ /dev/null @@ -1,8 +0,0 @@ - -DEAL:0::numproc=2 -DEAL:0::569 -DEAL:0::1383 - -DEAL:1::489 -DEAL:1::1161 - diff --git a/tests/mpi/parallel_block_vector_03.with_64bit_indices=off.mpirun=2.output.clang8-apple b/tests/mpi/parallel_block_vector_03.with_64bit_indices=off.mpirun=2.output.clang8-apple deleted file mode 100644 index 2587641957..0000000000 --- a/tests/mpi/parallel_block_vector_03.with_64bit_indices=off.mpirun=2.output.clang8-apple +++ /dev/null @@ -1,8 +0,0 @@ - -DEAL:0::numproc=2 -DEAL:0::727 -DEAL:0::1548 - -DEAL:1::647 -DEAL:1::1326 - diff --git a/tests/mpi/parallel_block_vector_03.with_64bit_indices=off.mpirun=2.output.gcc4 b/tests/mpi/parallel_block_vector_03.with_64bit_indices=off.mpirun=2.output.gcc4 deleted file mode 100644 index aa21f5988d..0000000000 --- a/tests/mpi/parallel_block_vector_03.with_64bit_indices=off.mpirun=2.output.gcc4 +++ /dev/null @@ -1,8 +0,0 @@ - -DEAL:0::numproc=2 -DEAL:0::675 -DEAL:0::1533 - -DEAL:1::595 -DEAL:1::1311 - diff --git a/tests/mpi/parallel_block_vector_03.with_64bit_indices=off.mpirun=2.output.gcc6 b/tests/mpi/parallel_block_vector_03.with_64bit_indices=off.mpirun=2.output.gcc6 deleted file mode 100644 index 53113d22c9..0000000000 --- a/tests/mpi/parallel_block_vector_03.with_64bit_indices=off.mpirun=2.output.gcc6 +++ /dev/null @@ -1,8 +0,0 @@ - -DEAL:0::numproc=2 -DEAL:0::679 -DEAL:0::1536 - -DEAL:1::599 -DEAL:1::1314 - diff --git a/tests/mpi/parallel_block_vector_03.with_64bit_indices=on.mpirun=2.output b/tests/mpi/parallel_block_vector_03.with_64bit_indices=on.mpirun=2.output deleted file mode 100644 index 8b07f9e7fb..0000000000 --- a/tests/mpi/parallel_block_vector_03.with_64bit_indices=on.mpirun=2.output +++ /dev/null @@ -1,8 +0,0 @@ - -DEAL:0::numproc=2 -DEAL:0::643 -DEAL:0::1501 - -DEAL:1::563 -DEAL:1::1279 - diff --git a/tests/mpi/parallel_block_vector_03.with_64bit_indices=on.mpirun=2.output.2 b/tests/mpi/parallel_block_vector_03.with_64bit_indices=on.mpirun=2.output.2 deleted file mode 100644 index e252434c1f..0000000000 --- a/tests/mpi/parallel_block_vector_03.with_64bit_indices=on.mpirun=2.output.2 +++ /dev/null @@ -1,8 +0,0 @@ - -DEAL:0::numproc=2 -DEAL:0::643 -DEAL:0::1525 - -DEAL:1::563 -DEAL:1::1303 - diff --git a/tests/mpi/parallel_block_vector_03.with_64bit_indices=on.mpirun=2.output.gcc4 b/tests/mpi/parallel_block_vector_03.with_64bit_indices=on.mpirun=2.output.gcc4 deleted file mode 100644 index 1ca50abed3..0000000000 --- a/tests/mpi/parallel_block_vector_03.with_64bit_indices=on.mpirun=2.output.gcc4 +++ /dev/null @@ -1,8 +0,0 @@ - -DEAL:0::numproc=2 -DEAL:0::719 -DEAL:0::1582 - -DEAL:1::639 -DEAL:1::1360 - diff --git a/tests/mpi/parallel_block_vector_03.with_64bit_indices=on.mpirun=2.output.gcc6 b/tests/mpi/parallel_block_vector_03.with_64bit_indices=on.mpirun=2.output.gcc6 deleted file mode 100644 index 699bafa6a2..0000000000 --- a/tests/mpi/parallel_block_vector_03.with_64bit_indices=on.mpirun=2.output.gcc6 +++ /dev/null @@ -1,8 +0,0 @@ - -DEAL:0::numproc=2 -DEAL:0::723 -DEAL:0::1585 - -DEAL:1::643 -DEAL:1::1363 - -- 2.39.5