]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Clean testsuite from deprecated Trilinos vector functions
authorDaniel Arndt <daniel.arndt@iwr.uni-heidelberg.de>
Fri, 5 May 2017 15:15:43 +0000 (17:15 +0200)
committerDaniel Arndt <daniel.arndt@iwr.uni-heidelberg.de>
Fri, 5 May 2017 15:49:16 +0000 (17:49 +0200)
100 files changed:
include/deal.II/lac/trilinos_parallel_block_vector.h
tests/mpi/trilinos_sadd_02.cc [deleted file]
tests/mpi/trilinos_sadd_02.with_trilinos=true.mpirun=1.output [deleted file]
tests/mpi/trilinos_sadd_02.with_trilinos=true.mpirun=2.output [deleted file]
tests/mpi/trilinos_sadd_03.cc [deleted file]
tests/mpi/trilinos_sadd_03.with_trilinos=true.mpirun=3.output [deleted file]
tests/trilinos/11.cc
tests/trilinos/12.cc
tests/trilinos/13.cc
tests/trilinos/14.cc
tests/trilinos/15.cc
tests/trilinos/16.cc
tests/trilinos/17.cc
tests/trilinos/18.cc
tests/trilinos/19.cc
tests/trilinos/20.cc
tests/trilinos/21.cc
tests/trilinos/22.cc
tests/trilinos/23.cc
tests/trilinos/24.cc
tests/trilinos/26.cc
tests/trilinos/27.cc
tests/trilinos/28.cc
tests/trilinos/29.cc
tests/trilinos/30.cc
tests/trilinos/31.cc
tests/trilinos/32.cc
tests/trilinos/33.cc
tests/trilinos/34.cc
tests/trilinos/35.cc
tests/trilinos/36.cc
tests/trilinos/37.cc
tests/trilinos/38.cc
tests/trilinos/39.cc
tests/trilinos/40.cc
tests/trilinos/41.cc
tests/trilinos/42.cc
tests/trilinos/43.cc [deleted file]
tests/trilinos/43.output [deleted file]
tests/trilinos/44.cc [deleted file]
tests/trilinos/44.output [deleted file]
tests/trilinos/45.cc
tests/trilinos/46.cc
tests/trilinos/47.cc [deleted file]
tests/trilinos/47.output [deleted file]
tests/trilinos/48.cc [deleted file]
tests/trilinos/48.output [deleted file]
tests/trilinos/49.cc
tests/trilinos/49a.cc
tests/trilinos/49b.cc
tests/trilinos/50.cc
tests/trilinos/51.cc
tests/trilinos/53.cc
tests/trilinos/54.cc
tests/trilinos/55.cc
tests/trilinos/56.cc
tests/trilinos/57.cc
tests/trilinos/58.cc
tests/trilinos/59.cc [deleted file]
tests/trilinos/59.output [deleted file]
tests/trilinos/60.cc
tests/trilinos/61.cc
tests/trilinos/65.cc [deleted file]
tests/trilinos/65.output [deleted file]
tests/trilinos/block_vector_iterator_01.cc
tests/trilinos/block_vector_iterator_02.cc
tests/trilinos/block_vector_iterator_03.cc
tests/trilinos/block_vector_iterator_03.output
tests/trilinos/deal_solver_01.cc
tests/trilinos/deal_solver_02.cc
tests/trilinos/deal_solver_03.cc
tests/trilinos/deal_solver_04.cc
tests/trilinos/deal_solver_05.cc
tests/trilinos/deal_solver_06.cc
tests/trilinos/slowness_02.cc
tests/trilinos/slowness_03.cc
tests/trilinos/slowness_04.cc
tests/trilinos/solver_03.cc
tests/trilinos/solver_05.cc
tests/trilinos/solver_07.cc
tests/trilinos/solver_control_01.cc
tests/trilinos/solver_control_02.cc
tests/trilinos/solver_control_03.cc
tests/trilinos/solver_control_04.cc
tests/trilinos/solver_control_05.cc
tests/trilinos/sparse_matrix_vector_01.cc
tests/trilinos/sparse_matrix_vector_02.cc
tests/trilinos/sparse_matrix_vector_03.cc
tests/trilinos/sparse_matrix_vector_04.cc
tests/trilinos/sparse_matrix_vector_05.cc
tests/trilinos/sparse_matrix_vector_06.cc
tests/trilinos/sparse_matrix_vector_07.cc
tests/trilinos/vector_assign_01.cc
tests/trilinos/vector_assign_02.cc
tests/trilinos/vector_equality_1.cc
tests/trilinos/vector_equality_2.cc
tests/trilinos/vector_equality_3.cc
tests/trilinos/vector_equality_4.cc
tests/trilinos/vector_reference_01.cc
tests/trilinos/vector_swap_01.cc

index bf515470739c64e2f2675fd305174b6c41790b88..0597cce0a9c0ccdf6c6af48ea4d27e714e2c4ee9 100644 (file)
@@ -186,19 +186,6 @@ namespace TrilinosWrappers
       template <typename Number>
       BlockVector &operator= (const ::dealii::BlockVector<Number> &v);
 
