]> https://gitweb.dealii.org/ - dealii.git/commitdiff
fix petsc_complex test
authorDenis Davydov <davydden@gmail.com>
Sun, 6 Mar 2016 17:20:23 +0000 (18:20 +0100)
committerDenis Davydov <davydden@gmail.com>
Sat, 12 Mar 2016 18:55:07 +0000 (19:55 +0100)
37 files changed:
tests/petsc_complex/00.cc
tests/petsc_complex/00.output
tests/petsc_complex/01.cc
tests/petsc_complex/02.cc
tests/petsc_complex/04.cc
tests/petsc_complex/05.cc
tests/petsc_complex/06.cc
tests/petsc_complex/07.cc
tests/petsc_complex/08.cc
tests/petsc_complex/09.cc
tests/petsc_complex/10.cc
tests/petsc_complex/11.cc
tests/petsc_complex/12.cc
tests/petsc_complex/13.cc
tests/petsc_complex/17.cc
tests/petsc_complex/18.cc
tests/petsc_complex/19.cc
tests/petsc_complex/20.cc
tests/petsc_complex/element_access_00.cc
tests/petsc_complex/element_access_01.cc
tests/petsc_complex/element_access_02.cc
tests/petsc_complex/element_access_03.cc
tests/petsc_complex/fe_get_function_values.cc
tests/petsc_complex/parallel_sparse_matrix_01.cc
tests/petsc_complex/solver_real_01.cc
tests/petsc_complex/solver_real_02.cc
tests/petsc_complex/solver_real_03.cc
tests/petsc_complex/solver_real_03_mf.cc
tests/petsc_complex/solver_real_04.cc
tests/petsc_complex/sparse_matrix_01.cc
tests/petsc_complex/vector_02.cc
tests/petsc_complex/vector_assign_01.cc
tests/petsc_complex/vector_assign_02.cc
tests/petsc_complex/vector_equality_1.cc
tests/petsc_complex/vector_equality_2.cc
tests/petsc_complex/vector_print.cc
tests/petsc_complex/vector_wrap_01.cc

index f00cdb481bbffebfa9a2e497e340bd897ad529d9..17781e5d09d368141bb42ccdcef2507b8bae2fe3 100644 (file)
@@ -1,7 +1,6 @@
 // ---------------------------------------------------------------------
-// $Id: 00.cc$
 //
-// Copyright (C) 2013 by the deal.II authors
+// Copyright (C) 2004 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
 //
 // ---------------------------------------------------------------------
 
-
-// PETSc includes: We would like to do this cleanly
-//
-#include <petscksp.h>
-#include <petscsys.h>
-#include <petscmath.h>
-//
-// though a horrible warning message
-//
-// warning: imaginary constants are a GCC extension [enabled by default]
-//
-// appears. This seems to be related to the direct useage of
-// PetscScalar in accordance with gcc.gnu.org bug 7263.
-
-// deal.II includes
 #include "../tests.h"
 #include <deal.II/base/logstream.h>
 
@@ -159,16 +143,16 @@ void init_petsc_complex ()
   deallog << "OK" << std::endl;
 }
 
+
 int main (int argc, char **argv)
 {
   std::ofstream logfile ("output");
   dealii::deallog.attach (logfile);
-  dealii::deallog.depth_console (0);
   deallog.threshold_double(1.e-10);
 
   try
     {
-      PetscInitialize (&argc, &argv, (char *) 0, (char *) 0);
+      Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, 1);
       {
         // initialisation (zero and nonzero)
         init_petsc_complex ();
@@ -182,7 +166,6 @@ int main (int argc, char **argv)
         divide_petsc_complex_by_a_number ();
         multiply_petsc_complex_by_a_number ();
       }
-      PetscFinalize ();
     }
 
   catch (std::exception &exc)
@@ -210,8 +193,6 @@ int main (int argc, char **argv)
       return 1;
     }
 
-  logfile << std::endl;
-
   return 0;
 }
 
