]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Fix two tests.
authorMartin Kronbichler <kronbichler@lnm.mw.tum.de>
Thu, 9 Sep 2010 09:09:29 +0000 (09:09 +0000)
committerMartin Kronbichler <kronbichler@lnm.mw.tum.de>
Thu, 9 Sep 2010 09:09:29 +0000 (09:09 +0000)
git-svn-id: https://svn.dealii.org/trunk@21903 0785d39b-7218-0410-832d-ea1e28bc413d

tests/trilinos/deal_solver_02.cc
tests/trilinos/deal_solver_02/cmp/generic
tests/trilinos/deal_solver_06.cc
tests/trilinos/deal_solver_06/cmp/generic

index a1b972a671d4e379c2f9df09679bd120926b70de..baab20c1f3de3466970863fd04483e4abfbc34ae 100644 (file)
@@ -63,8 +63,8 @@ check_solve( SOLVER& solver, const MATRIX& A,
 int main(int argc, char **argv)
 {
   std::ofstream logfile("deal_solver_02/output");
-  logfile.precision(4);
   deallog.attach(logfile);
+  deallog << std::setprecision(4);
   deallog.depth_console(0);
   deallog.threshold_double(1.e-10); 
 
index 7f8e0ffdff7fece11d7fa0cc2da006f82229f42a..664748dd19961a5d48a4415d23990eac6f3ea915 100644 (file)
@@ -1,6 +1,6 @@
 
 DEAL::Size 32 Unknowns 961
 DEAL::Solver type: N6dealii14SolverBicgstabINS_16TrilinosWrappers6VectorEEE
-DEAL:Bicgstab::Starting value 31.0000
-DEAL:Bicgstab::Convergence step 29 value 0.000873501
+DEAL:Bicgstab::Starting value 31.00
+DEAL:Bicgstab::Convergence step 29 value 0.0008735
 DEAL::Solver stopped after 29 iterations
index 6ef52509b8488eb6f372bdb82c5a0c3c456c96b6..ea1828f1a35ae9922889d1ee8520ba5dcc417a41 100644 (file)
@@ -1,20 +1,20 @@
 //----------------------------  trilinos_deal_solver_06.cc  ---------------------------
 //    $Id$
-//    Version: $Name$ 
+//    Version: $Name$
 //
-//    Copyright (C) 2004, 2005, 2008 by the deal.II authors
+//    Copyright (C) 2004, 2005, 2008, 2010 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
 //    to the file deal.II/doc/license.html for the  text  and
 //    further information on this license.
 //
-//----------------------------  trilinos_deal_solver_06.cc  ---------------------------
+//------------------  trilinos_deal_solver_06.cc  ---------------------------
 
 // test the Richardson solver using the Trilinos matrix and vector classes
 
 
-#include "../tests.h" 
+#include "../tests.h"
 #include <base/utilities.h>
 #include "../lac/testmatrix.h"
 #include <cmath>
@@ -40,10 +40,10 @@ check_solve( SOLVER& solver, const MATRIX& A,
             VECTOR& u, VECTOR& f, const PRECONDITION& P)
 {
   deallog << "Solver type: " << typeid(solver).name() << std::endl;
-  
+
   u = 0.;
   f = 1.;
-  try 
+  try
     {
       solver.solve(A,u,f,P);
     }
@@ -60,10 +60,10 @@ check_solve( SOLVER& solver, const MATRIX& A,
 int main(int argc, char **argv)
 {
   std::ofstream logfile("deal_solver_06/output");
-  logfile.precision(4);
   deallog.attach(logfile);
+  deallog << std::setprecision(4);
   deallog.depth_console(0);
-  deallog.threshold_double(1.e-10); 
+  deallog.threshold_double(1.e-10);
 
   Utilities::System::MPI_InitFinalize mpi_initialization (argc, argv);
 
@@ -74,7 +74,7 @@ int main(int argc, char **argv)
     SolverControl control(10000, 1.e-3);
 
     deallog << "Size " << size << " Unknowns " << dim << std::endl;
-      
+
                                      // Make matrix
     FDMatrix testproblem(size, size);
     CompressedSimpleSparsityPattern csp (dim, dim);
@@ -91,7 +91,7 @@ int main(int argc, char **argv)
     u.compress ();
 
     GrowingVectorMemory<TrilinosWrappers::Vector> mem;
-    SolverRichardson<TrilinosWrappers::Vector> solver(control,mem);
+    SolverRichardson<TrilinosWrappers::Vector> solver(control,mem,0.1);
     PreconditionIdentity preconditioner;
     check_solve (solver, A,u,f, preconditioner);
   }
index 2a09d922b41f6b3f0d1c96a2ce93eb249c59f83d..f7b0bc1e0eb83f51790c501659123547f8d24739 100644 (file)
@@ -1,7 +1,6 @@
 
 DEAL::Size 32 Unknowns 961
 DEAL::Solver type: N6dealii16SolverRichardsonINS_16TrilinosWrappers6VectorEEE
-DEAL:Richardson::Starting value 31.0000
-DEAL:Richardson::Failure step 374 value nan
-DEAL::Iterative method reported convergence failure in step 374 with residual nan
-DEAL::Solver stopped after 374 iterations
+DEAL:Richardson::Starting value 31.00
+DEAL:Richardson::Convergence step 5271 value 0.0009996
+DEAL::Solver stopped after 5271 iterations

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.