-      /**
-       * Reinitialize the BlockVector to contain as many blocks as there are
-       * Epetra_Maps given in the input argument, according to the parallel
-       * distribution of the individual components described in the maps.
-       *
-       * If <tt>omit_zeroing_entries==false</tt>, the vector is filled with
-       * zeros.
-       *
-       * This function is deprecated.
-       */
-      void reinit (const std::vector<Epetra_Map> &parallel_partitioning,
-                   const bool                     omit_zeroing_entries = false) DEAL_II_DEPRECATED;
-
       /**
        * Reinitialize the BlockVector to contain as many blocks as there are
        * index sets given in the input argument, according to the parallel
diff --git a/tests/mpi/trilinos_sadd_02.cc b/tests/mpi/trilinos_sadd_02.cc
deleted file mode 100644 (file)
index dd96a99..0000000
+++ /dev/null
@@ -1,117 +0,0 @@
-// ---------------------------------------------------------------------
-//
-// Copyright (C) 2011 - 2015 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 correct behaviour of sadd of Trilinos vectors
-// if they have different Epetra maps
-
-#include "../tests.h"
-#include <deal.II/base/utilities.h>
-#include <deal.II/base/index_set.h>
-#include <deal.II/lac/trilinos_vector.h>
-#include <fstream>
-#include <iostream>
-#include <vector>
-#include <algorithm>
-
-void test ()
-{
-  TrilinosWrappers::MPI::Vector ghosted, ghosted2, distributed, distributed2;
-  //All processes should own 10 entries
-  const int entries_per_process = 10;
-  const int n_proc = Utilities::MPI::n_mpi_processes(MPI_COMM_WORLD);
-  IndexSet locally_owned(entries_per_process*n_proc);
-  IndexSet locally_relevant(entries_per_process*n_proc);
-  const int my_id = Utilities::MPI::this_mpi_process(MPI_COMM_WORLD);
-  const int begin_index = my_id*entries_per_process;
-  const int end_index = (my_id+1)*entries_per_process;
-  const int local_begin = std::max(0, begin_index-entries_per_process/2);
-  const int local_end = entries_per_process*n_proc;
-
-  locally_owned.add_range(begin_index, end_index);
-  locally_relevant.add_range
-  (local_begin, local_end);
-
-  distributed.reinit(locally_owned, MPI_COMM_WORLD);
-  distributed2.reinit(locally_owned, MPI_COMM_WORLD);
-  ghosted.reinit (locally_owned, locally_relevant, MPI_COMM_WORLD);
-  ghosted2.reinit (locally_owned, locally_relevant, MPI_COMM_WORLD);
-
-  distributed=1.;
-  ghosted=distributed;
-  ghosted *= 1.6;
-  distributed.sadd (2., ghosted);
-  ghosted = distributed;
-  deallog << "sadd (s, v)" <<std::endl;
-  if (my_id==0)
-    for (unsigned int i=local_begin; i<local_end; ++i)
-      deallog << i << ": " << ghosted(i) << std::endl;
-
-  distributed=1.;
-  ghosted=distributed;
-  ghosted *= 1.6;
-  distributed.sadd (2., 3., ghosted);
-  ghosted = distributed;
-  deallog << "sadd (s, a, v)" <<std::endl;
-  if (my_id==0)
-    for (unsigned int i=local_begin; i<local_end; ++i)
-      deallog << i << ": " << ghosted(i) << std::endl;
-
-  distributed=1.;
-  ghosted=distributed;
-  ghosted *= 1.6;
-  ghosted2 = distributed;
-  ghosted2 *= 0.354;
-  distributed.sadd (2., 3., ghosted, 4., ghosted2);
-  ghosted = distributed;
-  deallog << "sadd (s, a, v, b, w)" <<std::endl;
-  if (my_id==0)
-    for (unsigned int i=local_begin; i<local_end; ++i)
-      deallog << i << ": " << ghosted(i) << std::endl;
-
-  distributed=1.;
-  ghosted=distributed;
-  distributed2 = 7.22;
-  distributed.sadd (2., 3., ghosted, 4., ghosted2, 5., distributed2);
-  ghosted = distributed;
-  deallog << "sadd (s, a, v, b, w, c, x)" <<std::endl;
-  if (my_id==0)
-    for (unsigned int i=local_begin; i<local_end; ++i)
-      deallog << i << ": " << ghosted(i) << std::endl;
-}
-
-
-
-int main (int argc, char **argv)
-{
-  Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
-
-  unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
-  deallog.push(Utilities::int_to_string(myid));
-
-  if (myid == 0)
-    {
-      std::ofstream logfile("output");
-      deallog.attach(logfile);
-      deallog << std::setprecision(4);
-      deallog.threshold_double(1.e-10);
-
-      test();
-    }
-  else
-    test();
-
-}
diff --git a/tests/mpi/trilinos_sadd_02.with_trilinos=true.mpirun=1.output b/tests/mpi/trilinos_sadd_02.with_trilinos=true.mpirun=1.output
deleted file mode 100644 (file)
index 27340e5..0000000
+++ /dev/null
@@ -1,45 +0,0 @@
-
-DEAL:0::sadd (s, v)
-DEAL:0::0: 3.600
-DEAL:0::1: 3.600
-DEAL:0::2: 3.600
-DEAL:0::3: 3.600
-DEAL:0::4: 3.600
-DEAL:0::5: 3.600
-DEAL:0::6: 3.600
-DEAL:0::7: 3.600
-DEAL:0::8: 3.600
-DEAL:0::9: 3.600
-DEAL:0::sadd (s, a, v)
-DEAL:0::0: 6.800
-DEAL:0::1: 6.800
-DEAL:0::2: 6.800
-DEAL:0::3: 6.800
-DEAL:0::4: 6.800
-DEAL:0::5: 6.800
-DEAL:0::6: 6.800
-DEAL:0::7: 6.800
-DEAL:0::8: 6.800
-DEAL:0::9: 6.800
-DEAL:0::sadd (s, a, v, b, w)
-DEAL:0::0: 8.216
-DEAL:0::1: 8.216
-DEAL:0::2: 8.216
-DEAL:0::3: 8.216
-DEAL:0::4: 8.216
-DEAL:0::5: 8.216
-DEAL:0::6: 8.216
-DEAL:0::7: 8.216
-DEAL:0::8: 8.216
-DEAL:0::9: 8.216
-DEAL:0::sadd (s, a, v, b, w, c, x)
-DEAL:0::0: 42.52
-DEAL:0::1: 42.52
-DEAL:0::2: 42.52
-DEAL:0::3: 42.52
-DEAL:0::4: 42.52
-DEAL:0::5: 42.52
-DEAL:0::6: 42.52
-DEAL:0::7: 42.52
-DEAL:0::8: 42.52
-DEAL:0::9: 42.52
diff --git a/tests/mpi/trilinos_sadd_02.with_trilinos=true.mpirun=2.output b/tests/mpi/trilinos_sadd_02.with_trilinos=true.mpirun=2.output
deleted file mode 100644 (file)
index d96caea..0000000
+++ /dev/null
@@ -1,85 +0,0 @@
-
-DEAL:0::sadd (s, v)
-DEAL:0::0: 3.600
-DEAL:0::1: 3.600
-DEAL:0::2: 3.600
-DEAL:0::3: 3.600
-DEAL:0::4: 3.600
-DEAL:0::5: 3.600
-DEAL:0::6: 3.600
-DEAL:0::7: 3.600
-DEAL:0::8: 3.600
-DEAL:0::9: 3.600
-DEAL:0::10: 3.600
-DEAL:0::11: 3.600
-DEAL:0::12: 3.600
-DEAL:0::13: 3.600
-DEAL:0::14: 3.600
-DEAL:0::15: 3.600
-DEAL:0::16: 3.600
-DEAL:0::17: 3.600
-DEAL:0::18: 3.600
-DEAL:0::19: 3.600
-DEAL:0::sadd (s, a, v)
-DEAL:0::0: 6.800
-DEAL:0::1: 6.800
-DEAL:0::2: 6.800
-DEAL:0::3: 6.800
-DEAL:0::4: 6.800
-DEAL:0::5: 6.800
-DEAL:0::6: 6.800
-DEAL:0::7: 6.800
-DEAL:0::8: 6.800
-DEAL:0::9: 6.800
-DEAL:0::10: 6.800
-DEAL:0::11: 6.800
-DEAL:0::12: 6.800
-DEAL:0::13: 6.800
-DEAL:0::14: 6.800
-DEAL:0::15: 6.800
-DEAL:0::16: 6.800
-DEAL:0::17: 6.800
-DEAL:0::18: 6.800
-DEAL:0::19: 6.800
-DEAL:0::sadd (s, a, v, b, w)
-DEAL:0::0: 8.216
-DEAL:0::1: 8.216
-DEAL:0::2: 8.216
-DEAL:0::3: 8.216
-DEAL:0::4: 8.216
-DEAL:0::5: 8.216
-DEAL:0::6: 8.216
-DEAL:0::7: 8.216
-DEAL:0::8: 8.216
-DEAL:0::9: 8.216
-DEAL:0::10: 8.216
-DEAL:0::11: 8.216
-DEAL:0::12: 8.216
-DEAL:0::13: 8.216
-DEAL:0::14: 8.216
-DEAL:0::15: 8.216
-DEAL:0::16: 8.216
-DEAL:0::17: 8.216
-DEAL:0::18: 8.216
-DEAL:0::19: 8.216
-DEAL:0::sadd (s, a, v, b, w, c, x)
-DEAL:0::0: 42.52
-DEAL:0::1: 42.52
-DEAL:0::2: 42.52
-DEAL:0::3: 42.52
-DEAL:0::4: 42.52
-DEAL:0::5: 42.52
-DEAL:0::6: 42.52
-DEAL:0::7: 42.52
-DEAL:0::8: 42.52
-DEAL:0::9: 42.52
-DEAL:0::10: 42.52
-DEAL:0::11: 42.52
-DEAL:0::12: 42.52
-DEAL:0::13: 42.52
-DEAL:0::14: 42.52
-DEAL:0::15: 42.52
-DEAL:0::16: 42.52
-DEAL:0::17: 42.52
-DEAL:0::18: 42.52
-DEAL:0::19: 42.52
diff --git a/tests/mpi/trilinos_sadd_03.cc b/tests/mpi/trilinos_sadd_03.cc
deleted file mode 100644 (file)
index 042229b..0000000
+++ /dev/null
@@ -1,162 +0,0 @@
-// ---------------------------------------------------------------------
-//
-// Copyright (C) 2011 - 2015 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 correct behaviour of sadd of Trilinos vectors
-// if there are processes that doesn't own anything
-
-#include "../tests.h"
-#include <deal.II/base/utilities.h>
-#include <deal.II/base/index_set.h>
-#include <deal.II/lac/trilinos_vector.h>
-#include <fstream>
-#include <iostream>
-#include <vector>
-#include <algorithm>
-
-void test ()
-{
-  TrilinosWrappers::MPI::Vector ghosted, ghosted2, distributed, distributed2;
-  const unsigned int my_id = Utilities::MPI::this_mpi_process(MPI_COMM_WORLD);
-  const unsigned int n_proc = Utilities::MPI::n_mpi_processes(MPI_COMM_WORLD);
-  //All processes except for the last one own elements
-  const int entries_per_process = (my_id==n_proc-1)?0:10;
-  IndexSet locally_owned(entries_per_process*(n_proc-1));
-  IndexSet locally_relevant(entries_per_process*(n_proc-1));
-  const int begin_index = my_id*entries_per_process;
-  const unsigned int end_index = (my_id+1)*entries_per_process;
-  const unsigned int local_begin = std::max(0, begin_index-entries_per_process/2);
-  const unsigned int local_end = entries_per_process*(n_proc-1);
-
-  if (my_id != n_proc-1)
-    {
-      locally_owned.add_range(begin_index, end_index);
-      locally_relevant.add_range(local_begin, local_end);
-    }
-
-  distributed.reinit(locally_owned, MPI_COMM_WORLD);
-  distributed2.reinit(locally_owned, MPI_COMM_WORLD);
-  ghosted.reinit (locally_owned, locally_relevant, MPI_COMM_WORLD);
-  ghosted2.reinit (locally_owned, locally_relevant, MPI_COMM_WORLD);
-
-  //sadd(s,v) with ghosted vector
-  distributed=1.;
-  ghosted=distributed;
-  ghosted *= 1.6;
-  distributed.sadd (2., ghosted);
-  ghosted = distributed;
-  deallog << "sadd (s, v) ghosted" <<std::endl;
-  if (my_id==0)
-    for (unsigned int i=local_begin; i<local_end; ++i)
-      deallog << i << ": " << ghosted(i) << std::endl;
-
-  //sadd(s,v) with distributed vector
-  distributed=1.;
-  distributed.sadd (1.5, distributed);
-  ghosted = distributed;
-  deallog << "sadd (s, v) distributed" <<std::endl;
-  if (my_id==0)
-    for (unsigned int i=local_begin; i<local_end; ++i)
-      deallog << i << ": " << ghosted(i) << std::endl;
-
-  //sadd(s,a,v) with ghosted vector
-  distributed=1.;
-  ghosted=distributed;
-  ghosted *= 1.6;
-  distributed.sadd (2., 3., ghosted);
-  ghosted = distributed;
-  deallog << "sadd (s, a, v) ghosted" <<std::endl;
-  if (my_id==0)
-    for (unsigned int i=local_begin; i<local_end; ++i)
-      deallog << i << ": " << ghosted(i) << std::endl;
-
-  //sadd(s,a,v) with distributed vector
-  distributed=1.;
-  distributed.sadd (2., 3., distributed);
-  ghosted = distributed;
-  deallog << "sadd (s, a, v) distributed" <<std::endl;
-  if (my_id==0)
-    for (unsigned int i=local_begin; i<local_end; ++i)
-      deallog << i << ": " << ghosted(i) << std::endl;
-
-  //sadd(s,a,v,b,w) with ghosted vector
-  distributed=1.;
-  ghosted=distributed;
-  ghosted *= 1.6;
-  ghosted2 = distributed;
-  ghosted2 *= 0.354;
-  distributed.sadd (2., 3., ghosted, 4., ghosted2);
-  ghosted = distributed;
-  deallog << "sadd (s, a, v, b, w) ghosted" <<std::endl;
-  if (my_id==0)
-    for (unsigned int i=local_begin; i<local_end; ++i)
-      deallog << i << ": " << ghosted(i) << std::endl;
-
-  //sadd(s,a,v,b,w) with distributed vector
-  distributed=1.;
-  distributed2=1.6;
-  distributed.sadd (2., 3., distributed, 4., distributed2);
-  ghosted = distributed;
-  deallog << "sadd (s, a, v, b, w) distributed" <<std::endl;
-  if (my_id==0)
-    for (unsigned int i=local_begin; i<local_end; ++i)
-      deallog << i << ": " << ghosted(i) << std::endl;
-
-  //sadd(s,a,v,b,w,c,x) with ghosted vector
-  distributed=1.;
-  ghosted=distributed;
-  distributed2 = 7.22;
-  ghosted2=distributed2;
-  distributed.sadd (2., 3., ghosted, 4., ghosted2, 5., distributed2);
-  ghosted = distributed;
-  deallog << "sadd (s, a, v, b, w, c, x) ghosted" <<std::endl;
-  if (my_id==0)
-    for (unsigned int i=local_begin; i<local_end; ++i)
-      deallog << i << ": " << ghosted(i) << std::endl;
-
-  //sadd(s,a,v,b,w,c,x) with distributed vector
-  distributed=1.;
-  distributed2 = 7.22;
-  distributed.sadd (2., 3., distributed, 4., distributed, 5., distributed2);
-  ghosted = distributed;
-  deallog << "sadd (s, a, v, b, w, c, x) distributed" <<std::endl;
-  if (my_id==0)
-    for (unsigned int i=local_begin; i<local_end; ++i)
-      deallog << i << ": " << ghosted(i) << std::endl;
-}
-
-
-
-int main (int argc, char **argv)
-{
-  Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
-
-  unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
-  deallog.push(Utilities::int_to_string(myid));
-
-  if (myid == 0)
-    {
-      std::ofstream logfile("output");
-      deallog.attach(logfile);
-      deallog << std::setprecision(4);
-      deallog.threshold_double(1.e-10);
-
-      test();
-    }
-  else
-    test();
-
-}
diff --git a/tests/mpi/trilinos_sadd_03.with_trilinos=true.mpirun=3.output b/tests/mpi/trilinos_sadd_03.with_trilinos=true.mpirun=3.output
deleted file mode 100644 (file)
index 86ec565..0000000
+++ /dev/null
@@ -1,169 +0,0 @@
-
-DEAL:0::sadd (s, v) ghosted
-DEAL:0::0: 3.600
-DEAL:0::1: 3.600
-DEAL:0::2: 3.600
-DEAL:0::3: 3.600
-DEAL:0::4: 3.600
-DEAL:0::5: 3.600
-DEAL:0::6: 3.600
-DEAL:0::7: 3.600
-DEAL:0::8: 3.600
-DEAL:0::9: 3.600
-DEAL:0::10: 3.600
-DEAL:0::11: 3.600
-DEAL:0::12: 3.600
-DEAL:0::13: 3.600
-DEAL:0::14: 3.600
-DEAL:0::15: 3.600
-DEAL:0::16: 3.600
-DEAL:0::17: 3.600
-DEAL:0::18: 3.600
-DEAL:0::19: 3.600
-DEAL:0::sadd (s, v) distributed
-DEAL:0::0: 2.500
-DEAL:0::1: 2.500
-DEAL:0::2: 2.500
-DEAL:0::3: 2.500
-DEAL:0::4: 2.500
-DEAL:0::5: 2.500
-DEAL:0::6: 2.500
-DEAL:0::7: 2.500
-DEAL:0::8: 2.500
-DEAL:0::9: 2.500
-DEAL:0::10: 2.500
-DEAL:0::11: 2.500
-DEAL:0::12: 2.500
-DEAL:0::13: 2.500
-DEAL:0::14: 2.500
-DEAL:0::15: 2.500
-DEAL:0::16: 2.500
-DEAL:0::17: 2.500
-DEAL:0::18: 2.500
-DEAL:0::19: 2.500
-DEAL:0::sadd (s, a, v) ghosted
-DEAL:0::0: 6.800
-DEAL:0::1: 6.800
-DEAL:0::2: 6.800
-DEAL:0::3: 6.800
-DEAL:0::4: 6.800
-DEAL:0::5: 6.800
-DEAL:0::6: 6.800
-DEAL:0::7: 6.800
-DEAL:0::8: 6.800
-DEAL:0::9: 6.800
-DEAL:0::10: 6.800
-DEAL:0::11: 6.800
-DEAL:0::12: 6.800
-DEAL:0::13: 6.800
-DEAL:0::14: 6.800
-DEAL:0::15: 6.800
-DEAL:0::16: 6.800
-DEAL:0::17: 6.800
-DEAL:0::18: 6.800
-DEAL:0::19: 6.800
-DEAL:0::sadd (s, a, v) distributed
-DEAL:0::0: 5.000
-DEAL:0::1: 5.000
-DEAL:0::2: 5.000
-DEAL:0::3: 5.000
-DEAL:0::4: 5.000
-DEAL:0::5: 5.000
-DEAL:0::6: 5.000
-DEAL:0::7: 5.000
-DEAL:0::8: 5.000
-DEAL:0::9: 5.000
-DEAL:0::10: 5.000
-DEAL:0::11: 5.000
-DEAL:0::12: 5.000
-DEAL:0::13: 5.000
-DEAL:0::14: 5.000
-DEAL:0::15: 5.000
-DEAL:0::16: 5.000
-DEAL:0::17: 5.000
-DEAL:0::18: 5.000
-DEAL:0::19: 5.000
-DEAL:0::sadd (s, a, v, b, w) ghosted
-DEAL:0::0: 8.216
-DEAL:0::1: 8.216
-DEAL:0::2: 8.216
-DEAL:0::3: 8.216
-DEAL:0::4: 8.216
-DEAL:0::5: 8.216
-DEAL:0::6: 8.216
-DEAL:0::7: 8.216
-DEAL:0::8: 8.216
-DEAL:0::9: 8.216
-DEAL:0::10: 8.216
-DEAL:0::11: 8.216
-DEAL:0::12: 8.216
-DEAL:0::13: 8.216
-DEAL:0::14: 8.216
-DEAL:0::15: 8.216
-DEAL:0::16: 8.216
-DEAL:0::17: 8.216
-DEAL:0::18: 8.216
-DEAL:0::19: 8.216
-DEAL:0::sadd (s, a, v, b, w) distributed
-DEAL:0::0: 11.40
-DEAL:0::1: 11.40
-DEAL:0::2: 11.40
-DEAL:0::3: 11.40
-DEAL:0::4: 11.40
-DEAL:0::5: 11.40
-DEAL:0::6: 11.40
-DEAL:0::7: 11.40
-DEAL:0::8: 11.40
-DEAL:0::9: 11.40
-DEAL:0::10: 11.40
-DEAL:0::11: 11.40
-DEAL:0::12: 11.40
-DEAL:0::13: 11.40
-DEAL:0::14: 11.40
-DEAL:0::15: 11.40
-DEAL:0::16: 11.40
-DEAL:0::17: 11.40
-DEAL:0::18: 11.40
-DEAL:0::19: 11.40
-DEAL:0::sadd (s, a, v, b, w, c, x) ghosted
-DEAL:0::0: 69.98
-DEAL:0::1: 69.98
-DEAL:0::2: 69.98
-DEAL:0::3: 69.98
-DEAL:0::4: 69.98
-DEAL:0::5: 69.98
-DEAL:0::6: 69.98
-DEAL:0::7: 69.98
-DEAL:0::8: 69.98
-DEAL:0::9: 69.98
-DEAL:0::10: 69.98
-DEAL:0::11: 69.98
-DEAL:0::12: 69.98
-DEAL:0::13: 69.98
-DEAL:0::14: 69.98
-DEAL:0::15: 69.98
-DEAL:0::16: 69.98
-DEAL:0::17: 69.98
-DEAL:0::18: 69.98
-DEAL:0::19: 69.98
-DEAL:0::sadd (s, a, v, b, w, c, x) distributed
-DEAL:0::0: 45.10
-DEAL:0::1: 45.10
-DEAL:0::2: 45.10
-DEAL:0::3: 45.10
-DEAL:0::4: 45.10
-DEAL:0::5: 45.10
-DEAL:0::6: 45.10
-DEAL:0::7: 45.10
-DEAL:0::8: 45.10
-DEAL:0::9: 45.10
-DEAL:0::10: 45.10
-DEAL:0::11: 45.10
-DEAL:0::12: 45.10
-DEAL:0::13: 45.10
-DEAL:0::14: 45.10
-DEAL:0::15: 45.10
-DEAL:0::16: 45.10
-DEAL:0::17: 45.10
-DEAL:0::18: 45.10
-DEAL:0::19: 45.10
index 4d02b176289f8e049746349e244c8454a1d62e1b..2b6fc244a47c0cec69aeb1e601d2948259c36d0b 100644 (file)
@@ -51,7 +51,8 @@ int main (int argc,char **argv)
   try
     {
       {
-        TrilinosWrappers::Vector v (100);
+        TrilinosWrappers::Vector v;
+        v.reinit(100);
         test (v);
       }
     }
index 03aaff5a003c60fe00708aeac50caf1e1a954837..bdc829011e295df0934e5f53952d8120f7f9f8ae 100644 (file)
@@ -64,7 +64,8 @@ int main (int argc,char **argv)
   try
     {
       {
-        TrilinosWrappers::Vector v (100);
+        TrilinosWrappers::Vector v;
+        v.reinit(100);
         test (v);
       }
     }
index c5a75a0d7c2d6a041c0e3f2a2495784df059c013..6bf65b5ee6b9466fab350ff6e7e230480902dfe3 100644 (file)
@@ -64,7 +64,8 @@ int main (int argc,char **argv)
   try
     {
       {
-        TrilinosWrappers::Vector v (100);
+        TrilinosWrappers::Vector v;
+        v.reinit(100);
         test (v);
       }
     }
index 78a441b4adb2642e1f658174316cbef91f9098da..a29e3e93be38ffcba39c92f3ea83160e3eead514 100644 (file)
@@ -83,7 +83,8 @@ int main (int argc,char **argv)
   try
     {
       {
-        TrilinosWrappers::Vector v (100);
+        TrilinosWrappers::Vector v;
+        v.reinit(100);
         test (v);
       }
     }
index 8564fc5ddcb2bccfc62ba6b784decbb53408986a..940f492eca45c95ff0d8f3018c7fa15550baad32 100644 (file)
@@ -82,7 +82,8 @@ int main (int argc,char **argv)
   try
     {
       {
-        TrilinosWrappers::Vector v (100);
+        TrilinosWrappers::Vector v;
+        v.reinit(100);
         test (v);
       }
     }
index 8a0cffe7dce7b82954f2572345c048437c6ef88a..238aa92e9e30ff3d50275a4d8a14805261848ef9 100644 (file)
@@ -83,7 +83,8 @@ int main (int argc,char **argv)
   try
     {
       {
-        TrilinosWrappers::Vector v (100);
+        TrilinosWrappers::Vector v;
+        v.reinit(100);
         test (v);
       }
     }
index 46aaa80c522ce916d578753722bf536e9cd32082..03007ee4c4678019d592d93a27326c7934ab1edb 100644 (file)
@@ -56,7 +56,8 @@ int main (int argc,char **argv)
   try
     {
       {
-        TrilinosWrappers::Vector v (100);
+        TrilinosWrappers::Vector v;
+        v.reinit(100);
         test (v);
       }
     }
index b9b7ee163e66ca666d7dec953309cd70e5ef9751..eddf0c3229f64a2034cb314d51975c1a400c22c3 100644 (file)
@@ -57,7 +57,8 @@ int main (int argc,char **argv)
   try
     {
       {
-        TrilinosWrappers::Vector v (100);
+        TrilinosWrappers::Vector v;
+        v.reinit(100);
         test (v);
       }
     }
index 1961380f114957c2001b4262daf256a2a1157baf..620adf865d5d8096f6b6da43f213a9764ea72019 100644 (file)
@@ -56,7 +56,8 @@ int main (int argc,char **argv)
   try
     {
       {
-        TrilinosWrappers::Vector v (100);
+        TrilinosWrappers::Vector v;
+        v.reinit(100);
         test (v);
       }
     }
index 8797e30ec0e69bf3e4535b4751f9bbab6b16d0d6..70dd6c64566e628319f8a21ef93262ec476f40e7 100644 (file)
@@ -65,7 +65,8 @@ int main (int argc,char **argv)
   try
     {
       {
-        TrilinosWrappers::Vector v (100);
+        TrilinosWrappers::Vector v;
+        v.reinit(100);
         test (v);
       }
     }
index 9c1238f41d7e0286c6cd778eda4fe6ebf53526a6..e3e1d692502216844fe47c25e82162974ffedb1a 100644 (file)
@@ -65,7 +65,8 @@ int main (int argc,char **argv)
   try
     {
       {
-        TrilinosWrappers::Vector v (100);
+        TrilinosWrappers::Vector v;
+        v.reinit(100);
         test (v);
       }
     }
index 3e6fabe88afa66e34b6c98ffb11169e4986abaf5..c2602f41118ee7b1a90ab53fcda81defb6b60c48 100644 (file)
@@ -59,8 +59,10 @@ int main (int argc,char **argv)
   try
     {
       {
-        TrilinosWrappers::Vector v (100);
-        TrilinosWrappers::Vector w (100);
+        TrilinosWrappers::Vector v;
+        v.reinit(100);
+        TrilinosWrappers::Vector w;
+        w.reinit(100);
         test (v,w);
       }
     }
index 00d9544467063d747c43dd9058ee5365f723fe58..8bbfcaf943d065d06511cf6d81a26c3de9f76f7c 100644 (file)
@@ -66,8 +66,10 @@ int main (int argc,char **argv)
   try
     {
       {
-        TrilinosWrappers::Vector v (100);
-        TrilinosWrappers::Vector w (100);
+        TrilinosWrappers::Vector v;
+        v.reinit(100);
+        TrilinosWrappers::Vector w;
+        w.reinit(100);
         test (v,w);
       }
     }
index 9857a567b536505d636aaee02e1cd09d85bebaaf..4a1fc3659bb7f3a55b6ad8fb44239200a3a214fc 100644 (file)
@@ -59,7 +59,8 @@ int main (int argc,char **argv)
   try
     {
       {
-        TrilinosWrappers::Vector v (100);
+        TrilinosWrappers::Vector v;
+        v.reinit(100);
         test (v);
       }
     }
index a2dd8b285e59b9b97cb339d7b33a7df9822b0af0..9cf9acb560029d0a5f4e18e29e6fcfb7cdddf891 100644 (file)
@@ -56,7 +56,8 @@ int main (int argc,char **argv)
   try
     {
       {
-        TrilinosWrappers::Vector v (100);
+        TrilinosWrappers::Vector v;
+        v.reinit(100);
         test (v);
       }
     }
index 0831d7ba6e9ef16f3b8cf1d9f174dc57eeb4e614..414197fe5589ec7cc99f65054165fcaf0afa9925 100644 (file)
@@ -34,7 +34,8 @@ void test (TrilinosWrappers::Vector &v)
   v.compress (VectorOperation::insert);
 
   // then copy it
-  TrilinosWrappers::Vector w (v.size());
+  TrilinosWrappers::Vector w;
+  w.reinit(v.size());
   w = v;
 
   // make sure they're equal
@@ -61,7 +62,8 @@ int main (int argc,char **argv)
   try
     {
       {
-        TrilinosWrappers::Vector v (100);
+        TrilinosWrappers::Vector v;
+        v.reinit(100);
         test (v);
       }
     }
index 730e13d2fe382bf64e43a50cef10abe6e83d0df2..2fcf5feac4ff221635db27d2a5996f50e100f4df 100644 (file)
@@ -36,7 +36,8 @@ void test (TrilinosWrappers::Vector &v)
 
   // then copy it to a vector of different
   // size
-  TrilinosWrappers::Vector w (1);
+  TrilinosWrappers::Vector w;
+  w.reinit(1);
   w = v;
 
   // make sure they're equal
@@ -63,7 +64,8 @@ int main (int argc,char **argv)
   try
     {
       {
-        TrilinosWrappers::Vector v (100);
+        TrilinosWrappers::Vector v;
+        v.reinit(100);
         test (v);
       }
     }
index e3199206c550fded116bf3810c756c897f295c99..31a9a7b2817845c136a9a5bef22c2364495c4c49 100644 (file)
@@ -48,7 +48,8 @@ int main (int argc,char **argv)
   try
     {
       {
-        TrilinosWrappers::Vector v (100);
+        TrilinosWrappers::Vector v;
+        v.reinit(100);
         test (v);
       }
     }
index 91424612bfb5acf3db43f0583444042d03753522..bc11b46186f5299ff9c8ba51b6433819313d738f 100644 (file)
@@ -56,7 +56,8 @@ int main (int argc,char **argv)
   try
     {
       {
-        TrilinosWrappers::Vector v (100);
+        TrilinosWrappers::Vector v;
+        v.reinit(100);
         test (v);
       }
     }
index 98f70ae55b0704e385566f19c960d000f2b15b26..35e767abbee37201cbe1c9e33aa182c599f30b71 100644 (file)
@@ -58,7 +58,8 @@ int main (int argc,char **argv)
   try
     {
       {
-        TrilinosWrappers::Vector v (100);
+        TrilinosWrappers::Vector v;
+        v.reinit(100);
         test (v);
       }
     }
index 235b6d6f0cc744a81a6373aa064b1c7681dc1a7d..dd720c444b07a6c1fc68c982c7e9e6662423e6af 100644 (file)
@@ -58,7 +58,8 @@ int main (int argc,char **argv)
   try
     {
       {
-        TrilinosWrappers::Vector v (100);
+        TrilinosWrappers::Vector v;
+        v.reinit(100);
         test (v);
       }
     }
index 3e9ca99110adf4c147fa3ed13363ce424daf9abe..971b32a9bec802665e2e26d03d033086f62269f8 100644 (file)
@@ -59,7 +59,8 @@ int main (int argc,char **argv)
   try
     {
       {
-        TrilinosWrappers::Vector v (100);
+        TrilinosWrappers::Vector v;
+        v.reinit(100);
         test (v);
       }
     }
index bfe0c980f7ce6549953f631445fa6844ca2bb4ff..46e0e1f152af67b009cd370c68242c29d4137736 100644 (file)
@@ -59,7 +59,8 @@ int main (int argc,char **argv)
   try
     {
       {
-        TrilinosWrappers::Vector v (100);
+        TrilinosWrappers::Vector v;
+        v.reinit(100);
         test (v);
       }
     }
index 9eb95a6873f8c65cd871ee650513f78ba9d5f13e..ebfa518a1569803d8736cf92b31ef0f56f4bbf30 100644 (file)
@@ -75,8 +75,10 @@ int main (int argc,char **argv)
   try
     {
       {
-        TrilinosWrappers::Vector v (100);
-        TrilinosWrappers::Vector w (100);
+        TrilinosWrappers::Vector v;
+        v.reinit(100);
+        TrilinosWrappers::Vector w;
+        w.reinit(100);
         test (v,w);
       }
     }
index 0947f77f132cd30db09cab079285e21d75c95574..3ca2e2f63408fc5f00acda2efff2becd797a1c1b 100644 (file)
@@ -75,8 +75,10 @@ int main (int argc,char **argv)
   try
     {
       {
-        TrilinosWrappers::Vector v (100);
-        TrilinosWrappers::Vector w (100);
+        TrilinosWrappers::Vector v;
+        v.reinit(100);
+        TrilinosWrappers::Vector w;
+        w.reinit(100);
         test (v,w);
       }
     }
index 84abf7921e67dbdd3f01bdc2b7e85b54a8adb3dd..1e0d1ed9e13eaae3eeb039af6527459e8e6b6025 100644 (file)
@@ -55,7 +55,8 @@ int main (int argc,char **argv)
   try
     {
       {
-        TrilinosWrappers::Vector v (100);
+        TrilinosWrappers::Vector v;
+        v.reinit(100);
         test (v);
       }
     }
index 607ce06299424c2fa95503affb7fbd2cc1f1b0df..777cd310716ce736526f7612b43625895c1c63a5 100644 (file)
@@ -63,8 +63,10 @@ int main (int argc,char **argv)
   try
     {
       {
-        TrilinosWrappers::Vector v (100);
-        TrilinosWrappers::Vector w (100);
+        TrilinosWrappers::Vector v;
+        v.reinit(100);
+        TrilinosWrappers::Vector w;
+        w.reinit(100);
         test (v,w);
       }
     }
index 4b1410d856992e0e17c8ecea5d681f7aa1cfb5b1..cae40a51ebfad419de0c1fdec45811186260f213 100644 (file)
@@ -63,8 +63,10 @@ int main (int argc,char **argv)
   try
     {
       {
-        TrilinosWrappers::Vector v (100);
-        TrilinosWrappers::Vector w (100);
+        TrilinosWrappers::Vector v;
+        v.reinit(100);
+        TrilinosWrappers::Vector w;
+        w.reinit(100);
         test (v,w);
       }
     }
index 9cced23098fb27e428271dbbadbb8713921a1d93..4f37f92591d7ab1dc223032aa0df0045cae54cea 100644 (file)
@@ -67,9 +67,12 @@ int main (int argc,char **argv)
   try
     {
       {
-        TrilinosWrappers::Vector v (100);
-        TrilinosWrappers::Vector w (100);
-        TrilinosWrappers::Vector x (100);
+        TrilinosWrappers::Vector v;
+        v.reinit(100);
+        TrilinosWrappers::Vector w;
+        w.reinit(100);
+        TrilinosWrappers::Vector x;
+        x.reinit(100);
         test (v,w,x);
       }
     }
index 1994668a008c4d1a1df88dd17cdd6b8edec26374..435dd7cdb1e1a44e541f2748f084223e367c775f 100644 (file)
@@ -63,8 +63,10 @@ int main (int argc,char **argv)
   try
     {
       {
-        TrilinosWrappers::Vector v (100);
-        TrilinosWrappers::Vector w (100);
+        TrilinosWrappers::Vector v;
+        v.reinit(100);
+        TrilinosWrappers::Vector w;
+        w.reinit(100);
         test (v,w);
       }
     }
index 4ff86bc2fc725e168af160e7b1d17f8e5794a56a..bfc50975da98e1f20e8ae95397b1054332b48497 100644 (file)
@@ -63,8 +63,10 @@ int main (int argc,char **argv)
   try
     {
       {
-        TrilinosWrappers::Vector v (100);
-        TrilinosWrappers::Vector w (100);
+        TrilinosWrappers::Vector v;
+        v.reinit(100);
+        TrilinosWrappers::Vector w;
+        w.reinit(100);
         test (v,w);
       }
     }
diff --git a/tests/trilinos/43.cc b/tests/trilinos/43.cc
deleted file mode 100644 (file)
index 6ce597d..0000000
+++ /dev/null
@@ -1,100 +0,0 @@
-// ---------------------------------------------------------------------
-//
-// Copyright (C) 2004 - 2015 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 TrilinosWrappers::Vector::sadd(s,s,V,s,V)
-
-#include "../tests.h"
-#include <deal.II/base/utilities.h>
-#include <deal.II/lac/trilinos_vector.h>
-#include <fstream>
-#include <iostream>
-#include <vector>
-
-
-void test (TrilinosWrappers::Vector &v,
-           TrilinosWrappers::Vector &w,
-           TrilinosWrappers::Vector &x)
-{
-  for (unsigned int i=0; i<v.size(); ++i)
-    {
-      v(i) = i;
-      w(i) = i+1.;
-      x(i) = i+2.;
-    }
-
-  v.compress (VectorOperation::insert);
-  w.compress (VectorOperation::insert);
-  x.compress (VectorOperation::insert);
-
-  v.sadd (1.5, 2, w, 3, x);
-
-  // make sure we get the expected result
-  for (unsigned int i=0; i<v.size(); ++i)
-    {
-      AssertThrow (w(i) == i+1., ExcInternalError());
-      AssertThrow (x(i) == i+2., ExcInternalError());
-      AssertThrow (v(i) == 1.5*i+2*(i+1.)+3*(i+2.), ExcInternalError());
-    }
-
-  deallog << "OK" << std::endl;
-}
-
-
-
-int main (int argc,char **argv)
-{
-  std::ofstream logfile("output");
-  deallog.attach(logfile);
-  deallog.threshold_double(1.e-10);
-
-  Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
-
-
-  try
-    {
-      {
-        TrilinosWrappers::Vector v (100);
-        TrilinosWrappers::Vector w (100);
-        TrilinosWrappers::Vector x (100);
-        test (v,w,x);
-      }
-    }
-  catch (std::exception &exc)
-    {
-      std::cerr << std::endl << std::endl
-                << "----------------------------------------------------"
-                << std::endl;
-      std::cerr << "Exception on processing: " << std::endl
-                << exc.what() << std::endl
-                << "Aborting!" << std::endl
-                << "----------------------------------------------------"
-                << std::endl;
-
-      return 1;
-    }
-  catch (...)
-    {
-      std::cerr << std::endl << std::endl
-                << "----------------------------------------------------"
-                << std::endl;
-      std::cerr << "Unknown exception!" << std::endl
-                << "Aborting!" << std::endl
-                << "----------------------------------------------------"
-                << std::endl;
-      return 1;
-    };
-}
diff --git a/tests/trilinos/43.output b/tests/trilinos/43.output
deleted file mode 100644 (file)
index 0fd8fc1..0000000
+++ /dev/null
@@ -1,2 +0,0 @@
-
-DEAL::OK
diff --git a/tests/trilinos/44.cc b/tests/trilinos/44.cc
deleted file mode 100644 (file)
index 26a6e71..0000000
+++ /dev/null
@@ -1,105 +0,0 @@
-// ---------------------------------------------------------------------
-//
-// Copyright (C) 2004 - 2015 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 TrilinosWrappers::Vector::sadd(s,s,V,s,V,s,V)
-
-#include "../tests.h"
-#include <deal.II/base/utilities.h>
-#include <deal.II/lac/trilinos_vector.h>
-#include <fstream>
-#include <iostream>
-#include <vector>
-
-
-void test (TrilinosWrappers::Vector &v,
-           TrilinosWrappers::Vector &w,
-           TrilinosWrappers::Vector &x,
-           TrilinosWrappers::Vector &y)
-{
-  for (unsigned int i=0; i<v.size(); ++i)
-    {
-      v(i) = i;
-      w(i) = i+1.;
-      x(i) = i+2.;
-      y(i) = i+3.;
-    }
-
-  v.compress (VectorOperation::insert);
-  w.compress (VectorOperation::insert);
-  x.compress (VectorOperation::insert);
-  y.compress (VectorOperation::insert);
-
-  v.sadd (1.5, 2, w, 3, x, 4, y);
-
-  // make sure we get the expected result
-  for (unsigned int i=0; i<v.size(); ++i)
-    {
-      AssertThrow (w(i) == i+1., ExcInternalError());
-      AssertThrow (x(i) == i+2., ExcInternalError());
-      AssertThrow (y(i) == i+3., ExcInternalError());
-      AssertThrow (v(i) == 1.5*i+2*(i+1.)+3*(i+2.)+4*(i+3), ExcInternalError());
-    }
-
-  deallog << "OK" << std::endl;
-}
-
-
-
-int main (int argc,char **argv)
-{
-  std::ofstream logfile("output");
-  deallog.attach(logfile);
-  deallog.threshold_double(1.e-10);
-
-  Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
-
-
-  try
-    {
-      {
-        TrilinosWrappers::Vector v (100);
-        TrilinosWrappers::Vector w (100);
-        TrilinosWrappers::Vector x (100);
-        TrilinosWrappers::Vector y (100);
-        test (v,w,x,y);
-      }
-    }
-  catch (std::exception &exc)
-    {
-      std::cerr << std::endl << std::endl
-                << "----------------------------------------------------"
-                << std::endl;
-      std::cerr << "Exception on processing: " << std::endl
-                << exc.what() << std::endl
-                << "Aborting!" << std::endl
-                << "----------------------------------------------------"
-                << std::endl;
-
-      return 1;
-    }
-  catch (...)
-    {
-      std::cerr << std::endl << std::endl
-                << "----------------------------------------------------"
-                << std::endl;
-      std::cerr << "Unknown exception!" << std::endl
-                << "Aborting!" << std::endl
-                << "----------------------------------------------------"
-                << std::endl;
-      return 1;
-    };
-}
diff --git a/tests/trilinos/44.output b/tests/trilinos/44.output
deleted file mode 100644 (file)
index 0fd8fc1..0000000
+++ /dev/null
@@ -1,2 +0,0 @@
-
-DEAL::OK
index 5985096a8424ab66a04198ddb5128d6f3e67188f..b78fcdd00ef64d659adc01acd89df73418a03dff 100644 (file)
@@ -63,8 +63,10 @@ int main (int argc,char **argv)
   try
     {
       {
-        TrilinosWrappers::Vector v (100);
-        TrilinosWrappers::Vector w (100);
+        TrilinosWrappers::Vector v;
+        v.reinit(100);
+        TrilinosWrappers::Vector w;
+        w.reinit(100);
         test (v,w);
       }
     }
index 6ffa9be5b7dcd45e6c383e24df797d82cf4fc2f5..85cff86f096cfcc0a1a167cc1a9ecae9a31fc212 100644 (file)
@@ -63,8 +63,10 @@ int main (int argc,char **argv)
   try
     {
       {
-        TrilinosWrappers::Vector v (100);
-        TrilinosWrappers::Vector w (100);
+        TrilinosWrappers::Vector v;
+        v.reinit(100);
+        TrilinosWrappers::Vector w;
+        w.reinit(100);
         test (v,w);
       }
     }
diff --git a/tests/trilinos/47.cc b/tests/trilinos/47.cc
deleted file mode 100644 (file)
index b301fdd..0000000
+++ /dev/null
@@ -1,100 +0,0 @@
-// ---------------------------------------------------------------------
-//
-// Copyright (C) 2004 - 2015 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 TrilinosWrappers::Vector::equ (s,V,s,V)
-
-#include "../tests.h"
-#include <deal.II/base/utilities.h>
-#include <deal.II/lac/trilinos_vector.h>
-#include <fstream>
-#include <iostream>
-#include <vector>
-
-
-void test (TrilinosWrappers::Vector &v,
-           TrilinosWrappers::Vector &w,
-           TrilinosWrappers::Vector &x)
-{
-  for (unsigned int i=0; i<v.size(); ++i)
-    {
-      v(i) = i;
-      w(i) = i+1.;
-      x(i) = i+2.;
-    }
-
-  v.compress (VectorOperation::insert);
-  w.compress (VectorOperation::insert);
-  x.compress (VectorOperation::insert);
-
-  v.equ (2, w, 3, x);
-
-  // make sure we get the expected result
-  for (unsigned int i=0; i<v.size(); ++i)
-    {
-      AssertThrow (w(i) == i+1., ExcInternalError());
-      AssertThrow (x(i) == i+2., ExcInternalError());
-      AssertThrow (v(i) == 2*(i+1.)+3*(i+2.), ExcInternalError());
-    }
-
-  deallog << "OK" << std::endl;
-}
-
-
-
-int main (int argc,char **argv)
-{
-  std::ofstream logfile("output");
-  deallog.attach(logfile);
-  deallog.threshold_double(1.e-10);
-
-  Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
-
-
-  try
-    {
-      {
-        TrilinosWrappers::Vector v (100);
-        TrilinosWrappers::Vector w (100);
-        TrilinosWrappers::Vector x (100);
-        test (v,w,x);
-      }
-    }
-  catch (std::exception &exc)
-    {
-      std::cerr << std::endl << std::endl
-                << "----------------------------------------------------"
-                << std::endl;
-      std::cerr << "Exception on processing: " << std::endl
-                << exc.what() << std::endl
-                << "Aborting!" << std::endl
-                << "----------------------------------------------------"
-                << std::endl;
-
-      return 1;
-    }
-  catch (...)
-    {
-      std::cerr << std::endl << std::endl
-                << "----------------------------------------------------"
-                << std::endl;
-      std::cerr << "Unknown exception!" << std::endl
-                << "Aborting!" << std::endl
-                << "----------------------------------------------------"
-                << std::endl;
-      return 1;
-    };
-}
diff --git a/tests/trilinos/47.output b/tests/trilinos/47.output
deleted file mode 100644 (file)
index 0fd8fc1..0000000
+++ /dev/null
@@ -1,2 +0,0 @@
-
-DEAL::OK
diff --git a/tests/trilinos/48.cc b/tests/trilinos/48.cc
deleted file mode 100644 (file)
index 413b5ac..0000000
+++ /dev/null
@@ -1,102 +0,0 @@
-// ---------------------------------------------------------------------
-//
-// Copyright (C) 2004 - 2015 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 TrilinosWrappers::Vector::ratio
-
-#include "../tests.h"
-#include <deal.II/base/utilities.h>
-#include <deal.II/lac/trilinos_vector.h>
-#include <fstream>
-#include <iostream>
-#include <vector>
-
-
-void test (TrilinosWrappers::Vector &v,
-           TrilinosWrappers::Vector &w,
-           TrilinosWrappers::Vector &x)
-{
-  for (unsigned int i=0; i<v.size(); ++i)
-    {
-      v(i) = i;
-      w(i) = i+1.;
-      x(i) = i+2.;
-    }
-
-  v.compress (VectorOperation::insert);
-  w.compress (VectorOperation::insert);
-  x.compress (VectorOperation::insert);
-
-  v.ratio (w, x);
-
-  // make sure we get the expected result
-  const double eps=typeid(TrilinosScalar)==typeid(double) ? 1e-14 : 1e-5;
-  for (unsigned int i=0; i<v.size(); ++i)
-    {
-      AssertThrow (w(i) == i+1., ExcInternalError());
-      AssertThrow (x(i) == i+2., ExcInternalError());
-      AssertThrow (std::fabs(v(i) - (i+1.)/(i+2.)) < eps*v(i),
-                   ExcInternalError());
-    }
-
-  deallog << "OK" << std::endl;
-}
-
-
-
-int main (int argc,char **argv)
-{
-  std::ofstream logfile("output");
-  deallog.attach(logfile);
-  deallog.threshold_double(1.e-10);
-
-  Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
-
-
-  try
-    {
-      {
-        TrilinosWrappers::Vector v (100);
-        TrilinosWrappers::Vector w (100);
-        TrilinosWrappers::Vector x (100);
-        test (v,w,x);
-      }
-    }
-  catch (std::exception &exc)
-    {
-      std::cerr << std::endl << std::endl
-                << "----------------------------------------------------"
-                << std::endl;
-      std::cerr << "Exception on processing: " << std::endl
-                << exc.what() << std::endl
-                << "Aborting!" << std::endl
-                << "----------------------------------------------------"
-                << std::endl;
-
-      return 1;
-    }
-  catch (...)
-    {
-      std::cerr << std::endl << std::endl
-                << "----------------------------------------------------"
-                << std::endl;
-      std::cerr << "Unknown exception!" << std::endl
-                << "Aborting!" << std::endl
-                << "----------------------------------------------------"
-                << std::endl;
-      return 1;
-    };
-}
diff --git a/tests/trilinos/48.output b/tests/trilinos/48.output
deleted file mode 100644 (file)
index 0fd8fc1..0000000
+++ /dev/null
@@ -1,2 +0,0 @@
-
-DEAL::OK
index 8a7f73e8f731f1635bb0ed3394cbfa4fd4969652..b4a0e2ca32f77314693c3489a7ccf7317ba1a671 100644 (file)
@@ -60,7 +60,8 @@ int main (int argc,char **argv)
   try
     {
       {
-        TrilinosWrappers::Vector v (100);
+        TrilinosWrappers::Vector v;
+        v.reinit(100);
         test (v);
       }
     }
index e9fca52219592c5b6afef3ea07296e24acc0bf5a..433417dfe9a31653da7cbc337ad13cb6e2080f2d 100644 (file)
@@ -32,7 +32,8 @@
 void test (TrilinosWrappers::BlockVector &v)
 {
   std::vector<types::global_dof_index> sizes (2, 3);
-  dealii::BlockVector<TrilinosScalar> w (sizes);
+  dealii::BlockVector<TrilinosScalar> w;
+  w.reinit(sizes);
 
   for (unsigned int i=0; i<w.size(); ++i)
     w(i) = i;
@@ -75,7 +76,8 @@ int main (int argc,char **argv)
     {
       {
         std::vector<types::global_dof_index> sizes (2, 3);
-        TrilinosWrappers::BlockVector v (sizes);
+        TrilinosWrappers::BlockVector v;
+        v.reinit(sizes);
         test (v);
       }
     }
index acf85dbe281fa703de37397c3d41e6e7891a0b6e..a88abebc3389e9659f070096c5b0007bca0c5c36 100644 (file)
@@ -49,7 +49,9 @@ void test (TrilinosWrappers::MPI::BlockVector &v)
 
   // now also check the reverse assignment
   w = 0;
-  w = v;
+  TrilinosWrappers::BlockVector v_serial;
+  v_serial.reinit(v);
+  w = v_serial;
   for (unsigned int i=0; i<v.size(); ++i)
     {
       AssertThrow (w(i) == i, ExcInternalError());
@@ -74,15 +76,10 @@ int main (int argc,char **argv)
   try
     {
       {
-        std::vector<Epetra_Map> sizes;
-        Epetra_Map map(TrilinosWrappers::types::int_type(3),
-                       TrilinosWrappers::types::int_type(3),
-                       0,
-                       Utilities::Trilinos::comm_world());
-        sizes.push_back (map);
-        sizes.push_back (map);
-
-        TrilinosWrappers::MPI::BlockVector v (sizes);
+        std::vector<IndexSet> sizes(2, complete_index_set(3));
+
+        TrilinosWrappers::MPI::BlockVector v;
+        v.reinit(sizes, MPI_COMM_WORLD);
         test (v);
       }
     }
index 98f46bb3ecae1d9a3fad1a63b4fe59d5571e9723..9dfbb7094edd86dfdecbd30f07e99570621f72ba 100644 (file)
@@ -76,7 +76,8 @@ int main (int argc,char **argv)
   try
     {
       {
-        TrilinosWrappers::Vector v (100);
+        TrilinosWrappers::Vector v;
+        v.reinit(100);
         test (v);
       }
     }
index ef7ccd9b83fa2977d8f3a77a70a331a5f55d0d72..e2f8fcfc61d9125bb1a3f5040f5c5624df1867c8 100644 (file)
@@ -61,7 +61,8 @@ int main (int argc,char **argv)
   try
     {
       {
-        TrilinosWrappers::Vector v (100);
+        TrilinosWrappers::Vector v;
+        v.reinit(100);
         test (v);
       }
     }
index a89464ed391537b94a0d15e854d3f08f1f804da6..184fd1f362e9ddfbbe4e7017782dc4aa36475954 100644 (file)
@@ -67,7 +67,8 @@ int main (int argc,char **argv)
   try
     {
       {
-        TrilinosWrappers::Vector v (100);
+        TrilinosWrappers::Vector v;
+        v.reinit(100);
         test (v);
       }
     }
index 9fa5ac9cf735ffb6690988105c9d59564ee156fd..47d01b3d626e78eba7dbf8504981e59cddcfa48f 100644 (file)
@@ -67,7 +67,8 @@ int main (int argc,char **argv)
   try
     {
       {
-        TrilinosWrappers::Vector v (100);
+        TrilinosWrappers::Vector v;
+        v.reinit(100);
         test (v);
       }
     }
index f626397075b228ef3066acc5b38968f9d5fe8c66..2f4ce06a7c356d0e899fb7d6471f8e2bb5ba9c51 100644 (file)
@@ -66,7 +66,8 @@ int main (int argc,char **argv)
   try
     {
       {
-        TrilinosWrappers::Vector v (100);
+        TrilinosWrappers::Vector v;
+        v.reinit(100);
         test (v);
       }
     }
index 6573ebcbf999920edc65431ede098ab94d8f0ddf..da2adbcdb36f8eb66c5c780136f377b0af0bd152 100644 (file)
@@ -66,7 +66,8 @@ int main (int argc,char **argv)
   try
     {
       {
-        TrilinosWrappers::Vector v (100);
+        TrilinosWrappers::Vector v;
+        v.reinit(100);
         test (v);
       }
     }
index 94c7c242b5866cf431bafafffcac4d7e2c80af16..bbcc85f01c5b7e0441114abe734773da4036b383 100644 (file)
@@ -64,7 +64,8 @@ int main (int argc,char **argv)
   try
     {
       {
-        TrilinosWrappers::Vector v (100);
+        TrilinosWrappers::Vector v;
+        v.reinit(100);
         test (v);
       }
     }
index ae4e482faf811f41bdb2ba2e6eb52421772e481b..cd1f84c369ff7a9ac349eb7f2bef4d979ecf840c 100644 (file)
@@ -66,7 +66,8 @@ int main (int argc,char **argv)
   try
     {
       {
-        TrilinosWrappers::Vector v (100);
+        TrilinosWrappers::Vector v;
+        v.reinit(100);
         test (v);
       }
     }
diff --git a/tests/trilinos/59.cc b/tests/trilinos/59.cc
deleted file mode 100644 (file)
index f48c416..0000000
+++ /dev/null
@@ -1,100 +0,0 @@
-// ---------------------------------------------------------------------
-//
-// Copyright (C) 2004 - 2015 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 TrilinosWrappers::Vector (const ::Vector &) copy constructor
-
-#include "../tests.h"
-#include <deal.II/base/utilities.h>
-#include <deal.II/lac/trilinos_vector.h>
-#include <deal.II/lac/vector.h>
-
-#include <fstream>
-#include <iostream>
-#include <vector>
-
-
-void test (TrilinosWrappers::Vector &v)
-{
-  // set only certain elements of the
-  // vector.
-  std::vector<bool> pattern (v.size(), false);
-  for (unsigned int i=0; i<v.size(); i+=1+i)
-    {
-      v(i) += i;
-      pattern[i] = true;
-    }
-
-  v.compress (VectorOperation::add);
-
-  Vector<double> w (v);
-  Vector<float>  x (v);
-
-  TrilinosWrappers::Vector w1 (w);
-  TrilinosWrappers::Vector x1 (x);
-
-  for (unsigned int i=0; i<v.size(); ++i)
-    {
-      AssertThrow (w1(i) == w(i), ExcInternalError());
-      AssertThrow (x1(i) == x(i), ExcInternalError());
-    }
-
-  deallog << "OK" << std::endl;
-}
-
-
-
-int main (int argc,char **argv)
-{
-  std::ofstream logfile("output");
-  deallog.attach(logfile);
-  deallog.threshold_double(1.e-10);
-
-  Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
-
-
-  try
-    {
-      {
-        TrilinosWrappers::Vector v (100);
-        test (v);
-      }
-    }
-  catch (std::exception &exc)
-    {
-      std::cerr << std::endl << std::endl
-                << "----------------------------------------------------"
-                << std::endl;
-      std::cerr << "Exception on processing: " << std::endl
-                << exc.what() << std::endl
-                << "Aborting!" << std::endl
-                << "----------------------------------------------------"
-                << std::endl;
-
-      return 1;
-    }
-  catch (...)
-    {
-      std::cerr << std::endl << std::endl
-                << "----------------------------------------------------"
-                << std::endl;
-      std::cerr << "Unknown exception!" << std::endl
-                << "Aborting!" << std::endl
-                << "----------------------------------------------------"
-                << std::endl;
-      return 1;
-    };
-}
diff --git a/tests/trilinos/59.output b/tests/trilinos/59.output
deleted file mode 100644 (file)
index 0fd8fc1..0000000
+++ /dev/null
@@ -1,2 +0,0 @@
-
-DEAL::OK
index eb197fcf808e1b3a476ec8440df960945d453153..100efa7c1207fd923b3f44de23dca2a81798fd42 100644 (file)
@@ -68,7 +68,8 @@ int main (int argc,char **argv)
   try
     {
       {
-        TrilinosWrappers::Vector v (100);
+        TrilinosWrappers::Vector v;
+        v.reinit(100);
         test (v);
       }
     }
index 6f10013f5385dfd29f1aa3a5ae0000f754d139e9..a3fc39bd2ab863dcd7c465f2662bbc8a046b8d9d 100644 (file)
@@ -45,9 +45,11 @@ void test (TrilinosWrappers::Vector &v)
   Vector<float>  x(v.size());
   x=v;
 
-  TrilinosWrappers::Vector w1(v.size());
+  TrilinosWrappers::Vector w1;
+  w1.reinit(v.size());
   w1=w;
-  TrilinosWrappers::Vector x1(v.size());
+  TrilinosWrappers::Vector x1;
+  x1.reinit(v.size());
   x1=x;
 
   for (unsigned int i=0; i<v.size(); ++i)
@@ -73,7 +75,8 @@ int main (int argc,char **argv)
   try
     {
       {
-        TrilinosWrappers::Vector v (100);
+        TrilinosWrappers::Vector v;
+        v.reinit(100);
         test (v);
       }
     }
diff --git a/tests/trilinos/65.cc b/tests/trilinos/65.cc
deleted file mode 100644 (file)
index 3cb6097..0000000
+++ /dev/null
@@ -1,82 +0,0 @@
-// ---------------------------------------------------------------------
-//
-// Copyright (C) 2004 - 2015 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.
-//
-// ---------------------------------------------------------------------
-
-
-
-// This test used to fail after upgrading to petsc 2.2.1
-
-
-#include "../tests.h"
-#include <deal.II/base/utilities.h>
-#include <deal.II/lac/trilinos_vector.h>
-
-#include <fstream>
-#include <iostream>
-#include <vector>
-
-
-void test ()
-{
-  TrilinosWrappers::MPI::Vector
-  v (Epetra_Map(TrilinosWrappers::types::int_type(100),0,
-                Utilities::Trilinos::comm_world()));
-  v(0) = 1;
-  v = 0;
-
-  deallog << "OK" << std::endl;
-}
-
-
-
-int main (int argc,char **argv)
-{
-  std::ofstream logfile("output");
-  deallog.attach(logfile);
-  deallog.threshold_double(1.e-10);
-
-  Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, testing_max_num_threads());
-
-
-  try
-    {
-      {
-        test ();
-      }
-    }
-  catch (std::exception &exc)
-    {
-      std::cerr << std::endl << std::endl
-                << "----------------------------------------------------"
-                << std::endl;
-      std::cerr << "Exception on processing: " << std::endl
-                << exc.what() << std::endl
-                << "Aborting!" << std::endl
-                << "----------------------------------------------------"
-                << std::endl;
-
-      return 1;
-    }
-  catch (...)
-    {
-      std::cerr << std::endl << std::endl
-                << "----------------------------------------------------"
-                << std::endl;
-      std::cerr << "Unknown exception!" << std::endl
-                << "Aborting!" << std::endl
-                << "----------------------------------------------------"
-                << std::endl;
-      return 1;
-    };
-}
diff --git a/tests/trilinos/65.output b/tests/trilinos/65.output
deleted file mode 100644 (file)
index 0fd8fc1..0000000
+++ /dev/null
@@ -1,2 +0,0 @@
-
-DEAL::OK
index c7866d85b0b0f087a491204b9cd74332962b1cf8..10b63cd7cf8ba279e67f2433f2cce613b2309183 100644 (file)
@@ -26,7 +26,8 @@
 
 void test ()
 {
-  TrilinosWrappers::BlockVector v(2);
+  TrilinosWrappers::BlockVector v;
+  v.reinit(2);
   for (unsigned int i=0; i<v.n_blocks(); ++i)
     v.block(i).reinit(1);
   v.collect_sizes();
index 408e7560d84ef981a5faff8b328b98f37001a297..1ff7545eac72f20d5b0a01db1bc60b9f04a8d2c8 100644 (file)
@@ -26,7 +26,8 @@
 
 void test ()
 {
-  TrilinosWrappers::BlockVector v(2);
+  TrilinosWrappers::BlockVector v;
+  v.reinit(2);
   for (unsigned int i=0; i<v.n_blocks(); ++i)
     v.block(i).reinit(1);
   v.collect_sizes();
index c37fbe25dc07ab0278ae42dfdf69481f744247ca..29e80db4e1ff4705f24cd3626e5f951e66330a76 100644 (file)
@@ -14,7 +14,7 @@
 // ---------------------------------------------------------------------
 
 
-// this test is an adaptation of lac/block_vector_iterator for PETSc block
+// this test is an adaptation of lac/block_vector_iterator for Trilinos block
 // vectors
 
 #include "../tests.h"
@@ -54,8 +54,10 @@ void test ()
   // iterators
   if (true)
     {
-      TrilinosWrappers::BlockVector v1(ivector);
-      TrilinosWrappers::BlockVector v2(ivector);
+      TrilinosWrappers::BlockVector v1;
+      v1.reinit(ivector);
+      TrilinosWrappers::BlockVector v2;
+      v2.reinit(ivector);
 
       // initialize first vector with
       // simple loop
@@ -72,30 +74,13 @@ void test ()
       deallog << "Check 1: " << (v1==v2 ? "true" : "false") << std::endl;
     };
 
-  // Check 1: initialization via
-  // iterators
-  if (true)
-    {
-      TrilinosWrappers::BlockVector v1(ivector);
-
-      // initialize first vector with
-      // simple loop
-      for (unsigned int i=0; i<v1.size(); ++i)
-        v1(i) = i;
-      // initialize other vector
-      // through iterators into first
-      // vector
-      TrilinosWrappers::BlockVector v2(ivector, v1.begin(), v1.end());
-      // check that the two vectors are equal
-      deallog << "Check 2: " << (v1==v2 ? "true" : "false") << std::endl;
-    };
-
-  // Check 3: loop forward and back
+  // Check 2: loop forward and back
   // and check that things are the
   // same
   if (true)
     {
-      TrilinosWrappers::BlockVector v1(ivector);
+      TrilinosWrappers::BlockVector v1;
+      v1.reinit(ivector);
       // initialize first vector with
       // simple loop
       for (unsigned int i=0; i<v1.size(); ++i)
@@ -121,11 +106,12 @@ void test ()
     };
 
 
-  // Check 4: same, but this time
+  // Check 3: same, but this time
   // with const iterators
   if (true)
     {
-      TrilinosWrappers::BlockVector v1(ivector);
+      TrilinosWrappers::BlockVector v1;
+      v1.reinit(ivector);
       // initialize first vector with
       // simple loop
       for (unsigned int i=0; i<v1.size(); ++i)
@@ -154,11 +140,12 @@ void test ()
       deallog << "Check 4: true" << std::endl;
     };
 
-  // Checks 5-14: use some standard
+  // Checks 4-13: use some standard
   // algorithms
   if (true)
     {
-      TrilinosWrappers::BlockVector v1(ivector);
+      TrilinosWrappers::BlockVector v1;
+      v1.reinit(ivector);
       // initialize first vector with
       // simple loop
       for (unsigned int i=0; i<v1.size(); ++i)
@@ -173,7 +160,8 @@ void test ()
               << std::endl;
 
       // check std::copy
-      TrilinosWrappers::BlockVector v2(ivector);
+      TrilinosWrappers::BlockVector v2;
+      v2.reinit(ivector);
       std::copy (v1.begin(), v1.end(), v2.begin());
       deallog << "Check 6: " << (v1 == v2 ? "true" : "false") << std::endl;
 
@@ -218,91 +206,11 @@ void test ()
       deallog << "Check 14: " << (p3 == v1.end() ? "true" : "false") << std::endl;
     };
 
-  // Check 15: initialization through
-  // iterators
-  if (true)
-    {
-      TrilinosWrappers::BlockVector v1(ivector);
-      // initialize first vector with
-      // simple loop
-      for (unsigned int i=0; i<v1.size(); ++i)
-        v1(i) = i;
-
-      // initialize a normal vector
-      // from it
-      Vector<double> v2(v1.begin(), v1.end());
-
-      // and reverse way
-      TrilinosWrappers::BlockVector v3(ivector, v2.begin(), v2.end());
-      deallog << "Check 15: " << (v1==v3 ? "true" : "false") << std::endl;
-    };
-
-  // Check 16: initialization through
-  // iterators. variant with one
-  // constant object
-  if (true)
-    {
-      TrilinosWrappers::BlockVector v1(ivector);
-      // initialize first vector with
-      // simple loop
-      for (unsigned int i=0; i<v1.size(); ++i)
-        v1(i) = i;
-
-      // initialize a normal vector
-      // from it
-      const Vector<double> v2(v1.begin(), v1.end());
-
-      // and reverse way
-      TrilinosWrappers::BlockVector v3(ivector, v2.begin(), v2.end());
-      deallog << "Check 16: " << (v1==v3 ? "true" : "false") << std::endl;
-    };
-
-  // Check 17: initialization through
-  // iterators. variant with two
-  // constant object
-  if (true)
-    {
-      TrilinosWrappers::BlockVector v1(ivector);
-      // initialize first vector with
-      // simple loop
-      for (unsigned int i=0; i<v1.size(); ++i)
-        v1(i) = i;
-
-      // initialize a normal vector
-      // from it
-      const Vector<double> v2(v1.begin(), v1.end());
-
-      // and reverse way
-      const TrilinosWrappers::BlockVector v3(ivector, v2.begin(), v2.end());
-      deallog << "Check 17: " << (v1==v3 ? "true" : "false") << std::endl;
-    };
-
-  // Check 18: initialization through
-  // iterators. variant with three
-  // constant object
-  if (true)
-    {
-      TrilinosWrappers::BlockVector v0(ivector);
-      // initialize first vector with
-      // simple loop
-      for (unsigned int i=0; i<v0.size(); ++i)
-        v0(i) = i;
-
-      const TrilinosWrappers::BlockVector v1 = v0;
-
-      // initialize a normal vector
-      // from it
-      const Vector<double> v2(v1.begin(), v1.end());
-
-      // and reverse way
-      const TrilinosWrappers::BlockVector v3(ivector, v2.begin(), v2.end());
-      deallog << "Check 18: " << (v1==v3 ? "true" : "false") << std::endl;
-    };
-
-  // Check 19: operator[]
+  // Check 15: operator[]
   if (true)
     {
-      TrilinosWrappers::BlockVector v1(ivector);
+      TrilinosWrappers::BlockVector v1;
+      v1.reinit(ivector);
       for (unsigned int i=0; i<v1.size(); ++i)
         v1(i) = i;
 
@@ -315,7 +223,7 @@ void test ()
 
       // if we came thus far,
       // everything is alright
-      deallog << "Check 19: true" << std::endl;
+      deallog << "Check 15: true" << std::endl;
     };
 }
 
index ca8a9d55a14311c63f8d45f4534c0c840a537854..700e3bf8d46bf2475e1b66f571575e422267d782 100644 (file)
@@ -1,6 +1,5 @@
 
 DEAL::Check 1: true
-DEAL::Check 2: true
 DEAL::Check 3: true
 DEAL::Check 4: true
 DEAL::Check 5: true
@@ -14,7 +13,3 @@ DEAL::Check 12: true
 DEAL::Check 13: true
 DEAL::Check 14: true
 DEAL::Check 15: true
-DEAL::Check 16: true
-DEAL::Check 17: true
-DEAL::Check 18: true
-DEAL::Check 19: true
index 60b26d01496540dd93c18da1b7c3f2279e9e5f34..d944d91830f124e73c614249eb84b205c3f37487 100644 (file)
@@ -91,8 +91,10 @@ int main(int argc, char **argv)
     A.reinit(csp);
     testproblem.five_point(A);
 
-    TrilinosWrappers::Vector  f(dim);
-    TrilinosWrappers::Vector  u(dim);
+    TrilinosWrappers::Vector f;
+    f.reinit(dim);
+    TrilinosWrappers::Vector u;
+    u.reinit(dim);
     f = 1.;
     A.compress (VectorOperation::insert);
     f.compress (VectorOperation::insert);
index d4638c704ea568da5aa5a731598ecb399acab3c8..5c563aafcf9a8dde05907744cb82394fe2450fc3 100644 (file)
@@ -92,8 +92,10 @@ int main(int argc, char **argv)
     A.reinit(csp);
     testproblem.five_point(A);
 
-    TrilinosWrappers::Vector  f(dim);
-    TrilinosWrappers::Vector  u(dim);
+    TrilinosWrappers::Vector f;
+    f.reinit(dim);
+    TrilinosWrappers::Vector u;
+    u.reinit(dim);
     f = 1.;
     A.compress (VectorOperation::insert);
     f.compress (VectorOperation::insert);
index 388916e9f19babee0a2333002b955e29b62af515..9095743b49db39e7ee1fe945b0409000b33e1b99 100644 (file)
@@ -93,8 +93,10 @@ int main(int argc, char **argv)
     A.reinit(csp);
     testproblem.five_point(A);
 
-    TrilinosWrappers::Vector  f(dim);
-    TrilinosWrappers::Vector  u(dim);
+    TrilinosWrappers::Vector f;
+    f.reinit(dim);
+    TrilinosWrappers::Vector u;
+    u.reinit(dim);
     f = 1.;
     A.compress (VectorOperation::insert);
     f.compress (VectorOperation::insert);
index bb0959662e78e9f59e812fdf3793a951514c3fa8..e8e11ec79b892fd3e09f138c553b0ca0fdf603e0 100644 (file)
@@ -92,8 +92,10 @@ int main(int argc, char **argv)
     A.reinit(csp);
     testproblem.five_point(A);
 
-    TrilinosWrappers::Vector  f(dim);
-    TrilinosWrappers::Vector  u(dim);
+    TrilinosWrappers::Vector f;
+    f.reinit(dim);
+    TrilinosWrappers::Vector u;
+    u.reinit(dim);
     f = 1.;
     A.compress (VectorOperation::insert);
     f.compress (VectorOperation::insert);
index ac5a640ebc995cc09fb344138bb32776941413fd..f31d3cbb74df0b77ef58aef68d1a66d7dada40eb 100644 (file)
@@ -91,8 +91,10 @@ int main(int argc, char **argv)
     A.reinit(csp);
     testproblem.five_point(A);
 
-    TrilinosWrappers::Vector  f(dim);
-    TrilinosWrappers::Vector  u(dim);
+    TrilinosWrappers::Vector f;
+    f.reinit(dim);
+    TrilinosWrappers::Vector u;
+    u.reinit(dim);
     f = 1.;
     A.compress (VectorOperation::insert);
     f.compress (VectorOperation::insert);
index c58a051d4f2c64d541a9fd42afcb663fdb721873..6d6a9598256834fa53cb26d0945eefd4ee6f9259 100644 (file)
@@ -89,8 +89,10 @@ int main(int argc, char **argv)
     A.reinit(csp);
     testproblem.five_point(A);
 
-    TrilinosWrappers::Vector  f(dim);
-    TrilinosWrappers::Vector  u(dim);
+    TrilinosWrappers::Vector f;
+    f.reinit(dim);
+    TrilinosWrappers::Vector u;
+    u.reinit(dim);
     f = 1.;
     A.compress (VectorOperation::insert);
     f.compress (VectorOperation::insert);
index 54007104f337307ca90b23d11c65832916a020e5..b07475608e056e22861730d8aea302dab408332e 100644 (file)
@@ -16,8 +16,8 @@
 
 
 // this is part of a whole suite of tests that checks the relative speed of
-// using PETSc for sparse matrices as compared to the speed of our own
-// library. the tests therefore may not all actually use PETSc, but they are
+// using Trilinos for sparse matrices as compared to the speed of our own
+// library. the tests therefore may not all actually use Trilinos, but they are
 // meant to compare it
 //
 // the tests build the 5-point stencil matrix for a uniform grid of size N*N
@@ -69,7 +69,10 @@ void test ()
   // then do a single matrix-vector
   // multiplication with subsequent formation
   // of the matrix norm
-  TrilinosWrappers::Vector v1(N*N), v2(N*N);
+  TrilinosWrappers::Vector v1;
+  v1.reinit(N*N);
+  TrilinosWrappers::Vector v2;
+  v2.reinit(N*N);
   for (unsigned int i=0; i<N*N; ++i)
     v1(i) = i;
   matrix.vmult (v2, v1);
index 55efaab1feb4c68ac6dc380714f0f1dc6f04edeb..ad9c4bd873d557fba6a03ff1b07da554b9529072 100644 (file)
@@ -16,8 +16,8 @@
 
 
 // this is part of a whole suite of tests that checks the relative speed of
-// using PETSc for sparse matrices as compared to the speed of our own
-// library. the tests therefore may not all actually use PETSc, but they are
+// using Trilinos for sparse matrices as compared to the speed of our own
+// library. the tests therefore may not all actually use Trilinos, but they are
 // meant to compare it
 //
 // the tests build the 5-point stencil matrix for a uniform grid of size N*N
@@ -36,9 +36,8 @@ void test ()
   const unsigned int N = 200;
 
   // build the sparse matrix
-  Epetra_Map map (TrilinosWrappers::types::int_type(N*N), 0,
-                  Utilities::Trilinos::comm_world());
-  TrilinosWrappers::SparseMatrix matrix (map, 5);
+  IndexSet indices = complete_index_set(N*N);
+  TrilinosWrappers::SparseMatrix matrix (indices, MPI_COMM_WORLD, 5);
   for (unsigned int i=0; i<N; i++)
     for (unsigned int j=0; j<N; j++)
       {
@@ -70,8 +69,8 @@ void test ()
   // then do a single matrix-vector
   // multiplication with subsequent formation
   // of the matrix norm
-  TrilinosWrappers::MPI::Vector v1(map);
-  TrilinosWrappers::MPI::Vector v2(map);
+  TrilinosWrappers::MPI::Vector v1(indices, MPI_COMM_WORLD);
+  TrilinosWrappers::MPI::Vector v2(indices, MPI_COMM_WORLD);
   for (unsigned int i=0; i<N*N; ++i)
     v1(i) = i;
   matrix.vmult (v2, v1);
index 078fbcea295cd3e2fd62992a9813961e7669c0b9..a5fe682ff71f292ae9ff68e085baf10a962d146f 100644 (file)
@@ -16,8 +16,8 @@
 
 
 // this is part of a whole suite of tests that checks the relative speed of
-// using PETSc for sparse matrices as compared to the speed of our own
-// library. the tests therefore may not all actually use PETSc, but they are
+// using Trilinos for sparse matrices as compared to the speed of our own
+// library. the tests therefore may not all actually use Trilinos, but they are
 // meant to compare it
 //
 // the tests build the 5-point stencil matrix for a uniform grid of size N*N
@@ -64,9 +64,8 @@ void test ()
   }
 
   // build the sparse matrix
-  Epetra_Map map (TrilinosWrappers::types::int_type(N*N), 0,
-                  Utilities::Trilinos::comm_world());
-  TrilinosWrappers::SparseMatrix matrix (map, 5);
+  IndexSet indices = complete_index_set(N*N);
+  TrilinosWrappers::SparseMatrix matrix (indices, MPI_COMM_WORLD, 5);
   for (unsigned int i_=0; i_<N; i_++)
     for (unsigned int j_=0; j_<N; j_++)
       {
@@ -101,8 +100,8 @@ void test ()
   // then do a single matrix-vector
   // multiplication with subsequent formation
   // of the matrix norm
-  TrilinosWrappers::MPI::Vector v1(map);
-  TrilinosWrappers::MPI::Vector v2(map);
+  TrilinosWrappers::MPI::Vector v1(indices, MPI_COMM_WORLD);
+  TrilinosWrappers::MPI::Vector v2(indices, MPI_COMM_WORLD);
   for (unsigned int i=0; i<N*N; ++i)
     v1(i) = i;
   matrix.vmult (v2, v1);
index f0b0a0a5258bad300839471d3980a20be91e963a..11e990b31245d1d9f807ec63b8acc883c40110c3 100644 (file)
@@ -86,8 +86,10 @@ int main(int argc, char **argv)
     A.reinit(csp);
     testproblem.five_point(A);
 
-    TrilinosWrappers::Vector  f(dim);
-    TrilinosWrappers::Vector  u(dim);
+    TrilinosWrappers::Vector f;
+    f.reinit(dim);
+    TrilinosWrappers::Vector u;
+    u.reinit(dim);
     f = 1.;
     A.compress (VectorOperation::insert);
     f.compress (VectorOperation::insert);
index 018a19c2885cbbe4e2a7413e2153194d70dc415e..ba422f4934d1c2e6c0ecf80c8ef53d73890cd896 100644 (file)
@@ -86,8 +86,10 @@ int main(int argc, char **argv)
     A.reinit(csp);
     testproblem.five_point(A);
 
-    TrilinosWrappers::Vector  f(dim);
-    TrilinosWrappers::Vector  u(dim);
+    TrilinosWrappers::Vector f;
+    f.reinit(dim);
+    TrilinosWrappers::Vector u;
+    u.reinit(dim);
     f = 1.;
     A.compress (VectorOperation::insert);
     f.compress (VectorOperation::insert);
index 8d5ed47975e125d4baa8820e59563204a66950c9..1e717ed87fd9f5a663c9e56d2f7de6833957e421 100644 (file)
@@ -85,8 +85,10 @@ int main(int argc, char **argv)
     A.reinit(csp);
     testproblem.five_point(A);
 
-    TrilinosWrappers::Vector  f(dim);
-    TrilinosWrappers::Vector  u(dim);
+    TrilinosWrappers::Vector f;
+    f.reinit(dim);
+    TrilinosWrappers::Vector u;
+    u.reinit(dim);
     f = 1.;
     A.compress (VectorOperation::insert);
     f.compress (VectorOperation::insert);
index 1ca9f2e4da939a58278e3f76b4bfe723df8cd2d4..6aad6ef261ca8c5b82b65505a3a221b7631d6125 100644 (file)
@@ -88,8 +88,10 @@ int main(int argc, char **argv)
     A.reinit(csp);
     testproblem.five_point(A);
 
-    TrilinosWrappers::Vector  f(dim);
-    TrilinosWrappers::Vector  u(dim);
+    TrilinosWrappers::Vector f;
+    f.reinit(dim);
+    TrilinosWrappers::Vector u;
+    u.reinit(dim);
     f = 1.;
     A.compress (VectorOperation::insert);
     f.compress (VectorOperation::insert);
index 85356bcea75cee996d92dcf60f01e10a51b73f16..4c26b676eb43f1882a633e53fe0d9bf1c271e748 100644 (file)
@@ -88,8 +88,10 @@ int main(int argc, char **argv)
     A.reinit(csp);
     testproblem.five_point(A);
 
-    TrilinosWrappers::Vector  f(dim);
-    TrilinosWrappers::Vector  u(dim);
+    TrilinosWrappers::Vector f;
+    f.reinit(dim);
+    TrilinosWrappers::Vector u;
+    u.reinit(dim);
     f = 1.;
     A.compress (VectorOperation::insert);
     f.compress (VectorOperation::insert);
index e2ff9612c987a994043faefd9fef8bd201eb933c..0e2d9921c560b9dabd49999e457a2ea62a15f229 100644 (file)
@@ -88,8 +88,10 @@ int main(int argc, char **argv)
     A.reinit(csp);
     testproblem.five_point(A);
 
-    TrilinosWrappers::Vector  f(dim);
-    TrilinosWrappers::Vector  u(dim);
+    TrilinosWrappers::Vector f;
+    f.reinit(dim);
+    TrilinosWrappers::Vector u;
+    u.reinit(dim);
     f = 1.;
     A.compress (VectorOperation::insert);
     f.compress (VectorOperation::insert);
index 974816cb9ffad803db1b4a2c393e969458d1bf15..05ca980cec9ee073c71240e91fabd1bd508daf3b 100644 (file)
@@ -57,9 +57,12 @@ int main(int argc, char **argv)
     A.reinit(csp);
     testproblem.five_point(A);
 
-    TrilinosWrappers::Vector  f(dim);
-    TrilinosWrappers::Vector  u1(dim);
-    TrilinosWrappers::Vector  u2(dim);
+    TrilinosWrappers::Vector f;
+    f.reinit(dim);
+    TrilinosWrappers::Vector u1;
+    u1.reinit(dim);
+    TrilinosWrappers::Vector u2;
+    u2.reinit(dim);
     f = 1.;
     A.compress (VectorOperation::insert);
     f.compress (VectorOperation::insert);
index 68892722dc4e8e7d26096046ef662c3f1f8b62ae..310ebba605de590eed9465a101a9ec8d75bb121b 100644 (file)
@@ -60,9 +60,12 @@ int main(int argc, char **argv)
     for (unsigned int row=0; row<dim; row++)
       A.set(row,row, 2.0*(row+1));
 
-    TrilinosWrappers::Vector  f(dim);
-    TrilinosWrappers::Vector  u1(dim);
-    TrilinosWrappers::Vector  u2(dim);
+    TrilinosWrappers::Vector f;
+    f.reinit(dim);
+    TrilinosWrappers::Vector u1;
+    u1.reinit(dim);
+    TrilinosWrappers::Vector u2;
+    u2.reinit(dim);
     f = 1.;
     A.compress (VectorOperation::insert);
     f.compress (VectorOperation::insert);
index 9c43cab50055ed1f4b152f1743cfa2d0241233ea..cb222d0874c7ee6b733d83bf0a2a7783c331e810 100644 (file)
@@ -72,8 +72,10 @@ int main (int argc, char **argv)
   try
     {
       {
-        TrilinosWrappers::Vector v (100);
-        TrilinosWrappers::Vector w (100);
+        TrilinosWrappers::Vector v;
+        v.reinit(100);
+        TrilinosWrappers::Vector w;
+        w.reinit(100);
         test (v,w);
       }
     }
index 477416234ea47e83daed303eb1585b5de2317e4f..cc962553e0b35b5db87aa1ded37e40de22e71dc4 100644 (file)
@@ -72,8 +72,10 @@ int main (int argc, char **argv)
   try
     {
       {
-        TrilinosWrappers::Vector v (100);
-        TrilinosWrappers::Vector w (100);
+        TrilinosWrappers::Vector v;
+        v.reinit(100);
+        TrilinosWrappers::Vector w;
+        w.reinit(100);
         test (v,w);
       }
     }
index 40eee248ef5f24238218ade0e50210bd59fda323..b8c3704b4c711af4cacecf6577a1d080197d17c9 100644 (file)
@@ -75,8 +75,10 @@ int main (int argc, char **argv)
   try
     {
       {
-        TrilinosWrappers::Vector v (100);
-        TrilinosWrappers::Vector w (100);
+        TrilinosWrappers::Vector v;
+        v.reinit(100);
+        TrilinosWrappers::Vector w;
+        w.reinit(100);
         test (v,w);
       }
     }
index 6913fead47e9a7ae80dfefe2a2719a1d98d3a369..fe77fd32170aea79960ebb7878fb739f96fc6209 100644 (file)
@@ -74,8 +74,10 @@ int main (int argc, char **argv)
   try
     {
       {
-        TrilinosWrappers::Vector v (100);
-        TrilinosWrappers::Vector w (100);
+        TrilinosWrappers::Vector v;
+        v.reinit(100);
+        TrilinosWrappers::Vector w;
+        w.reinit(100);
         test (v,w);
       }
     }
index 96f565cd9b9c331388ea82998edc07a4a19a7738..cf3f866a7b4152ff568027dbeaf42486d28070b4 100644 (file)
@@ -78,8 +78,10 @@ int main (int argc, char **argv)
   try
     {
       {
-        TrilinosWrappers::Vector v (100);
-        TrilinosWrappers::Vector w (100);
+        TrilinosWrappers::Vector v;
+        v.reinit(100);
+        TrilinosWrappers::Vector w;
+        w.reinit(100);
         test (v,w);
       }
     }
index c24458b3fb3440c431e3192c5736f92ae2fd7da3..295a793ce87f7c11237e3c6d2b816cc394151c0a 100644 (file)
@@ -70,7 +70,8 @@ int main (int argc, char **argv)
   try
     {
       {
-        TrilinosWrappers::Vector v (30);
+        TrilinosWrappers::Vector v;
+        v.reinit(30);
         test (v);
       }
     }
index b6c3c9c6c6c7d66979d407b4fe91aa3d2ece2f37..441eeb5c8d2e09ba6e1eaeb5f1c457f3f049f82a 100644 (file)
@@ -80,9 +80,12 @@ int main (int argc, char **argv)
   try
     {
       {
-        TrilinosWrappers::Vector v (100);
-        TrilinosWrappers::Vector w (100);
-        TrilinosWrappers::Vector x (100);
+        TrilinosWrappers::Vector v;
+        v.reinit(100);
+        TrilinosWrappers::Vector w;
+        w.reinit(100);
+        TrilinosWrappers::Vector x;
+        x.reinit(100);
         test (v,w,x);
       }
     }
index 708dd7a3d9dc9d5ea4fdfd960c23305e555dbdb5..7ad06b816e23ca7fd9df822d6ae848916353bc0b 100644 (file)
@@ -62,8 +62,10 @@ int main (int argc, char **argv)
   try
     {
       {
-        TrilinosWrappers::Vector v (100);
-        TrilinosWrappers::Vector w (100);
+        TrilinosWrappers::Vector v;
+        v.reinit(100);
+        TrilinosWrappers::Vector w;
+        w.reinit(100);
         test (v,w);
       }
     }
index 720e1c786f244af3f6b8df19e4ba6b778dd6bc54..7409afa47a30dc00f704f57706524535051a0235 100644 (file)
@@ -61,8 +61,10 @@ int main (int argc, char **argv)
   try
     {
       {
-        TrilinosWrappers::Vector v (100);
-        TrilinosWrappers::Vector w (100);
+        TrilinosWrappers::Vector v;
+        v.reinit(100);
+        TrilinosWrappers::Vector w;
+        w.reinit(100);
         test (v,w);
       }
     }
index 42e6bb69f07bf5ca7deeef954e31fc79aa462d3b..2dda42d42fe5a3e1438c5937b4f22c3f4b3a3d49 100644 (file)
@@ -57,8 +57,10 @@ int main (int argc, char **argv)
   try
     {
       {
-        TrilinosWrappers::Vector v (100);
-        TrilinosWrappers::Vector w (100);
+        TrilinosWrappers::Vector v;
+        v.reinit(100);
+        TrilinosWrappers::Vector w;
+        w.reinit(100);
         test (v,w);
       }
     }
index 90dbda09572178e82301a132b36d7e0311cc8d15..230e723d640902325f8260a74604b12f62a180f2 100644 (file)
@@ -59,8 +59,10 @@ int main (int argc, char **argv)
   try
     {
       {
-        TrilinosWrappers::Vector v (100);
-        TrilinosWrappers::Vector w (100);
+        TrilinosWrappers::Vector v;
+        v.reinit(100);
+        TrilinosWrappers::Vector w;
+        w.reinit(100);
         test (v,w);
       }
     }
index 73b18fe08a9473ef5ad90fa0bf9ac54b18f93686..2449fb7995b6998d51d84b08cd54826698f8f6cc 100644 (file)
@@ -57,8 +57,10 @@ int main (int argc, char **argv)
   try
     {
       {
-        TrilinosWrappers::Vector v (100);
-        TrilinosWrappers::Vector w (100);
+        TrilinosWrappers::Vector v;
+        v.reinit(100);
+        TrilinosWrappers::Vector w;
+        w.reinit(100);
         test (v,w);
       }
     }
index 382510bb2a6b92fae83e9b2d9cfb1f9cc16822a8..65cbb17ffe8dd5863d35ca7704a2aeb2de472d09 100644 (file)
@@ -59,8 +59,10 @@ int main (int argc, char **argv)
   try
     {
       {
-        TrilinosWrappers::Vector v (100);
-        TrilinosWrappers::Vector w (100);
+        TrilinosWrappers::Vector v;
+        v.reinit(100);
+        TrilinosWrappers::Vector w;
+        w.reinit(100);
         test (v,w);
       }
     }
index 16040f65f9d105332cd92e36086656603a1c6951..21c5ef463bdef34ae5ada2d5979553b06c212a6b 100644 (file)
@@ -29,7 +29,8 @@
 
 void test ()
 {
-  TrilinosWrappers::Vector v(3);
+  TrilinosWrappers::Vector v;
+  v.reinit(3);
   v(0) = 0;
   v(1) = 1;
   v(2) = 2;
index 2b4c8f8ea1233bb86c702816c25f5409fd439e4f..1b4f1e512c424cd67943950e1cae950790310345 100644 (file)
@@ -36,10 +36,12 @@ void print(TrilinosWrappers::Vector &v)
 
 void test ()
 {
-  TrilinosWrappers::Vector v(5);
+  TrilinosWrappers::Vector v;
+  v.reinit(5);
   for (unsigned int i=0; i<v.size(); ++i)
     v(i) = 1;
-  TrilinosWrappers::Vector w(9);
+  TrilinosWrappers::Vector w;
+  w.reinit(9);
   for (unsigned int i=0; i<w.size(); ++i)
     w(i) = 2;
 

In the beginning the Universe was created. This has made a lot of people very angry and has been widely regarded as a bad move.

Douglas Adams


Typeset in Trocchi and Trocchi Bold Sans Serif.