index 8fc890b1ae75786c24ac78025af907d07a6798d9..a7cb78f5fb0688dff5e31b2a600a531bdbdd2854 100644 (file)
@@ -11,4 +11,3 @@ DEAL::Check PetscScalar division
 DEAL::OK
 DEAL::Check PetscScalar multiply
 DEAL::OK
-
index 4dbcfec56cea70d6ff2226cd966710861883c752..61a78e9054ea0ff173b8cb587a230d0c6c31b7a9 100644 (file)
@@ -1,7 +1,6 @@
 // ---------------------------------------------------------------------
-// $Id: 01.cc $
 //
-// Copyright (C) 2013 by the deal.II authors
+// Copyright (C) 2004 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
@@ -31,7 +30,7 @@ void test (PETScWrappers::SparseMatrix &m)
       if ((i+2*j+1) % 3 == 0)
         m.set (i,j, std::complex<double> (0.,i*j*.5+.5));
 
-  m.compress (VectorOperation::add);
+  m.compress (VectorOperation::insert);
 
   // then make sure we retrieve the same ones
   for (unsigned int i=0; i<m.m(); ++i)
index dd70f49c83502c3da68b726e20c31762ce181365..ff4e8c87ab883e63195006ec5162f6d050be71e2 100644 (file)
@@ -1,7 +1,6 @@
 // ---------------------------------------------------------------------
-// $Id: 02.cc $
 //
-// Copyright (C) 2013 by the deal.II authors
+// Copyright (C) 2004 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b0a8d51e015a8ad67523eb5424ad53760b6b37b7..6312b33fbcb921b332ecdc2483e838363c36ec12 100644 (file)
@@ -1,7 +1,6 @@
 // ---------------------------------------------------------------------
-// $Id: 04.cc $
 //
-// Copyright (C) 2013 by the deal.II authors
+// Copyright (C) 2004 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index dd468a6e0bed97d16dc8f72be26ab0fc9f9ee99d..f6e6422c1039613ee47310e34df877d651ff2abf 100644 (file)
@@ -1,7 +1,6 @@
 // ---------------------------------------------------------------------
-// $Id: 05.cc $
 //
-// Copyright (C) 2013 by the deal.II authors
+// Copyright (C) 2004 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
@@ -36,7 +35,7 @@ void test (PETScWrappers::SparseMatrix &m)
           ++counter;
         }
 
-  m.compress (VectorOperation::add);
+  m.compress (VectorOperation::insert);
 
   deallog << m.n_nonzero_elements() << std::endl;
   Assert (m.n_nonzero_elements() == counter,
index e3cc027519bf6a5ca2fa887587a68186395b8a60..37904745358a175675d8020d716dcd2ae751ae80 100644 (file)
@@ -1,7 +1,6 @@
 // ---------------------------------------------------------------------
-// $Id: 06.cc $
 //
-// Copyright (C) 2013 by the deal.II authors
+// Copyright (C) 2004 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
@@ -31,7 +30,7 @@ void test (PETScWrappers::SparseMatrix &m)
       if ((i+2*j+1) % 3 == 0)
         m.set (i,j, std::complex<double> (0.,i*j*.5+.5));
 
-  m.compress (VectorOperation::add);
+  m.compress (VectorOperation::insert);
 
   // compare against the exact value of the l1-norm (max col-sum)
   deallog << m.l1_norm() << std::endl;
index 3a1cafb1a9cecd8913cc464cb6cbe611f243af7c..75b106ebd4969a9f5c8fc3da42a27cdf1874bd27 100644 (file)
@@ -1,7 +1,6 @@
 // ---------------------------------------------------------------------
-// $Id: 07.cc $
 //
-// Copyright (C) 2013 by the deal.II authors
+// Copyright (C) 2004 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
@@ -32,7 +31,7 @@ void test (PETScWrappers::SparseMatrix &m)
       if ((i+2*j+1) % 3 == 0)
         m.set (i,j, std::complex<double> (0.,i*j*.5+.5));
 
-  m.compress (VectorOperation::add);
+  m.compress (VectorOperation::insert);
 
   // compare against the exact value of the linfty-norm (max row-sum).
   deallog << m.linfty_norm() << std::endl;
index e34a00a744972f59dcac7a34223589df58be7b10..3ab73e9b46da3310a75f3834e518c1536b401891 100644 (file)
@@ -1,7 +1,6 @@
 // ---------------------------------------------------------------------
-// $Id: 08.cc $
 //
-// Copyright (C) 2013 by the deal.II authors
+// Copyright (C) 2004 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
@@ -37,7 +36,7 @@ void test (PETScWrappers::SparseMatrix &m)
         }
   norm = std::sqrt(norm);
 
-  m.compress (VectorOperation::add);
+  m.compress (VectorOperation::insert);
 
   // compare against the exact value of the l2-norm (max row-sum)
   deallog << m.frobenius_norm() << std::endl;
index e04c644cc67a7453259eb558061470c006177e69..b4fb084a661f2d4801ce3af654f1aabe04b4688b 100644 (file)
@@ -1,7 +1,6 @@
 // ---------------------------------------------------------------------
-// $Id: 09.cc $
 //
-// Copyright (C) 2013 by the deal.II authors
+// Copyright (C) 2004 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
@@ -32,7 +31,7 @@ void test (PETScWrappers::SparseMatrix &m)
       if ((i+2*j+1) % 3 == 0)
         m.set (i,j, std::complex<double> (i*j*.5+.5,i*j*.5));
 
-  m.compress (VectorOperation::add);
+  m.compress (VectorOperation::insert);
 
   // then multiply everything by 1.25
   m *= 1.25;
index 5d27dd617ae770f7bbee8ad2458c6dbdf1755bbb..2e22c87c119f73ece9ec96454061eaa137b6d67c 100644 (file)
@@ -1,7 +1,6 @@
 // ---------------------------------------------------------------------
-// $id: 10.cc $
 //
-// Copyright (C) 2013 by the deal.II authors
+// Copyright (C) 2004 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
@@ -31,7 +30,7 @@ void test (PETScWrappers::SparseMatrix &m)
       if ((i+2*j+1) % 3 == 0)
         m.set (i,j, std::complex<double> (0.,i*j*.5+.5));
 
-  m.compress (VectorOperation::add);
+  m.compress (VectorOperation::insert);
 
   // then divide everything by 4/3 and make sure we retrieve the
   // values we expect
index 2b332d9d5bb933f5043ea45d9e0b802e5ab5f117..07181f7bbe752e9b3250d45a67e688ec11f8364f 100644 (file)
@@ -1,7 +1,6 @@
 // ---------------------------------------------------------------------
-// $Id: 11.cc $
 //
-// Copyright (C) 2013 by the deal.II authors
+// Copyright (C) 2004 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
@@ -30,7 +29,7 @@ void test (PETScWrappers::Vector &v)
   for (unsigned int k=0; k<v.size(); k+=1+k)
     v(k) = std::complex<double> (k,.5*k);
 
-  v.compress (VectorOperation::add);
+  v.compress (VectorOperation::insert);
 
   Assert (v.size() == 100, ExcInternalError());
 
index 608fa3baee3ab780f262e2ed69f7353f30d1d539..d2ab3d5f4d44e85fc545d8982ce19ef0f152e45d 100644 (file)
@@ -1,7 +1,6 @@
 // ---------------------------------------------------------------------
-// $Id: 12.cc $
 //
-// Copyright (C) 2013 by the deal.II authors
+// Copyright (C) 2004 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
@@ -39,7 +38,7 @@ void test (PETScWrappers::Vector &v)
       pattern[k] = true;
     }
 
-  v.compress (VectorOperation::add);
+  v.compress (VectorOperation::insert);
 
   // check that they are ok, and this time all of them
   for (unsigned int k=0; k<v.size(); ++k)
index 03af432204b75e0365ffce93063912818114654a..0d68cdf3135664394cc698350e66be8c5bf12b55 100644 (file)
@@ -1,7 +1,6 @@
 // ---------------------------------------------------------------------
-// $Id: 13.cc $
 //
-// Copyright (C) 2013 by the deal.II authors
+// Copyright (C) 2004 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a4c85e11a74ef17c45df426fbe0256353fb4cf64..637a8515faea71db00fae79b8b5cb474e2e15ded 100644 (file)
@@ -1,7 +1,6 @@
 // ---------------------------------------------------------------------
-// $Id: 17.cc $
 //
-// Copyright (C) 2013 by the deal.II authors
+// Copyright (C) 2004 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
@@ -34,7 +33,7 @@ void test (PETScWrappers::Vector &v)
       v(k) = PetscScalar (k,2.*k);
       norm += std::fabs (1.*k+2.*k);
     }
-  v.compress (VectorOperation::add);
+  v.compress (VectorOperation::insert);
 
   // then check the norm
   Assert (v.l1_norm() == norm, ExcInternalError());
index c575c59fb52e24cfff66bbb96cb0e72c3c13f8a5..37ef593f2d06c6b98ff155ebb99f1a495f932e62 100644 (file)
@@ -1,7 +1,6 @@
 // ---------------------------------------------------------------------
-// $Id: 18.cc $
 //
-// Copyright (C) 2013 by the deal.II authors
+// Copyright (C) 2004 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
@@ -38,7 +37,7 @@ void test (PETScWrappers::Vector &v)
       norm += std::fabs (1.*k*1.*k /*+ 1.*k*2*ki - 1.*k*2*ki*/ + 2*k*2.*k/*i*/);
     }
 
-  v.compress (VectorOperation::add);
+  v.compress (VectorOperation::insert);
 
   // then check the l2-norm
   PetscReal l2_norm = v.l2_norm();
index 4bb0c1bc4ef863353fe8e030e95fb840884eb535..169f90828100b2ddf50c468d90adba4e1306cfa5 100644 (file)
@@ -1,7 +1,6 @@
 // ---------------------------------------------------------------------
-// $Id: 19.cc $
 //
-// Copyright (C) 2013 by the deal.II authors
+// Copyright (C) 2004 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
@@ -37,7 +36,7 @@ void test (PETScWrappers::Vector &v)
       norm = std::max (norm,std::fabs (std::sqrt ((k*k + 2.*k*2.*k))));
     }
 
-  v.compress (VectorOperation::add);
+  v.compress (VectorOperation::insert);
 
   // then check the norm
   Assert (v.linfty_norm() == norm, ExcInternalError());
index 0774b2cef247f2bac82ac9678806930a6ab43b70..c0bc9db93b11a8d96f0bc4612470ecd3eb575396 100644 (file)
@@ -1,7 +1,6 @@
 // ---------------------------------------------------------------------
-// $Id: 23.cc 31349 2013-10-20 19:07:06Z maier $
 //
-// Copyright (C) 2004 - 2013 by the deal.II authors
+// Copyright (C) 2004 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
@@ -45,8 +44,8 @@ void test (PETScWrappers::Vector &v,
         }
     }
 
-  v.compress (VectorOperation::add);
-  w.compress (VectorOperation::add);
+  v.compress (VectorOperation::insert);
+  w.compress (VectorOperation::insert);
 
   // make sure the scalar product is zero
   Assert (v*w == product, ExcInternalError());
index a088479882d4758c19b72cbebef5f96a38663ff4..09fef7f132fb1bc07230b5cd7b44f5bdf39f54b0 100644 (file)
@@ -1,8 +1,6 @@
-
 // ---------------------------------------------------------------------
-// $Id:
 //
-// Copyright (C) 2013 by the deal.II authors
+// Copyright (C) 2004 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
@@ -39,7 +37,7 @@ void test_vector (PETScWrappers::Vector &v)
   for (unsigned int k=0; k<v.size(); ++k)
     v(k) = std::complex<double> (k,v.size()-k);
 
-  v.compress (VectorOperation::add);
+  v.compress (VectorOperation::insert);
 
   // check that is what we get by casting PetscScalar to std::real()
   // and std::imag()
@@ -67,7 +65,7 @@ int main (int argc, char **argv)
 
   try
     {
-      PetscInitialize (&argc, &argv, (char *) 0, (char *) 0);
+      Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1);
       {
         PETScWrappers::Vector v (5);
         test_vector (v);
@@ -75,7 +73,6 @@ int main (int argc, char **argv)
         deallog << "vector:" << std::endl;
         v.print (logfile);
       }
-      PetscFinalize ();
     }
 
 
index 31b0a4f940b8ed3f3dbdfa9df3639ac992d21837..69c28b990b6bd90d22e1043a61d5bb2895ecbefa 100644 (file)
@@ -1,8 +1,6 @@
-
 // ---------------------------------------------------------------------
-// $Id:
 //
-// Copyright (C) 2013 by the deal.II authors
+// Copyright (C) 2004 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
@@ -42,7 +40,7 @@ void test_matrix (PETScWrappers::SparseMatrix &m)
         m.set (k,l, std::complex<double> (el_r,el_i));
       }
 
-  m.compress (VectorOperation::add);
+  m.compress (VectorOperation::insert);
 
   for (unsigned int k=0; k<m.m(); ++k)
     for (unsigned int l=0; l<m.n(); ++l)
@@ -66,7 +64,7 @@ int main (int argc, char **argv)
 
   try
     {
-      PetscInitialize (&argc, &argv, (char *) 0, (char *) 0);
+      Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1);
       {
         PETScWrappers::SparseMatrix m (5,5,5);
         test_matrix (m);
@@ -74,7 +72,6 @@ int main (int argc, char **argv)
         deallog << "matrix:" << std::endl;
         m.print (logfile);
       }
-      PetscFinalize ();
     }
 
 
index 0b66ad38014264c4ef82bfe5974ef13a2c090fc4..02b4d04edafe6040de37619296abbbc96f22ff05 100644 (file)
@@ -1,8 +1,6 @@
-
 // ---------------------------------------------------------------------
-// $Id: element_access_02.cc
 //
-// Copyright (C) 2013 by the deal.II authors
+// Copyright (C) 2004 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
@@ -35,7 +33,7 @@ void test (PETScWrappers::SparseMatrix &m)
       if (k>l)
         m.set (k,l, PetscScalar (k+l,-1.*(k+l)));
 
-  m.compress (VectorOperation::add);
+  m.compress (VectorOperation::insert);
 
   // check the matrix is correctly filled
   for (unsigned int k=0; k<m.m(); ++k)
@@ -55,7 +53,7 @@ int main (int argc, char **argv)
 
   try
     {
-      PetscInitialize (&argc, &argv, (char *) 0, (char *) 0);
+      Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1);
       {
         PETScWrappers::SparseMatrix m (10,10,10);
         test (m);
@@ -63,7 +61,6 @@ int main (int argc, char **argv)
         deallog << "matrix:" << std::endl;
         m.print (logfile);
       }
-      PetscFinalize ();
     }
 
   catch (std::exception &exc)
index df1a0fc061f54532f1708876dacff3ec2b53c19f..9d525755aecd9c4d7d9cb6e2ac24da80c06c1950 100644 (file)
@@ -1,8 +1,6 @@
-
 // ---------------------------------------------------------------------
-// $Id:
 //
-// Copyright (C) 2013 by the deal.II authors
+// Copyright (C) 2004 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
@@ -43,7 +41,7 @@ void test_matrix (PETScWrappers::SparseMatrix &m)
     for (unsigned int l=0; l<m.n(); ++l)
       m.set (k,l, PetscScalar ((k+l)*r,(k+l)*i));
 
-  m.compress (VectorOperation::add);
+  m.compress (VectorOperation::insert);
 
   // Check elements have the correct value
   for (unsigned int k=0; k<m.m(); ++k)
@@ -75,7 +73,7 @@ int main (int argc, char **argv)
 
   try
     {
-      PetscInitialize (&argc, &argv, (char *) 0, (char *) 0);
+      Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1);
       {
         PETScWrappers::SparseMatrix m (5,5,5);
         test_matrix (m);
@@ -83,7 +81,6 @@ int main (int argc, char **argv)
         deallog << "matrix:" << std::endl;
         m.print (logfile);
       }
-      PetscFinalize ();
     }
 
   catch (std::exception &exc)
index 999e4f0d9127b88ccd5d80b6d121d4bf9f7d2ec0..9aca85dff68c14026998416b1eb4082bde9b713e 100644 (file)
@@ -1,7 +1,6 @@
 // ---------------------------------------------------------------------
-// $Id: testsuite.html 32446 2014-05-21 14:31:22Z davydov $
 //
-// Copyright (C) 2013 by the deal.II Authors
+// Copyright (C) 2004 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
@@ -170,8 +169,8 @@ int main (int argc, char *argv[])
   deallog.depth_console(0);
   deallog.threshold_double(1.e-10);
 
-  Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv);
-
-  test ();
-
-}
\ No newline at end of file
+  Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1);
+  {
+    test ();
+  }
+}
index 503bb3f2ff28a3b7f0ff12086755550eacf68ea4..5eb530915e52bcc8779097278d7ac8edf3f514e2 100644 (file)
@@ -1,7 +1,6 @@
 // ---------------------------------------------------------------------
-// $Id: testsuite.html 32446 2014-02-10 14:31:22Z bangerth $
 //
-// Copyright (C) 2013 by the deal.II Authors
+// Copyright (C) 2004 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
@@ -113,7 +112,7 @@ void test (const unsigned int poly_degree = 1)
       if (cell->is_locally_owned())
         {
           fe_values.reinit (cell);
-          cell_mass_matrix    = PetscScalar(0);
+          cell_mass_matrix    = PetscScalar();
 
           for (unsigned int q_point=0; q_point<n_q_points; ++q_point)
             for (unsigned int i=0; i<dofs_per_cell; ++i)
@@ -160,8 +159,8 @@ void test (const unsigned int poly_degree = 1)
   vector.compress(VectorOperation::insert);
   constraints.distribute(vector);
 
-  deallog<<"symmetric: "<<mass_matrix.is_symmetric()<<std::endl;
-  deallog<<"hermitian: "<<mass_matrix.is_hermitian()<<std::endl;
+  deallog<<"symmetric: "<<(mass_matrix.is_symmetric()==PETSC_TRUE)<<std::endl;
+  deallog<<"hermitian: "<<(mass_matrix.is_hermitian()==PETSC_TRUE)<<std::endl;
 
   PETScWrappers::MPI::Vector tmp(vector);
   mass_matrix.vmult (tmp, vector);
@@ -192,8 +191,8 @@ int main (int argc, char *argv[])
   deallog.depth_console(0);
   deallog.threshold_double(1.e-10);
 
-  Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv);
-
-  test<2>();
-
-}
\ No newline at end of file
+  Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1);
+  {
+    test<2>();
+  }
+}
index 9c045ca95803dcf3aacf7ab8dd8327563c9bb900..c5126c999e0783d1eb13e018ae6c655ae5768f70 100644 (file)
@@ -1,7 +1,6 @@
 // ---------------------------------------------------------------------
-// $Id: solver_real_01.cc $
 //
-// Copyright (C) 2013 by the deal.II authors
+// Copyright (C) 2004 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
@@ -85,9 +84,9 @@ int main(int argc, char **argv)
     PETScWrappers::Vector  f(dim);
     PETScWrappers::Vector  u(dim);
     f = 1.;
-    A.compress (VectorOperation::add);
-    f.compress (VectorOperation::add);
-    u.compress (VectorOperation::add);
+    A.compress (VectorOperation::insert);
+    f.compress (VectorOperation::insert);
+    u.compress (VectorOperation::insert);
 
     PETScWrappers::SolverRichardson solver(control);
     PETScWrappers::PreconditionJacobi preconditioner(A);
index 28f4e0484b74b561bc3ed7197eab3fd13ae74041..8d952c928573fa6031d7ee1072da1a31a6d5b696 100644 (file)
@@ -1,7 +1,6 @@
 // ---------------------------------------------------------------------
-// $Id: solver_real_02.cc $
 //
-// Copyright (C) 2013 by the deal.II authors
+// Copyright (C) 2004 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
@@ -83,9 +82,9 @@ int main(int argc, char **argv)
     PETScWrappers::Vector  f(dim);
     PETScWrappers::Vector  u(dim);
     f = 1.;
-    A.compress (VectorOperation::add);
-    f.compress (VectorOperation::add);
-    u.compress (VectorOperation::add);
+    A.compress (VectorOperation::insert);
+    f.compress (VectorOperation::insert);
+    u.compress (VectorOperation::insert);
 
     PETScWrappers::SolverChebychev solver(control);
     PETScWrappers::PreconditionJacobi preconditioner(A);
index 0b69601e0743d0c1aa70ef98116a070c360c4353..cc5406ac71a5a7c29f1fbc7357d5002c9ceb54b1 100644 (file)
@@ -1,7 +1,6 @@
 // ---------------------------------------------------------------------
-// $Id: solver_real_03.cc $
 //
-// Copyright (C) 2013 by the deal.II authors
+// Copyright (C) 2004 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
@@ -82,9 +81,9 @@ int main(int argc, char **argv)
     PETScWrappers::Vector  f(dim);
     PETScWrappers::Vector  u(dim);
     f = 1.;
-    A.compress (VectorOperation::add);
-    f.compress (VectorOperation::add);
-    u.compress (VectorOperation::add);
+    A.compress (VectorOperation::insert);
+    f.compress (VectorOperation::insert);
+    u.compress (VectorOperation::insert);
 
     PETScWrappers::SolverCG solver(control);
     PETScWrappers::PreconditionJacobi preconditioner(A);
index b3197e70ea7ed8ed53cbaa1a3f9f282d3a8b5043..1bea00f78fbe6567e2224a691ab52751cab7ad33 100644 (file)
@@ -1,7 +1,6 @@
 // ---------------------------------------------------------------------
-// $Id: solver_03_mf.cc $
 //
-// Copyright (C) 2013 by the deal.II authors
+// Copyright (C) 2004 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
@@ -92,9 +91,9 @@ int main(int argc, char **argv)
     PETScWrappers::Vector  f(dim);
     PETScWrappers::Vector  u(dim);
     f = 1.;
-    A.compress (VectorOperation::add);
-    f.compress (VectorOperation::add);
-    u.compress (VectorOperation::add);
+    A.compress (VectorOperation::insert);
+    f.compress (VectorOperation::insert);
+    u.compress (VectorOperation::insert);
 
     PETScWrappers::SolverCG solver(control);
     PETScWrappers::PreconditionNone preconditioner(A);
index 9ace49088c58fb4156bcea606e48c5c2ea211a32..eed403f0b8bf6a813f468b4810ce055865e7751c 100644 (file)
@@ -1,7 +1,6 @@
 // ---------------------------------------------------------------------
-// $Id: solver_real_04.cc $
 //
-// Copyright (C) 2013 by the deal.II authors
+// Copyright (C) 2004 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
@@ -82,9 +81,9 @@ int main(int argc, char **argv)
     PETScWrappers::Vector  f(dim);
     PETScWrappers::Vector  u(dim);
     f = 1.;
-    A.compress (VectorOperation::add);
-    f.compress (VectorOperation::add);
-    u.compress (VectorOperation::add);
+    A.compress (VectorOperation::insert);
+    f.compress (VectorOperation::insert);
+    u.compress (VectorOperation::insert);
 
     PETScWrappers::SolverBiCG solver(control);
     PETScWrappers::PreconditionJacobi preconditioner(A);
index 7d7a749b1ce13f856f28dc1605f74a911c2cbfb8..46f783f61d0b024921fc18635f689d1c3626ca57 100644 (file)
@@ -1,7 +1,6 @@
 // ---------------------------------------------------------------------
-// $Id sparse_matrix_01.cc $
 //
-// Copyright (C) 2013 by the deal.II authors
+// Copyright (C) 2004 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
@@ -33,13 +32,13 @@ void test ()
     for (unsigned int l=0; l<=k; ++l)
       m.set (k,l, k+2*l);
 
-  m.compress (VectorOperation::add);
+  m.compress (VectorOperation::insert);
 
   PETScWrappers::SparseMatrix m2(s,s,s);
   m2.set(0,1,5.0);
   for (unsigned int k=0; k<m2.m(); ++k)
     m2.set(k,k,PetscScalar(1.0+k,-1.0-k));
-  m2.compress(VectorOperation::add);
+  m2.compress(VectorOperation::insert);
 
   // we now print the matrix m, it is all real. Then print after
   // adding m2 which is complex, and then subtract m2 again to get the
index 33586ea2e9ce9506f85f7bdb0e3a895bba25c47c..9cacfcbe95617d6b6b78c6a38bcf19bb29dc84da 100644 (file)
@@ -1,7 +1,6 @@
 // ---------------------------------------------------------------------
-// $Id vector_02.cc $
 //
-// Copyright (C) 2013 by the deal.II authors
+// Copyright (C) 2004 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
@@ -33,7 +32,7 @@ void test ()
   for (unsigned int k=0; k<v.size(); ++k)
     v(k) = k;
 
-  v.compress (VectorOperation::add);
+  v.compress (VectorOperation::insert);
 
   PETScWrappers::Vector v2(s);
   for (unsigned int k=0; k<v2.size(); ++k)
@@ -44,7 +43,7 @@ void test ()
       v2(k) = PetscScalar (k,-1.0*k);
     }
 
-  v2.compress(VectorOperation::add);
+  v2.compress(VectorOperation::insert);
 
   // we now print the vector v, it is all real. Then print after
   // adding v2 which is complex, and then subtract v2 again to get the
index d8f85360c0d97a6c6ff34520fd8f2243ef5bb7fd..c952cf35690dd57f4603562068b26d55c86d5ece 100644 (file)
@@ -1,7 +1,6 @@
 // ---------------------------------------------------------------------
-// $Id: vector_assign_01.cc $
 //
-// Copyright (C) 2013 by the deal.II authors
+// Copyright (C) 2004 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 64c20333b0db7cbe9deb08ec1232bde356e20128..ffc09239342f529fa77bbcacfd89c7369e4c434b 100644 (file)
@@ -1,7 +1,6 @@
 // ---------------------------------------------------------------------
-// $Id: vector_assign_02.cc $
 //
-// Copyright (C) 2013 by the deal.II authors
+// Copyright (C) 2004 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d9d14e9a7c41844cd484a64d3b20840fa44b28c5..ff9953e85e0e4390a0c0d6d445558c4095b49280 100644 (file)
@@ -1,7 +1,6 @@
 // ---------------------------------------------------------------------
-// $Id: vector_equality_1.cc $
 //
-// Copyright (C) 2013 by the deal.II authors
+// Copyright (C) 2004 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 53aa85cce2538772d3abe69c981453c12916a3e0..814f8043bbde85a8df6d5bb51b8eff6eeac23aaf 100644 (file)
@@ -1,7 +1,6 @@
 // ---------------------------------------------------------------------
-// $Id: vector_equality_2.cc $
 //
-// Copyright (C) 2013 by the deal.II authors
+// Copyright (C) 2004 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7d7b64cf1bb943f357db7525e6fb3005c1c590f6..071fa8b79af2021131a4d4246eac92b1e198be58 100644 (file)
@@ -1,7 +1,6 @@
 // ---------------------------------------------------------------------
-// $Id: vector_print.cc $
 //
-// Copyright (C) 2013 by the deal.II authors
+// Copyright (C) 2004 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2f520c6f475dac4658d2b8931978083e59eea00e..d9c1f4c5e1adf4a7fdfa3f81c946a10fe7662b39 100644 (file)
@@ -1,7 +1,6 @@
 // ---------------------------------------------------------------------
-// $Id: vector_wrap_01.cc $
 //
-// Copyright (C) 2013 by the deal.II authors
+// Copyright (C) 2004 - 2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //

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.