[petsc-users] problems using ilu dt of superlu

Tobias Neckel neckel at in.tum.de
Thu May 31 08:18:49 CDT 2012


Dear Matt,

 > I know it involves another build, but turning on debugging is really
 > essential for tracking down errors like this. Can you
 > reconfigure with debugging under a different PETSC_ARCH and send the 
trace?

we built the debug version of petsc and now get the attached output 
(with and without valgrind) instead of a segfault for the test under 
consideration.

Interestingly, the code runs now fully (with all the respective error 
messages of petsc) and completes *successfully* the different 5 test 
cases, despite the errors in all of them. The related code lines of the 
PETScNonLinearSolver.cpp (365, 367, and 369) exactly are the newly 
inserted code lines:
        _ierr = PCFactorSetUpMatSolverPackage(pc);
        _ierr = PCFactorGetMatrix(pc,&F);
        _ierr = MatSuperluSetILUDropTol(F,1.0e-3);

What I forgot to mention in the previous email is that we use the ILU 
with GMRES in the linear solve inside a snes non-linear problem ... 
hence, we have a call to SNESCreate() and fetch the ksp from there 
(different to ex52.c).

It looks like setting up the PC is not working correctly even if we 
successfully use it before. Did we miss additional changes in the setup 
from 3.0 to 3.2? Would the full source file help for clarification in 
this case?

Thanks and best regards
Tobias


On 30.05.2012 20:35, Matthew Knepley wrote:
> On Wed, May 30, 2012 at 2:29 PM, Tobias Neckel <neckel at in.tum.de
> <mailto:neckel at in.tum.de>> wrote:
>
>     Hello,
>
>     we recently upgraded from 3.0.0-p11 to 3.2-p7 and are facing a
>     problem in one of our test cases: We use seqaij matrix format and
>     GMRES with ILU dt.
>
>     Knowing that the ILUdt has been replaced by superlu's version, we
>     therefore configured our petsc installation with
>     ---
>     -PETSC_ARCH=petsc-3.2-serial
>     --prefix=/work_fast/liebm/__petsc-3.2-serial/ --with-debugging=0
>     --with-cxx=gcc --with-fc=gfortran --with-cc=gcc --download-superlu=1
>     --with-mpi=0
>     ----
>
>
> I know it involves another build, but turning on debugging is really
> essential for tracking down errors like this. Can you
> reconfigure with debugging under a different PETSC_ARCH and send the trace?
>
>    Thanks
>
>       Matt
>
>     resulting in a nicely compiled lib/libsuperlu_4.2.a.
>
>     Also, ex52.c works (with ILU as a solver).
>
>     Hence, in our code, we replaced the former single-line command
>             _ierr = PCFactorSetDropTolerance(...__stuff...);
>     by the code of ex52.c:
>             Mat F;
>             _ierr = PCFactorSetMatSolverPackage(__pc,MATSOLVERSUPERLU);
>             _ierr = PCFactorSetUpMatSolverPackage(__pc);/* call
>     MatGetFactor() to create F */
>             _ierr = PCFactorGetMatrix(pc,&F);
>             _ierr = MatSuperluSetILUDropTol(F,1.__0e-3);
>
>     After some smooting, the compile and link works now fine, but
>     running the test case results in a segfault; here is the
>     corresponding valgrind output:
>
>     ==17405== Invalid read of size 4
>     ==17405==    at 0x1B15245: MatGetFactor (in
>     /work_fast/liebm/workspace/p1/__src/build/debug/dim2/fluid/__peano-fluid)
>     ==17405==    by 0x1CDF709: PCFactorSetUpMatSolverPackage___Factor
>     (in
>     /work_fast/liebm/workspace/p1/__src/build/debug/dim2/fluid/__peano-fluid)
>     ==17405==    by 0x1B3F7F9: PCFactorSetUpMatSolverPackage (in
>     /work_fast/liebm/workspace/p1/__src/build/debug/dim2/fluid/__peano-fluid)
>     ==17405==    by 0x19284F5:
>     peano::petsc::__PETScNonLinearSolver::__setupLinearSolver(_p_KSP*&,
>     std::string, std::string, double, double, int)
>     (PETScNonLinearSolver.cpp:365)
>     ==17405==    by 0x1926DF2:
>     peano::petsc::__PETScNonLinearSolver::__initialize(int, int, int)
>     (PETScNonLinearSolver.cpp:242)
>     ==17405==    by 0x901225:
>     peano::fluid::__NonLinearTrivialgridFluidSimul__ation::__implementSetInitialValue(bool,
>     double, int, double) (__NonLinearTrivialgridFluidSimul__ation.cpp:540)
>     ==17405==    by 0x17AE3C8:
>     peano::fluid::__SteadyStateIntegrationTestChan__nel::__testTrivialgrid3x3ComputeNavie__rStokesFunction()
>     (__SteadyStateIntegrationTestChan__nel.cpp:114)
>     ==17405==    by 0x17B28A8:
>     peano::fluid::__SteadyStateIntegrationTestChan__nel::run()
>     (__SteadyStateIntegrationTestChan__nel.cpp:484)
>     ==17405==    by 0x19BDCB3: tarch::tests::__TestCaseCollection::run()
>     (TestCaseCollection.cpp:42)
>     ==17405==    by 0x19BDCB3: tarch::tests::__TestCaseCollection::run()
>     (TestCaseCollection.cpp:42)
>     ==17405==    by 0x408A9D:
>     peano::__IntegrationTestCaseRunner::__run(tarch::configuration::__IntegrationTestConfiguration
>     const&) (IntegrationTestCaseRunner.__cpp:127)
>     ==17405==    by 0x412C2E: main (main.cpp:205)
>     ==17405==  Address 0x1e8 is not stack'd, malloc'd or (recently) free'd
>     ==17405==
>     [0]PETSC ERROR:
>     ------------------------------__------------------------------__------------
>     [0]PETSC ERROR: Caught signal number 11 SEGV: Segmentation
>     Violation, probably memory access out of range
>     [0]PETSC ERROR: Try option -start_in_debugger or
>     -on_error_attach_debugger
>     [0]PETSC ERROR: or see
>     http://www.mcs.anl.gov/petsc/__petsc-as/documentation/faq.__html#valgrind[0]PETSC
>     <http://www.mcs.anl.gov/petsc/petsc-as/documentation/faq.html#valgrind[0]PETSC>
>     ERROR: or try http://valgrind.org on GNU/linux and Apple Mac OS X to
>     find memory corruption errors
>     [0]PETSC ERROR: configure using --with-debugging=yes, recompile,
>     link, and run
>     [0]PETSC ERROR: to get more information on the crash.
>     [0]PETSC ERROR: --------------------- Error Message
>     ------------------------------__------
>     [0]PETSC ERROR: Signal received!
>     [0]PETSC ERROR:
>     ------------------------------__------------------------------__------------
>     [0]PETSC ERROR: Petsc Release Version 3.2.0, Patch 7, Thu Mar 15
>     09:30:51 CDT 2012
>     [0]PETSC ERROR: See docs/changes/index.html for recent updates.
>     [0]PETSC ERROR: See docs/faq.html for hints about trouble shooting.
>     [0]PETSC ERROR: See docs/index.html for manual pages.
>     [0]PETSC ERROR:
>     ------------------------------__------------------------------__------------
>     [0]PETSC ERROR: ./build/debug/dim2/fluid/__peano-fluid on a
>     petsc-3.2 named atsccs58 by liebm Wed May 30 20:06:30 2012
>     [0]PETSC ERROR: Libraries linked from
>     /work_fast/liebm/petsc-3.2-__serial/lib
>     [0]PETSC ERROR: Configure run at Tue May 29 21:05:34 2012
>     [0]PETSC ERROR: Configure options --PETSC_ARCH=petsc-3.2-serial
>     --prefix=/work_fast/liebm/__petsc-3.2-serial/ --with-debugging=0
>     --with-cxx=gcc --with-fc=gfortran --with-cc=gcc --download-superlu=1
>     --with-mpi=0
>     [0]PETSC ERROR:
>     ------------------------------__------------------------------__------------
>     [0]PETSC ERROR: User provided function() line 0 in unknown directory
>     unknown file
>
>
>     Did we miss something (keeping in mind that we use ILU now as a
>     preconditioner in combination with GMRES)? Any suggestions are
>     warmly welcome ;-).
>
>     Thanks in advance and best regards
>     Tobias
>
-------------- next part --------------
 1338467468   14:31:08     [atsccs58]   debug        /::validateProgramArguments(int,char**)                 Using configuration file configuration-integration-test.xml
 1338467468   14:31:08     [atsccs58]   debug        peano::petsc::PETScFrame::init()                        received parameters: ./build/debug/dim2/fluid/peano-fluid configuration-integration-test.xml 
[0]PETSC ERROR: --------------------- Error Message ------------------------------------
[0]PETSC ERROR: Null argument, when expecting valid pointer!
[0]PETSC ERROR: Null Object: Parameter # 1!
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: Petsc Release Version 3.2.0, Patch 7, Thu Mar 15 09:30:51 CDT 2012 
[0]PETSC ERROR: See docs/changes/index.html for recent updates.
[0]PETSC ERROR: See docs/faq.html for hints about trouble shooting.
[0]PETSC ERROR: See docs/index.html for manual pages.
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: ./build/debug/dim2/fluid/peano-fluid on a petsc-3.2 named atsccs58 by liebm Thu May 31 14:31:08 2012
[0]PETSC ERROR: Libraries linked from /work_fast/liebm/petsc-3.2-serial-debug/lib
[0]PETSC ERROR: Configure run at Thu May 31 10:27:55 2012
[0]PETSC ERROR: Configure options --PETSC_ARCH=petsc-3.2-serial-debug --prefix=/work_fast/liebm/petsc-3.2-serial-debug --with-debugging=1 --with-cxx=gcc --with-fc=gfortran --with-cc=gcc --download-superlu=1 --with-mpi=0
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: MatGetFactor() line 3929 in /work_fast/liebm/petsc-3.2-p7/src/mat/interface/matrix.c
[0]PETSC ERROR: PCFactorSetUpMatSolverPackage_Factor() line 17 in /work_fast/liebm/petsc-3.2-p7/src/ksp/pc/impls/factor/factimpl.c
[0]PETSC ERROR: PCFactorSetUpMatSolverPackage() line 26 in /work_fast/liebm/petsc-3.2-p7/src/ksp/pc/impls/factor/factor.c
  14:31:08      info          UserInterface::writeHeader()                             peano - release T2
  14:31:08      info          UserInterface::writeHeader()                             2d, loaded components: stacks geometry plotter trivialgrid fluid fluid-scenario grid petsc ode
  14:31:08      info          UserInterface::writeHeader()                             opts:       
  14:31:08      info          UserInterface::writeHeader()                             grid-opts: d-loop persistent-attr packed 
  14:31:08      info          UserInterface::writeHeader()                             $Revision: 1.88 $
  14:31:08      info          UserInterface::writeHeader()                             2005 - 2008 Tobias Neckel, Tobias Weinzierl, TUM, Informatik V

test testTrivialgrid3x3ComputeNavierStokesFunction
  14:31:08      info          peano::fluid::AbstractCalculateF::AbstractCalculateF()       using gravity with values: 0, 0
  14:31:08      info          peano::trivialgrid::TrivialgridDataContainer::allocateMemory()      allocate grid with 16 vertex dofs and 9 cell dofs
  14:31:08      info          peano::trivialgrid::Trivialgrid::Trivialgrid(...)            Trivialgrid(): number of grid points: 4, 4, domain size: 1, 1, domain offset: 0, 0
  14:31:08      info          peano::fluid::TrivialgridFluidRunner::createJacobianAdapterAndTrivialgrid()      creating Jacobian instances for assembling type: FINITEDIFF (matrix-free=0)
  14:31:08      info          peano::fluid::FluidSimulation::runFluidSimulation()          preparing the grid
  14:31:08      info          peano::fluid::TrivialgridFluidSimulation::parseGeometry()      starting geometry parsing
  14:31:08      info          peano::fluid::FluidSimulation::runFluidSimulation()          counting the inner cells and setting boundary conditions
  14:31:08      info          peano::fluid::TrivialgridFluidSimulation::updateGrid         updating grid...
  14:31:08      info          peano::fluid::FluidSimulation::implementSetInitialValue()      assembling the matrix
  14:31:08      info          peano::fluid::TrivialgridFluidSimulation::createPETScSolver()      PETSc KSP Object info: , type: cg, maximum iterations=10000, rtol=1e-07, atol=1e-07, divtol=10000, left precond.; PETSc PC Object info: , type: jacobi, 
  14:31:08      info          peano::fluid::TrivialgridFluidSimulation::assembleMatrix()::Assemble Q iteration      total number of clock ticks within block (cpu-time,calendar-time): (0s,7.9155e-05s)
  14:31:08      info          peano::fluid::FluidSimulation::implementSetInitialValue()      memory consumption after matrix assemblation: 111 MB
  14:31:08      info          peano::fluid::FluidSimulation::implementSetInitialValue()      global time for matrix assemblation:
  14:31:08      info          FluidSimulation::implementSetInitialValue()                  total number of clock ticks within block (cpu-time,calendar-time): (0s,0.00111055s)
  14:31:08      info          UserInterface::writeFluidTimeStepInfoHeader()                || time step || T_sim total   || norm(du/u)_2h || norm(du/u)_max|| norm(du)_2h   || norm(du)_max  || norm(dp/p)_2h || norm(dp/p)_max|| norm(dp)_2h   || norm(dp)_max  || resdiuum      || depth || \#cells || \#dofNodes || cpu sec./step || \#its/LGS-sol.  || cpu sec./LGS-sol. || mem usage MB || f_glob on nr. 4
  14:31:08      info          peano::fluid::NonLinearTrivialgridFluidSimulation::implementSetInitialValue()      starting pseudo-timestepping with 1 steps and specified step size=0.001
  14:31:08      warning       petscError::logPETScError                                    Attention: no PetscErrorBaseMessage imitated!
[0]PETSC ERROR: --------------------- Error Message ------------------------------------
[0]PETSC ERROR: Null argument, when expecting valid pointer!
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: Petsc Release Version 3.2.0, Patch 7, Thu Mar 15 09:30:51 CDT 2012 
[0]PETSC ERROR: See docs/changes/index.html for recent updates.
[0]PETSC ERROR: See docs/faq.html for hints about trouble shooting.
[0]PETSC ERROR: See docs/index.html for manual pages.
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: ./build/debug/dim2/fluid/peano-fluid on a petsc-3.2 named atsccs58 by liebm Thu May 31 14:31:08 2012
[0]PETSC ERROR: Libraries linked from /work_fast/liebm/petsc-3.2-serial-debug/lib
[0]PETSC ERROR: Configure run at Thu May 31 10:27:55 2012
[0]PETSC ERROR: Configure options --PETSC_ARCH=petsc-3.2-serial-debug --prefix=/work_fast/liebm/petsc-3.2-serial-debug --with-debugging=1 --with-cxx=gcc --with-fc=gfortran --with-cc=gcc --download-superlu=1 --with-mpi=0
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: peano::petsc::PETScNonLinearSolver::setupLinearSolver() line 365 in petscpetsc/PETScNonLinearSolver.cpp
  14:31:08      error         petscError::logPetscTraceBackErrorHandler                    Major PETSc error occured in function peano::petsc::PETScNonLinearSolver::setupLinearSolver, line 365, dir. petsc, file petsc/PETScNonLinearSolver.cpp.

  14:31:08      warning       petscError::logPetscTraceBackErrorHandler                    Implementation not yet completed
  14:31:08      warning       petscError::logPETScError                                    PetscErrorCode is: 85
  14:31:08      warning       petscError::logPETScError                                    Attention: no MPI abort for main or unknown function imitated!
[0]PETSC ERROR: --------------------- Error Message ------------------------------------
[0]PETSC ERROR: Operation done in wrong order!
[0]PETSC ERROR: Matrix not yet factored; call after KSPSetUp() or PCSetUp()!
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: Petsc Release Version 3.2.0, Patch 7, Thu Mar 15 09:30:51 CDT 2012 
[0]PETSC ERROR: See docs/changes/index.html for recent updates.
[0]PETSC ERROR: See docs/faq.html for hints about trouble shooting.
[0]PETSC ERROR: See docs/index.html for manual pages.
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: ./build/debug/dim2/fluid/peano-fluid on a petsc-3.2 named atsccs58 by liebm Thu May 31 14:31:08 2012
[0]PETSC ERROR: Libraries linked from /work_fast/liebm/petsc-3.2-serial-debug/lib
[0]PETSC ERROR: Configure run at Thu May 31 10:27:55 2012
[0]PETSC ERROR: Configure options --PETSC_ARCH=petsc-3.2-serial-debug --prefix=/work_fast/liebm/petsc-3.2-serial-debug --with-debugging=1 --with-cxx=gcc --with-fc=gfortran --with-cc=gcc --download-superlu=1 --with-mpi=0
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: PCFactorGetMatrix_Factor() line 176 in /work_fast/liebm/petsc-3.2-p7/src/ksp/pc/impls/factor/factimpl.c
[0]PETSC ERROR: PCFactorGetMatrix() line 1220 in /work_fast/liebm/petsc-3.2-p7/src/ksp/pc/interface/precon.c
  14:31:08      warning       petscError::logPETScError                                    Attention: no PetscErrorBaseMessage imitated!
[0]PETSC ERROR: --------------------- Error Message ------------------------------------
[0]PETSC ERROR: Operation done in wrong order!
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: Petsc Release Version 3.2.0, Patch 7, Thu Mar 15 09:30:51 CDT 2012 
[0]PETSC ERROR: See docs/changes/index.html for recent updates.
[0]PETSC ERROR: See docs/faq.html for hints about trouble shooting.
[0]PETSC ERROR: See docs/index.html for manual pages.
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: ./build/debug/dim2/fluid/peano-fluid on a petsc-3.2 named atsccs58 by liebm Thu May 31 14:31:08 2012
[0]PETSC ERROR: Libraries linked from /work_fast/liebm/petsc-3.2-serial-debug/lib
[0]PETSC ERROR: Configure run at Thu May 31 10:27:55 2012
[0]PETSC ERROR: Configure options --PETSC_ARCH=petsc-3.2-serial-debug --prefix=/work_fast/liebm/petsc-3.2-serial-debug --with-debugging=1 --with-cxx=gcc --with-fc=gfortran --with-cc=gcc --download-superlu=1 --with-mpi=0
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: peano::petsc::PETScNonLinearSolver::setupLinearSolver() line 367 in petscpetsc/PETScNonLinearSolver.cpp
  14:31:08      error         petscError::logPetscTraceBackErrorHandler                    Major PETSc error occured in function peano::petsc::PETScNonLinearSolver::setupLinearSolver, line 367, dir. petsc, file petsc/PETScNonLinearSolver.cpp.

  14:31:08      warning       petscError::logPetscTraceBackErrorHandler                    Implementation not yet completed
  14:31:08      warning       petscError::logPETScError                                    PetscErrorCode is: 58
  14:31:08      warning       petscError::logPETScError                                    Attention: no MPI abort for main or unknown function imitated!
[0]PETSC ERROR: --------------------- Error Message ------------------------------------
[0]PETSC ERROR: Invalid argument!
[0]PETSC ERROR: Wrong type of object: Parameter # 1!
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: Petsc Release Version 3.2.0, Patch 7, Thu Mar 15 09:30:51 CDT 2012 
[0]PETSC ERROR: See docs/changes/index.html for recent updates.
[0]PETSC ERROR: See docs/faq.html for hints about trouble shooting.
[0]PETSC ERROR: See docs/index.html for manual pages.
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: ./build/debug/dim2/fluid/peano-fluid on a petsc-3.2 named atsccs58 by liebm Thu May 31 14:31:08 2012
[0]PETSC ERROR: Libraries linked from /work_fast/liebm/petsc-3.2-serial-debug/lib
[0]PETSC ERROR: Configure run at Thu May 31 10:27:55 2012
[0]PETSC ERROR: Configure options --PETSC_ARCH=petsc-3.2-serial-debug --prefix=/work_fast/liebm/petsc-3.2-serial-debug --with-debugging=1 --with-cxx=gcc --with-fc=gfortran --with-cc=gcc --download-superlu=1 --with-mpi=0
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: MatSuperluSetILUDropTol() line 455 in /work_fast/liebm/petsc-3.2-p7/src/mat/impls/aij/seq/superlu/superlu.c
  14:31:08      warning       petscError::logPETScError                                    Attention: no PetscErrorBaseMessage imitated!
[0]PETSC ERROR: --------------------- Error Message ------------------------------------
[0]PETSC ERROR: Invalid argument!
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: Petsc Release Version 3.2.0, Patch 7, Thu Mar 15 09:30:51 CDT 2012 
[0]PETSC ERROR: See docs/changes/index.html for recent updates.
[0]PETSC ERROR: See docs/faq.html for hints about trouble shooting.
[0]PETSC ERROR: See docs/index.html for manual pages.
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: ./build/debug/dim2/fluid/peano-fluid on a petsc-3.2 named atsccs58 by liebm Thu May 31 14:31:08 2012
[0]PETSC ERROR: Libraries linked from /work_fast/liebm/petsc-3.2-serial-debug/lib
[0]PETSC ERROR: Configure run at Thu May 31 10:27:55 2012
[0]PETSC ERROR: Configure options --PETSC_ARCH=petsc-3.2-serial-debug --prefix=/work_fast/liebm/petsc-3.2-serial-debug --with-debugging=1 --with-cxx=gcc --with-fc=gfortran --with-cc=gcc --download-superlu=1 --with-mpi=0
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: peano::petsc::PETScNonLinearSolver::setupLinearSolver() line 369 in petscpetsc/PETScNonLinearSolver.cpp
  14:31:08      error         petscError::logPetscTraceBackErrorHandler                    Major PETSc error occured in function peano::petsc::PETScNonLinearSolver::setupLinearSolver, line 369, dir. petsc, file petsc/PETScNonLinearSolver.cpp.

  14:31:08      warning       petscError::logPetscTraceBackErrorHandler                    Implementation not yet completed
  14:31:08      warning       petscError::logPETScError                                    PetscErrorCode is: 62
  14:31:08      warning       petscError::logPETScError                                    Attention: no MPI abort for main or unknown function imitated!
  14:31:08      info          peano::fluid::NonLinearTrivialgridFluidSimulation::computeNavierStokesFunction()      runtime for B-evaluation: 0 (CPU time), 0.000112295 (calendar time)

test testTrivialgrid3x3FreeChannelTwoPreSteps(JACOBIAN_ASSEMBLING_ANALYTICAL)
  14:31:08      info          peano::fluid::SteadyStateIntegrationTestChannel::testTrivialgrid3x3FreeChannelTwoPreSteps(ANALYTICAL)      running test case
  14:31:08      info          peano::fluid::AbstractCalculateF::AbstractCalculateF()       using gravity with values: 0, 0
  14:31:08      info          peano::trivialgrid::TrivialgridDataContainer::allocateMemory()      allocate grid with 16 vertex dofs and 9 cell dofs
  14:31:08      info          peano::trivialgrid::Trivialgrid::Trivialgrid(...)            Trivialgrid(): number of grid points: 4, 4, domain size: 1, 1, domain offset: 0, 0
  14:31:08      info          peano::fluid::TrivialgridFluidRunner::createJacobianAdapterAndTrivialgrid()      creating Jacobian instances for assembling type: FINITEDIFF (matrix-free=0)
  14:31:08      warning       peano::ode::ODESolver::checkSettings()                       no restart writing in use!
[0]PETSC ERROR: --------------------- Error Message ------------------------------------
[0]PETSC ERROR: Null argument, when expecting valid pointer!
[0]PETSC ERROR: Null Object: Parameter # 1!
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: Petsc Release Version 3.2.0, Patch 7, Thu Mar 15 09:30:51 CDT 2012 
[0]PETSC ERROR: See docs/changes/index.html for recent updates.
[0]PETSC ERROR: See docs/faq.html for hints about trouble shooting.
[0]PETSC ERROR: See docs/index.html for manual pages.
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: ./build/debug/dim2/fluid/peano-fluid on a petsc-3.2 named atsccs58 by liebm Thu May 31 14:31:08 2012
[0]PETSC ERROR: Libraries linked from /work_fast/liebm/petsc-3.2-serial-debug/lib
[0]PETSC ERROR: Configure run at Thu May 31 10:27:55 2012
[0]PETSC ERROR: Configure options --PETSC_ARCH=petsc-3.2-serial-debug --prefix=/work_fast/liebm/petsc-3.2-serial-debug --with-debugging=1 --with-cxx=gcc --with-fc=gfortran --with-cc=gcc --download-superlu=1 --with-mpi=0
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: MatGetFactor() line 3929 in /work_fast/liebm/petsc-3.2-p7/src/mat/interface/matrix.c
[0]PETSC ERROR: PCFactorSetUpMatSolverPackage_Factor() line 17 in /work_fast/liebm/petsc-3.2-p7/src/ksp/pc/impls/factor/factimpl.c
[0]PETSC ERROR: PCFactorSetUpMatSolverPackage() line 26 in /work_fast/liebm/petsc-3.2-p7/src/ksp/pc/impls/factor/factor.c
  14:31:08      info          peano::fluid::FluidSimulation::runFluidSimulation()          preparing the grid
  14:31:08      info          peano::fluid::TrivialgridFluidSimulation::parseGeometry()      starting geometry parsing
  14:31:08      info          peano::fluid::FluidSimulation::runFluidSimulation()          counting the inner cells and setting boundary conditions
  14:31:08      info          peano::fluid::TrivialgridFluidSimulation::updateGrid         updating grid...
  14:31:08      info          peano::fluid::FluidSimulation::implementSetInitialValue()      assembling the matrix
  14:31:08      info          peano::fluid::TrivialgridFluidSimulation::createPETScSolver()      PETSc KSP Object info: , type: cg, maximum iterations=10000, rtol=1e-07, atol=1e-07, divtol=10000, left precond.; PETSc PC Object info: , type: jacobi, 
  14:31:08      info          peano::fluid::TrivialgridFluidSimulation::assembleMatrix()::Assemble Q iteration      total number of clock ticks within block (cpu-time,calendar-time): (0s,6.98566e-05s)
  14:31:08      info          peano::fluid::FluidSimulation::implementSetInitialValue()      memory consumption after matrix assemblation: 111 MB
  14:31:08      info          peano::fluid::FluidSimulation::implementSetInitialValue()      global time for matrix assemblation:
  14:31:08      info          FluidSimulation::implementSetInitialValue()                  total number of clock ticks within block (cpu-time,calendar-time): (0s,0.000394344s)
  14:31:08      info          UserInterface::writeFluidTimeStepInfoHeader()                || time step || T_sim total   || norm(du/u)_2h || norm(du/u)_max|| norm(du)_2h   || norm(du)_max  || norm(dp/p)_2h || norm(dp/p)_max|| norm(dp)_2h   || norm(dp)_max  || resdiuum      || depth || \#cells || \#dofNodes || cpu sec./step || \#its/LGS-sol.  || cpu sec./LGS-sol. || mem usage MB || f_glob on nr. 4
  14:31:08      info          peano::fluid::NonLinearTrivialgridFluidSimulation::implementSetInitialValue()      starting pseudo-timestepping with 2 steps and specified step size=0.001
  14:31:08      warning       petscError::logPETScError                                    Attention: no PetscErrorBaseMessage imitated!
[0]PETSC ERROR: --------------------- Error Message ------------------------------------
[0]PETSC ERROR: Null argument, when expecting valid pointer!
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: Petsc Release Version 3.2.0, Patch 7, Thu Mar 15 09:30:51 CDT 2012 
[0]PETSC ERROR: See docs/changes/index.html for recent updates.
[0]PETSC ERROR: See docs/faq.html for hints about trouble shooting.
[0]PETSC ERROR: See docs/index.html for manual pages.
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: ./build/debug/dim2/fluid/peano-fluid on a petsc-3.2 named atsccs58 by liebm Thu May 31 14:31:08 2012
[0]PETSC ERROR: Libraries linked from /work_fast/liebm/petsc-3.2-serial-debug/lib
[0]PETSC ERROR: Configure run at Thu May 31 10:27:55 2012
[0]PETSC ERROR: Configure options --PETSC_ARCH=petsc-3.2-serial-debug --prefix=/work_fast/liebm/petsc-3.2-serial-debug --with-debugging=1 --with-cxx=gcc --with-fc=gfortran --with-cc=gcc --download-superlu=1 --with-mpi=0
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: peano::petsc::PETScNonLinearSolver::setupLinearSolver() line 365 in petscpetsc/PETScNonLinearSolver.cpp
  14:31:08      error         petscError::logPetscTraceBackErrorHandler                    Major PETSc error occured in function peano::petsc::PETScNonLinearSolver::setupLinearSolver, line 365, dir. petsc, file petsc/PETScNonLinearSolver.cpp.

  14:31:08      warning       petscError::logPetscTraceBackErrorHandler                    Implementation not yet completed
  14:31:08      warning       petscError::logPETScError                                    PetscErrorCode is: 85
  14:31:08      warning       petscError::logPETScError                                    Attention: no MPI abort for main or unknown function imitated!
[0]PETSC ERROR: --------------------- Error Message ------------------------------------
[0]PETSC ERROR: Operation done in wrong order!
[0]PETSC ERROR: Matrix not yet factored; call after KSPSetUp() or PCSetUp()!
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: Petsc Release Version 3.2.0, Patch 7, Thu Mar 15 09:30:51 CDT 2012 
[0]PETSC ERROR: See docs/changes/index.html for recent updates.
[0]PETSC ERROR: See docs/faq.html for hints about trouble shooting.
[0]PETSC ERROR: See docs/index.html for manual pages.
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: ./build/debug/dim2/fluid/peano-fluid on a petsc-3.2 named atsccs58 by liebm Thu May 31 14:31:08 2012
[0]PETSC ERROR: Libraries linked from /work_fast/liebm/petsc-3.2-serial-debug/lib
[0]PETSC ERROR: Configure run at Thu May 31 10:27:55 2012
[0]PETSC ERROR: Configure options --PETSC_ARCH=petsc-3.2-serial-debug --prefix=/work_fast/liebm/petsc-3.2-serial-debug --with-debugging=1 --with-cxx=gcc --with-fc=gfortran --with-cc=gcc --download-superlu=1 --with-mpi=0
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: PCFactorGetMatrix_Factor() line 176 in /work_fast/liebm/petsc-3.2-p7/src/ksp/pc/impls/factor/factimpl.c
[0]PETSC ERROR: PCFactorGetMatrix() line 1220 in /work_fast/liebm/petsc-3.2-p7/src/ksp/pc/interface/precon.c
  14:31:08      warning       petscError::logPETScError                                    Attention: no PetscErrorBaseMessage imitated!
[0]PETSC ERROR: --------------------- Error Message ------------------------------------
[0]PETSC ERROR: Operation done in wrong order!
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: Petsc Release Version 3.2.0, Patch 7, Thu Mar 15 09:30:51 CDT 2012 
[0]PETSC ERROR: See docs/changes/index.html for recent updates.
[0]PETSC ERROR: See docs/faq.html for hints about trouble shooting.
[0]PETSC ERROR: See docs/index.html for manual pages.
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: ./build/debug/dim2/fluid/peano-fluid on a petsc-3.2 named atsccs58 by liebm Thu May 31 14:31:08 2012
[0]PETSC ERROR: Libraries linked from /work_fast/liebm/petsc-3.2-serial-debug/lib
[0]PETSC ERROR: Configure run at Thu May 31 10:27:55 2012
[0]PETSC ERROR: Configure options --PETSC_ARCH=petsc-3.2-serial-debug --prefix=/work_fast/liebm/petsc-3.2-serial-debug --with-debugging=1 --with-cxx=gcc --with-fc=gfortran --with-cc=gcc --download-superlu=1 --with-mpi=0
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: peano::petsc::PETScNonLinearSolver::setupLinearSolver() line 367 in petscpetsc/PETScNonLinearSolver.cpp
  14:31:08      error         petscError::logPetscTraceBackErrorHandler                    Major PETSc error occured in function peano::petsc::PETScNonLinearSolver::setupLinearSolver, line 367, dir. petsc, file petsc/PETScNonLinearSolver.cpp.

  14:31:08      warning       petscError::logPetscTraceBackErrorHandler                    Implementation not yet completed
  14:31:08      warning       petscError::logPETScError                                    PetscErrorCode is: 58
  14:31:08      warning       petscError::logPETScError                                    Attention: no MPI abort for main or unknown function imitated!
[0]PETSC ERROR: --------------------- Error Message ------------------------------------
[0]PETSC ERROR: Invalid argument!
[0]PETSC ERROR: Wrong type of object: Parameter # 1!
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: Petsc Release Version 3.2.0, Patch 7, Thu Mar 15 09:30:51 CDT 2012 
[0]PETSC ERROR: See docs/changes/index.html for recent updates.
[0]PETSC ERROR: See docs/faq.html for hints about trouble shooting.
[0]PETSC ERROR: See docs/index.html for manual pages.
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: ./build/debug/dim2/fluid/peano-fluid on a petsc-3.2 named atsccs58 by liebm Thu May 31 14:31:08 2012
[0]PETSC ERROR: Libraries linked from /work_fast/liebm/petsc-3.2-serial-debug/lib
[0]PETSC ERROR: Configure run at Thu May 31 10:27:55 2012
[0]PETSC ERROR: Configure options --PETSC_ARCH=petsc-3.2-serial-debug --prefix=/work_fast/liebm/petsc-3.2-serial-debug --with-debugging=1 --with-cxx=gcc --with-fc=gfortran --with-cc=gcc --download-superlu=1 --with-mpi=0
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: MatSuperluSetILUDropTol() line 455 in /work_fast/liebm/petsc-3.2-p7/src/mat/impls/aij/seq/superlu/superlu.c
  14:31:08      warning       petscError::logPETScError                                    Attention: no PetscErrorBaseMessage imitated!
[0]PETSC ERROR: --------------------- Error Message ------------------------------------
[0]PETSC ERROR: Invalid argument!
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: Petsc Release Version 3.2.0, Patch 7, Thu Mar 15 09:30:51 CDT 2012 
[0]PETSC ERROR: See docs/changes/index.html for recent updates.
[0]PETSC ERROR: See docs/faq.html for hints about trouble shooting.
[0]PETSC ERROR: See docs/index.html for manual pages.
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: ./build/debug/dim2/fluid/peano-fluid on a petsc-3.2 named atsccs58 by liebm Thu May 31 14:31:08 2012
[0]PETSC ERROR: Libraries linked from /work_fast/liebm/petsc-3.2-serial-debug/lib
[0]PETSC ERROR: Configure run at Thu May 31 10:27:55 2012
[0]PETSC ERROR: Configure options --PETSC_ARCH=petsc-3.2-serial-debug --prefix=/work_fast/liebm/petsc-3.2-serial-debug --with-debugging=1 --with-cxx=gcc --with-fc=gfortran --with-cc=gcc --download-superlu=1 --with-mpi=0
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: peano::petsc::PETScNonLinearSolver::setupLinearSolver() line 369 in petscpetsc/PETScNonLinearSolver.cpp
  14:31:08      error         petscError::logPetscTraceBackErrorHandler                    Major PETSc error occured in function peano::petsc::PETScNonLinearSolver::setupLinearSolver, line 369, dir. petsc, file petsc/PETScNonLinearSolver.cpp.

  14:31:08      warning       petscError::logPetscTraceBackErrorHandler                    Implementation not yet completed
  14:31:08      warning       petscError::logPETScError                                    PetscErrorCode is: 62
  14:31:08      warning       petscError::logPETScError                                    Attention: no MPI abort for main or unknown function imitated!
  14:31:08      info          peano::ode::ODESolver::solve()                               starting time integration. StartTime=0, endTime=1, startTimeStepNr=1, endTimeStepNr=1
  14:31:08      info          peano::fluid::NonLinearTrivialgridFluidSimulation::computeNavierStokesFunction()      runtime for B-evaluation: 0 (CPU time), 0.000110388 (calendar time)
  14:31:08      info          peano::petsc::PETScNonLinearEquations::monitorNonLinearSolver()      residual norm at iteration 0: 6.97099e-14; LinearIterations: 0
  14:31:08      info          peano::petsc::PETScNonLinearEquations::jacobianGrid()        iteration started.
  14:31:08      info          peano::fluid::NonLinearTrivialgridFluidSimulation::computeNavierStokesJacobian()      runtime for Jacobian: 0 (CPU time), 0.00081563 (calendar time)
  14:31:08      info          peano::fluid::NonLinearTrivialgridFluidSimulation::computeNavierStokesFunction()      runtime for B-evaluation: 0 (CPU time), 0.000109434 (calendar time)
  14:31:08      info          peano::petsc::PETScNonLinearEquations::monitorNonLinearSolver()      residual norm at iteration 1: 6.49184e-16; LinearIterations: 1
  14:31:08      info          peano::petsc::PETScNonLinearSolver::solve()                  NLGS solver completed in 1 iterations; conv. reason=4
  14:31:08      info          peano::petsc::PETScNonLinearSolver::solve()                  NLGS solver converged!
  14:31:08      info          peano::fluid::FluidSimulation::solveNonLinearSystem()        non-linear solution completed with iterations:1
  14:31:08      info          UserInterface::writeFluidTimeStepInfo(...)                   |    1       |    1.00000e-03  |   -nan  |   -nan  |   0.00000e+00  |   0.00000e+00  |   -nan  |   -nan  |   0.00000e+00  |   0.00000e+00  |   1.01140e-13  |   -1    |   9   |   6     |  1.00000e-02     |  3     |  0.00000e+00     |  112  |   0.00000e+00, 0.00000e+00, 
  14:31:08      info          peano::fluid::SteadyStateIntegrationTestChannel::testTrivialgrid3x3FreeChannelTwoPreSteps()      testTrivialgrid3x3FreeChannelTwoPreSteps(ANALYTICAL) OK

test testTrivialgrid3x3FreeChannelTwoPreSteps(JACOBIAN_ASSEMBLING_FINITEDIFF)
  14:31:08      info          peano::fluid::SteadyStateIntegrationTestChannel::testTrivialgrid3x3FreeChannelTwoPreSteps(FINITEDIFF)      running test case
  14:31:08      info          peano::fluid::AbstractCalculateF::AbstractCalculateF()       using gravity with values: 0, 0
  14:31:08      info          peano::trivialgrid::TrivialgridDataContainer::allocateMemory()      allocate grid with 16 vertex dofs and 9 cell dofs
  14:31:08      info          peano::trivialgrid::Trivialgrid::Trivialgrid(...)            Trivialgrid(): number of grid points: 4, 4, domain size: 1, 1, domain offset: 0, 0
  14:31:08      info          peano::fluid::TrivialgridFluidRunner::createJacobianAdapterAndTrivialgrid()      creating Jacobian instances for assembling type: FINITEDIFF (matrix-free=0)
  14:31:08      warning       peano::ode::ODESolver::checkSettings()                       no restart writing in use!
[0]PETSC ERROR: --------------------- Error Message ------------------------------------
[0]PETSC ERROR: Null argument, when expecting valid pointer!
[0]PETSC ERROR: Null Object: Parameter # 1!
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: Petsc Release Version 3.2.0, Patch 7, Thu Mar 15 09:30:51 CDT 2012 
[0]PETSC ERROR: See docs/changes/index.html for recent updates.
[0]PETSC ERROR: See docs/faq.html for hints about trouble shooting.
[0]PETSC ERROR: See docs/index.html for manual pages.
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: ./build/debug/dim2/fluid/peano-fluid on a petsc-3.2 named atsccs58 by liebm Thu May 31 14:31:08 2012
[0]PETSC ERROR: Libraries linked from /work_fast/liebm/petsc-3.2-serial-debug/lib
[0]PETSC ERROR: Configure run at Thu May 31 10:27:55 2012
[0]PETSC ERROR: Configure options --PETSC_ARCH=petsc-3.2-serial-debug --prefix=/work_fast/liebm/petsc-3.2-serial-debug --with-debugging=1 --with-cxx=gcc --with-fc=gfortran --with-cc=gcc --download-superlu=1 --with-mpi=0
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: MatGetFactor() line 3929 in /work_fast/liebm/petsc-3.2-p7/src/mat/interface/matrix.c
[0]PETSC ERROR: PCFactorSetUpMatSolverPackage_Factor() line 17 in /work_fast/liebm/petsc-3.2-p7/src/ksp/pc/impls/factor/factimpl.c
[0]PETSC ERROR: PCFactorSetUpMatSolverPackage() line 26 in /work_fast/liebm/petsc-3.2-p7/src/ksp/pc/impls/factor/factor.c
  14:31:08      info          peano::fluid::FluidSimulation::runFluidSimulation()          preparing the grid
  14:31:08      info          peano::fluid::TrivialgridFluidSimulation::parseGeometry()      starting geometry parsing
  14:31:08      info          peano::fluid::FluidSimulation::runFluidSimulation()          counting the inner cells and setting boundary conditions
  14:31:08      info          peano::fluid::TrivialgridFluidSimulation::updateGrid         updating grid...
  14:31:08      info          peano::fluid::FluidSimulation::implementSetInitialValue()      assembling the matrix
  14:31:08      info          peano::fluid::TrivialgridFluidSimulation::createPETScSolver()      PETSc KSP Object info: , type: cg, maximum iterations=10000, rtol=1e-07, atol=1e-07, divtol=10000, left precond.; PETSc PC Object info: , type: jacobi, 
  14:31:08      info          peano::fluid::TrivialgridFluidSimulation::assembleMatrix()::Assemble Q iteration      total number of clock ticks within block (cpu-time,calendar-time): (0s,7.20024e-05s)
  14:31:08      info          peano::fluid::FluidSimulation::implementSetInitialValue()      memory consumption after matrix assemblation: 112 MB
  14:31:08      info          peano::fluid::FluidSimulation::implementSetInitialValue()      global time for matrix assemblation:
  14:31:08      info          FluidSimulation::implementSetInitialValue()                  total number of clock ticks within block (cpu-time,calendar-time): (0s,0.000437021s)
  14:31:08      info          UserInterface::writeFluidTimeStepInfoHeader()                || time step || T_sim total   || norm(du/u)_2h || norm(du/u)_max|| norm(du)_2h   || norm(du)_max  || norm(dp/p)_2h || norm(dp/p)_max|| norm(dp)_2h   || norm(dp)_max  || resdiuum      || depth || \#cells || \#dofNodes || cpu sec./step || \#its/LGS-sol.  || cpu sec./LGS-sol. || mem usage MB || f_glob on nr. 4
  14:31:08      info          peano::fluid::NonLinearTrivialgridFluidSimulation::implementSetInitialValue()      starting pseudo-timestepping with 2 steps and specified step size=0.001
  14:31:08      warning       petscError::logPETScError                                    Attention: no PetscErrorBaseMessage imitated!
[0]PETSC ERROR: --------------------- Error Message ------------------------------------
[0]PETSC ERROR: Null argument, when expecting valid pointer!
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: Petsc Release Version 3.2.0, Patch 7, Thu Mar 15 09:30:51 CDT 2012 
[0]PETSC ERROR: See docs/changes/index.html for recent updates.
[0]PETSC ERROR: See docs/faq.html for hints about trouble shooting.
[0]PETSC ERROR: See docs/index.html for manual pages.
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: ./build/debug/dim2/fluid/peano-fluid on a petsc-3.2 named atsccs58 by liebm Thu May 31 14:31:08 2012
[0]PETSC ERROR: Libraries linked from /work_fast/liebm/petsc-3.2-serial-debug/lib
[0]PETSC ERROR: Configure run at Thu May 31 10:27:55 2012
[0]PETSC ERROR: Configure options --PETSC_ARCH=petsc-3.2-serial-debug --prefix=/work_fast/liebm/petsc-3.2-serial-debug --with-debugging=1 --with-cxx=gcc --with-fc=gfortran --with-cc=gcc --download-superlu=1 --with-mpi=0
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: peano::petsc::PETScNonLinearSolver::setupLinearSolver() line 365 in petscpetsc/PETScNonLinearSolver.cpp
  14:31:08      error         petscError::logPetscTraceBackErrorHandler                    Major PETSc error occured in function peano::petsc::PETScNonLinearSolver::setupLinearSolver, line 365, dir. petsc, file petsc/PETScNonLinearSolver.cpp.

  14:31:08      warning       petscError::logPetscTraceBackErrorHandler                    Implementation not yet completed
  14:31:08      warning       petscError::logPETScError                                    PetscErrorCode is: 85
  14:31:08      warning       petscError::logPETScError                                    Attention: no MPI abort for main or unknown function imitated!
[0]PETSC ERROR: --------------------- Error Message ------------------------------------
[0]PETSC ERROR: Operation done in wrong order!
[0]PETSC ERROR: Matrix not yet factored; call after KSPSetUp() or PCSetUp()!
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: Petsc Release Version 3.2.0, Patch 7, Thu Mar 15 09:30:51 CDT 2012 
[0]PETSC ERROR: See docs/changes/index.html for recent updates.
[0]PETSC ERROR: See docs/faq.html for hints about trouble shooting.
[0]PETSC ERROR: See docs/index.html for manual pages.
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: ./build/debug/dim2/fluid/peano-fluid on a petsc-3.2 named atsccs58 by liebm Thu May 31 14:31:08 2012
[0]PETSC ERROR: Libraries linked from /work_fast/liebm/petsc-3.2-serial-debug/lib
[0]PETSC ERROR: Configure run at Thu May 31 10:27:55 2012
[0]PETSC ERROR: Configure options --PETSC_ARCH=petsc-3.2-serial-debug --prefix=/work_fast/liebm/petsc-3.2-serial-debug --with-debugging=1 --with-cxx=gcc --with-fc=gfortran --with-cc=gcc --download-superlu=1 --with-mpi=0
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: PCFactorGetMatrix_Factor() line 176 in /work_fast/liebm/petsc-3.2-p7/src/ksp/pc/impls/factor/factimpl.c
[0]PETSC ERROR: PCFactorGetMatrix() line 1220 in /work_fast/liebm/petsc-3.2-p7/src/ksp/pc/interface/precon.c
  14:31:08      warning       petscError::logPETScError                                    Attention: no PetscErrorBaseMessage imitated!
[0]PETSC ERROR: --------------------- Error Message ------------------------------------
[0]PETSC ERROR: Operation done in wrong order!
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: Petsc Release Version 3.2.0, Patch 7, Thu Mar 15 09:30:51 CDT 2012 
[0]PETSC ERROR: See docs/changes/index.html for recent updates.
[0]PETSC ERROR: See docs/faq.html for hints about trouble shooting.
[0]PETSC ERROR: See docs/index.html for manual pages.
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: ./build/debug/dim2/fluid/peano-fluid on a petsc-3.2 named atsccs58 by liebm Thu May 31 14:31:08 2012
[0]PETSC ERROR: Libraries linked from /work_fast/liebm/petsc-3.2-serial-debug/lib
[0]PETSC ERROR: Configure run at Thu May 31 10:27:55 2012
[0]PETSC ERROR: Configure options --PETSC_ARCH=petsc-3.2-serial-debug --prefix=/work_fast/liebm/petsc-3.2-serial-debug --with-debugging=1 --with-cxx=gcc --with-fc=gfortran --with-cc=gcc --download-superlu=1 --with-mpi=0
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: peano::petsc::PETScNonLinearSolver::setupLinearSolver() line 367 in petscpetsc/PETScNonLinearSolver.cpp
  14:31:08      error         petscError::logPetscTraceBackErrorHandler                    Major PETSc error occured in function peano::petsc::PETScNonLinearSolver::setupLinearSolver, line 367, dir. petsc, file petsc/PETScNonLinearSolver.cpp.

  14:31:08      warning       petscError::logPetscTraceBackErrorHandler                    Implementation not yet completed
  14:31:08      warning       petscError::logPETScError                                    PetscErrorCode is: 58
  14:31:08      warning       petscError::logPETScError                                    Attention: no MPI abort for main or unknown function imitated!
[0]PETSC ERROR: --------------------- Error Message ------------------------------------
[0]PETSC ERROR: Invalid argument!
[0]PETSC ERROR: Wrong type of object: Parameter # 1!
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: Petsc Release Version 3.2.0, Patch 7, Thu Mar 15 09:30:51 CDT 2012 
[0]PETSC ERROR: See docs/changes/index.html for recent updates.
[0]PETSC ERROR: See docs/faq.html for hints about trouble shooting.
[0]PETSC ERROR: See docs/index.html for manual pages.
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: ./build/debug/dim2/fluid/peano-fluid on a petsc-3.2 named atsccs58 by liebm Thu May 31 14:31:08 2012
[0]PETSC ERROR: Libraries linked from /work_fast/liebm/petsc-3.2-serial-debug/lib
[0]PETSC ERROR: Configure run at Thu May 31 10:27:55 2012
[0]PETSC ERROR: Configure options --PETSC_ARCH=petsc-3.2-serial-debug --prefix=/work_fast/liebm/petsc-3.2-serial-debug --with-debugging=1 --with-cxx=gcc --with-fc=gfortran --with-cc=gcc --download-superlu=1 --with-mpi=0
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: MatSuperluSetILUDropTol() line 455 in /work_fast/liebm/petsc-3.2-p7/src/mat/impls/aij/seq/superlu/superlu.c
  14:31:08      warning       petscError::logPETScError                                    Attention: no PetscErrorBaseMessage imitated!
[0]PETSC ERROR: --------------------- Error Message ------------------------------------
[0]PETSC ERROR: Invalid argument!
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: Petsc Release Version 3.2.0, Patch 7, Thu Mar 15 09:30:51 CDT 2012 
[0]PETSC ERROR: See docs/changes/index.html for recent updates.
[0]PETSC ERROR: See docs/faq.html for hints about trouble shooting.
[0]PETSC ERROR: See docs/index.html for manual pages.
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: ./build/debug/dim2/fluid/peano-fluid on a petsc-3.2 named atsccs58 by liebm Thu May 31 14:31:08 2012
[0]PETSC ERROR: Libraries linked from /work_fast/liebm/petsc-3.2-serial-debug/lib
[0]PETSC ERROR: Configure run at Thu May 31 10:27:55 2012
[0]PETSC ERROR: Configure options --PETSC_ARCH=petsc-3.2-serial-debug --prefix=/work_fast/liebm/petsc-3.2-serial-debug --with-debugging=1 --with-cxx=gcc --with-fc=gfortran --with-cc=gcc --download-superlu=1 --with-mpi=0
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: peano::petsc::PETScNonLinearSolver::setupLinearSolver() line 369 in petscpetsc/PETScNonLinearSolver.cpp
  14:31:08      error         petscError::logPetscTraceBackErrorHandler                    Major PETSc error occured in function peano::petsc::PETScNonLinearSolver::setupLinearSolver, line 369, dir. petsc, file petsc/PETScNonLinearSolver.cpp.

  14:31:08      warning       petscError::logPetscTraceBackErrorHandler                    Implementation not yet completed
  14:31:08      warning       petscError::logPETScError                                    PetscErrorCode is: 62
  14:31:08      warning       petscError::logPETScError                                    Attention: no MPI abort for main or unknown function imitated!
  14:31:08      info          peano::ode::ODESolver::solve()                               starting time integration. StartTime=0, endTime=1, startTimeStepNr=1, endTimeStepNr=1
  14:31:08      info          peano::fluid::NonLinearTrivialgridFluidSimulation::computeNavierStokesFunction()      runtime for B-evaluation: 0 (CPU time), 0.000109673 (calendar time)
  14:31:08      info          peano::petsc::PETScNonLinearEquations::monitorNonLinearSolver()      residual norm at iteration 0: 6.97099e-14; LinearIterations: 0
  14:31:08      info          peano::petsc::PETScNonLinearEquations::jacobianGrid()        iteration started.
  14:31:08      info          peano::fluid::NonLinearTrivialgridFluidSimulation::computeNavierStokesJacobian()      runtime for Jacobian: 0 (CPU time), 0.000813007 (calendar time)
  14:31:08      info          peano::fluid::NonLinearTrivialgridFluidSimulation::computeNavierStokesFunction()      runtime for B-evaluation: 0 (CPU time), 0.000109196 (calendar time)
  14:31:08      info          peano::petsc::PETScNonLinearEquations::monitorNonLinearSolver()      residual norm at iteration 1: 6.49184e-16; LinearIterations: 1
  14:31:08      info          peano::petsc::PETScNonLinearSolver::solve()                  NLGS solver completed in 1 iterations; conv. reason=4
  14:31:08      info          peano::petsc::PETScNonLinearSolver::solve()                  NLGS solver converged!
  14:31:08      info          peano::fluid::FluidSimulation::solveNonLinearSystem()        non-linear solution completed with iterations:1
  14:31:08      info          UserInterface::writeFluidTimeStepInfo(...)                   |    1       |    1.00000e-03  |   -nan  |   -nan  |   0.00000e+00  |   0.00000e+00  |   -nan  |   -nan  |   0.00000e+00  |   0.00000e+00  |   1.01140e-13  |   -1    |   9   |   6     |  0.00000e+00     |  3     |  0.00000e+00     |  112  |   0.00000e+00, 0.00000e+00, 
  14:31:08      info          peano::fluid::SteadyStateIntegrationTestChannel::testTrivialgrid3x3FreeChannelTwoPreSteps()      testTrivialgrid3x3FreeChannelTwoPreSteps(FINITEDIFF) OK

test testTrivialgrid9x9ObstacleInChannelNoPreSteps(JACOBIAN_ASSEMBLING_ANALYTICAL)
  14:31:08      info          peano::fluid::SteadyStateIntegrationTestChannel::testTrivialgrid9x9ObstacleInChannelNoPreSteps(ANALYTICAL)      running test case
  14:31:08      info          peano::fluid::AbstractCalculateF::AbstractCalculateF()       using gravity with values: 0, 0
  14:31:08      info          peano::trivialgrid::TrivialgridDataContainer::allocateMemory()      allocate grid with 100 vertex dofs and 81 cell dofs
  14:31:08      info          peano::trivialgrid::Trivialgrid::Trivialgrid(...)            Trivialgrid(): number of grid points: 10, 10, domain size: 1, 1, domain offset: 0, 0
  14:31:08      info          peano::fluid::TrivialgridFluidRunner::createJacobianAdapterAndTrivialgrid()      creating Jacobian instances for assembling type: ANALYTICAL (matrix-free=0)
  14:31:08      warning       peano::ode::ODESolver::checkSettings()                       no restart writing in use!
[0]PETSC ERROR: --------------------- Error Message ------------------------------------
[0]PETSC ERROR: Null argument, when expecting valid pointer!
[0]PETSC ERROR: Null Object: Parameter # 1!
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: Petsc Release Version 3.2.0, Patch 7, Thu Mar 15 09:30:51 CDT 2012 
[0]PETSC ERROR: See docs/changes/index.html for recent updates.
[0]PETSC ERROR: See docs/faq.html for hints about trouble shooting.
[0]PETSC ERROR: See docs/index.html for manual pages.
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: ./build/debug/dim2/fluid/peano-fluid on a petsc-3.2 named atsccs58 by liebm Thu May 31 14:31:08 2012
[0]PETSC ERROR: Libraries linked from /work_fast/liebm/petsc-3.2-serial-debug/lib
[0]PETSC ERROR: Configure run at Thu May 31 10:27:55 2012
[0]PETSC ERROR: Configure options --PETSC_ARCH=petsc-3.2-serial-debug --prefix=/work_fast/liebm/petsc-3.2-serial-debug --with-debugging=1 --with-cxx=gcc --with-fc=gfortran --with-cc=gcc --download-superlu=1 --with-mpi=0
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: MatGetFactor() line 3929 in /work_fast/liebm/petsc-3.2-p7/src/mat/interface/matrix.c
[0]PETSC ERROR: PCFactorSetUpMatSolverPackage_Factor() line 17 in /work_fast/liebm/petsc-3.2-p7/src/ksp/pc/impls/factor/factimpl.c
[0]PETSC ERROR: PCFactorSetUpMatSolverPackage() line 26 in /work_fast/liebm/petsc-3.2-p7/src/ksp/pc/impls/factor/factor.c
  14:31:08      info          peano::fluid::FluidSimulation::runFluidSimulation()          preparing the grid
  14:31:08      info          peano::fluid::TrivialgridFluidSimulation::parseGeometry()      starting geometry parsing
  14:31:08      info          peano::fluid::FluidSimulation::runFluidSimulation()          counting the inner cells and setting boundary conditions
  14:31:08      info          peano::fluid::TrivialgridFluidSimulation::updateGrid         updating grid...
  14:31:08      info          peano::fluid::FluidSimulation::implementSetInitialValue()      assembling the matrix
  14:31:08      info          peano::fluid::TrivialgridFluidSimulation::createPETScSolver()      PETSc KSP Object info: , type: cg, maximum iterations=10000, rtol=1e-07, atol=1e-07, divtol=10000, left precond.; PETSc PC Object info: , type: jacobi, 
  14:31:08      info          peano::fluid::TrivialgridFluidSimulation::assembleMatrix()::Assemble Q iteration      total number of clock ticks within block (cpu-time,calendar-time): (0s,0.000596762s)
  14:31:08      info          peano::fluid::FluidSimulation::implementSetInitialValue()      memory consumption after matrix assemblation: 112 MB
  14:31:08      info          peano::fluid::FluidSimulation::implementSetInitialValue()      global time for matrix assemblation:
  14:31:08      info          FluidSimulation::implementSetInitialValue()                  total number of clock ticks within block (cpu-time,calendar-time): (0s,0.000961542s)
  14:31:08      info          peano::fluid::TrivialgridEventHandle2VTKWriter4FluidAdapter::endIteration      
Accumulated and integrated outflow is: 0

  14:31:08      info          UserInterface::writeFluidTimeStepInfoHeader()                || time step || T_sim total   || norm(du/u)_2h || norm(du/u)_max|| norm(du)_2h   || norm(du)_max  || norm(dp/p)_2h || norm(dp/p)_max|| norm(dp)_2h   || norm(dp)_max  || resdiuum      || depth || \#cells || \#dofNodes || cpu sec./step || \#its/LGS-sol.  || cpu sec./LGS-sol. || mem usage MB || f_glob on nr. 4
  14:31:08      info          peano::fluid::NonLinearTrivialgridFluidSimulation::implementSetInitialValue()      starting pseudo-timestepping with 0 steps and specified step size=0.001
  14:31:08      warning       petscError::logPETScError                                    Attention: no PetscErrorBaseMessage imitated!
[0]PETSC ERROR: --------------------- Error Message ------------------------------------
[0]PETSC ERROR: Null argument, when expecting valid pointer!
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: Petsc Release Version 3.2.0, Patch 7, Thu Mar 15 09:30:51 CDT 2012 
[0]PETSC ERROR: See docs/changes/index.html for recent updates.
[0]PETSC ERROR: See docs/faq.html for hints about trouble shooting.
[0]PETSC ERROR: See docs/index.html for manual pages.
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: ./build/debug/dim2/fluid/peano-fluid on a petsc-3.2 named atsccs58 by liebm Thu May 31 14:31:08 2012
[0]PETSC ERROR: Libraries linked from /work_fast/liebm/petsc-3.2-serial-debug/lib
[0]PETSC ERROR: Configure run at Thu May 31 10:27:55 2012
[0]PETSC ERROR: Configure options --PETSC_ARCH=petsc-3.2-serial-debug --prefix=/work_fast/liebm/petsc-3.2-serial-debug --with-debugging=1 --with-cxx=gcc --with-fc=gfortran --with-cc=gcc --download-superlu=1 --with-mpi=0
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: peano::petsc::PETScNonLinearSolver::setupLinearSolver() line 365 in petscpetsc/PETScNonLinearSolver.cpp
  14:31:08      error         petscError::logPetscTraceBackErrorHandler                    Major PETSc error occured in function peano::petsc::PETScNonLinearSolver::setupLinearSolver, line 365, dir. petsc, file petsc/PETScNonLinearSolver.cpp.

  14:31:08      warning       petscError::logPetscTraceBackErrorHandler                    Implementation not yet completed
  14:31:08      warning       petscError::logPETScError                                    PetscErrorCode is: 85
  14:31:08      warning       petscError::logPETScError                                    Attention: no MPI abort for main or unknown function imitated!
[0]PETSC ERROR: --------------------- Error Message ------------------------------------
[0]PETSC ERROR: Operation done in wrong order!
[0]PETSC ERROR: Matrix not yet factored; call after KSPSetUp() or PCSetUp()!
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: Petsc Release Version 3.2.0, Patch 7, Thu Mar 15 09:30:51 CDT 2012 
[0]PETSC ERROR: See docs/changes/index.html for recent updates.
[0]PETSC ERROR: See docs/faq.html for hints about trouble shooting.
[0]PETSC ERROR: See docs/index.html for manual pages.
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: ./build/debug/dim2/fluid/peano-fluid on a petsc-3.2 named atsccs58 by liebm Thu May 31 14:31:08 2012
[0]PETSC ERROR: Libraries linked from /work_fast/liebm/petsc-3.2-serial-debug/lib
[0]PETSC ERROR: Configure run at Thu May 31 10:27:55 2012
[0]PETSC ERROR: Configure options --PETSC_ARCH=petsc-3.2-serial-debug --prefix=/work_fast/liebm/petsc-3.2-serial-debug --with-debugging=1 --with-cxx=gcc --with-fc=gfortran --with-cc=gcc --download-superlu=1 --with-mpi=0
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: PCFactorGetMatrix_Factor() line 176 in /work_fast/liebm/petsc-3.2-p7/src/ksp/pc/impls/factor/factimpl.c
[0]PETSC ERROR: PCFactorGetMatrix() line 1220 in /work_fast/liebm/petsc-3.2-p7/src/ksp/pc/interface/precon.c
  14:31:08      warning       petscError::logPETScError                                    Attention: no PetscErrorBaseMessage imitated!
[0]PETSC ERROR: --------------------- Error Message ------------------------------------
[0]PETSC ERROR: Operation done in wrong order!
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: Petsc Release Version 3.2.0, Patch 7, Thu Mar 15 09:30:51 CDT 2012 
[0]PETSC ERROR: See docs/changes/index.html for recent updates.
[0]PETSC ERROR: See docs/faq.html for hints about trouble shooting.
[0]PETSC ERROR: See docs/index.html for manual pages.
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: ./build/debug/dim2/fluid/peano-fluid on a petsc-3.2 named atsccs58 by liebm Thu May 31 14:31:08 2012
[0]PETSC ERROR: Libraries linked from /work_fast/liebm/petsc-3.2-serial-debug/lib
[0]PETSC ERROR: Configure run at Thu May 31 10:27:55 2012
[0]PETSC ERROR: Configure options --PETSC_ARCH=petsc-3.2-serial-debug --prefix=/work_fast/liebm/petsc-3.2-serial-debug --with-debugging=1 --with-cxx=gcc --with-fc=gfortran --with-cc=gcc --download-superlu=1 --with-mpi=0
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: peano::petsc::PETScNonLinearSolver::setupLinearSolver() line 367 in petscpetsc/PETScNonLinearSolver.cpp
  14:31:08      error         petscError::logPetscTraceBackErrorHandler                    Major PETSc error occured in function peano::petsc::PETScNonLinearSolver::setupLinearSolver, line 367, dir. petsc, file petsc/PETScNonLinearSolver.cpp.

  14:31:08      warning       petscError::logPetscTraceBackErrorHandler                    Implementation not yet completed
  14:31:08      warning       petscError::logPETScError                                    PetscErrorCode is: 58
  14:31:08      warning       petscError::logPETScError                                    Attention: no MPI abort for main or unknown function imitated!
[0]PETSC ERROR: --------------------- Error Message ------------------------------------
[0]PETSC ERROR: Invalid argument!
[0]PETSC ERROR: Wrong type of object: Parameter # 1!
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: Petsc Release Version 3.2.0, Patch 7, Thu Mar 15 09:30:51 CDT 2012 
[0]PETSC ERROR: See docs/changes/index.html for recent updates.
[0]PETSC ERROR: See docs/faq.html for hints about trouble shooting.
[0]PETSC ERROR: See docs/index.html for manual pages.
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: ./build/debug/dim2/fluid/peano-fluid on a petsc-3.2 named atsccs58 by liebm Thu May 31 14:31:08 2012
[0]PETSC ERROR: Libraries linked from /work_fast/liebm/petsc-3.2-serial-debug/lib
[0]PETSC ERROR: Configure run at Thu May 31 10:27:55 2012
[0]PETSC ERROR: Configure options --PETSC_ARCH=petsc-3.2-serial-debug --prefix=/work_fast/liebm/petsc-3.2-serial-debug --with-debugging=1 --with-cxx=gcc --with-fc=gfortran --with-cc=gcc --download-superlu=1 --with-mpi=0
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: MatSuperluSetILUDropTol() line 455 in /work_fast/liebm/petsc-3.2-p7/src/mat/impls/aij/seq/superlu/superlu.c
  14:31:08      warning       petscError::logPETScError                                    Attention: no PetscErrorBaseMessage imitated!
[0]PETSC ERROR: --------------------- Error Message ------------------------------------
[0]PETSC ERROR: Invalid argument!
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: Petsc Release Version 3.2.0, Patch 7, Thu Mar 15 09:30:51 CDT 2012 
[0]PETSC ERROR: See docs/changes/index.html for recent updates.
[0]PETSC ERROR: See docs/faq.html for hints about trouble shooting.
[0]PETSC ERROR: See docs/index.html for manual pages.
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: ./build/debug/dim2/fluid/peano-fluid on a petsc-3.2 named atsccs58 by liebm Thu May 31 14:31:08 2012
[0]PETSC ERROR: Libraries linked from /work_fast/liebm/petsc-3.2-serial-debug/lib
[0]PETSC ERROR: Configure run at Thu May 31 10:27:55 2012
[0]PETSC ERROR: Configure options --PETSC_ARCH=petsc-3.2-serial-debug --prefix=/work_fast/liebm/petsc-3.2-serial-debug --with-debugging=1 --with-cxx=gcc --with-fc=gfortran --with-cc=gcc --download-superlu=1 --with-mpi=0
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: peano::petsc::PETScNonLinearSolver::setupLinearSolver() line 369 in petscpetsc/PETScNonLinearSolver.cpp
  14:31:08      error         petscError::logPetscTraceBackErrorHandler                    Major PETSc error occured in function peano::petsc::PETScNonLinearSolver::setupLinearSolver, line 369, dir. petsc, file petsc/PETScNonLinearSolver.cpp.

  14:31:08      warning       petscError::logPetscTraceBackErrorHandler                    Implementation not yet completed
  14:31:08      warning       petscError::logPETScError                                    PetscErrorCode is: 62
  14:31:08      warning       petscError::logPETScError                                    Attention: no MPI abort for main or unknown function imitated!
  14:31:08      info          peano::fluid::TrivialgridEventHandle2VTKWriter4FluidAdapter::endIteration      
Accumulated and integrated outflow is: 0

  14:31:08      info          peano::ode::ODESolver::solve()                               starting time integration. StartTime=0, endTime=1, startTimeStepNr=1, endTimeStepNr=1
  14:31:08      info          peano::fluid::NonLinearTrivialgridFluidSimulation::computeNavierStokesFunction()      runtime for B-evaluation: 0 (CPU time), 0.000845671 (calendar time)
  14:31:08      info          peano::petsc::PETScNonLinearEquations::monitorNonLinearSolver()      residual norm at iteration 0: 3.24893; LinearIterations: 0
  14:31:08      info          peano::fluid::TrivialgridEventHandle2VTKWriter4FluidAdapter::endIteration      
Accumulated and integrated outflow is: 0

  14:31:08      info          peano::petsc::PETScNonLinearEquations::jacobianGrid()        iteration started.
  14:31:08      info          peano::fluid::NonLinearTrivialgridFluidSimulation::computeNavierStokesJacobian()      runtime for Jacobian: 0 (CPU time), 0.00197101 (calendar time)
  14:31:08      info          peano::fluid::NonLinearTrivialgridFluidSimulation::computeNavierStokesFunction()      runtime for B-evaluation: 0 (CPU time), 0.000895262 (calendar time)
  14:31:08      info          peano::petsc::PETScNonLinearEquations::monitorNonLinearSolver()      residual norm at iteration 1: 0.445035; LinearIterations: 2
  14:31:08      info          peano::fluid::TrivialgridEventHandle2VTKWriter4FluidAdapter::endIteration      
Accumulated and integrated outflow is: 0

  14:31:08      info          peano::petsc::PETScNonLinearEquations::jacobianGrid()        iteration started.
  14:31:08      info          peano::fluid::NonLinearTrivialgridFluidSimulation::computeNavierStokesJacobian()      runtime for Jacobian: 0 (CPU time), 0.00191617 (calendar time)
  14:31:08      info          peano::fluid::NonLinearTrivialgridFluidSimulation::computeNavierStokesFunction()      runtime for B-evaluation: 0 (CPU time), 0.000865698 (calendar time)
  14:31:08      info          peano::petsc::PETScNonLinearEquations::monitorNonLinearSolver()      residual norm at iteration 2: 6.48912e-05; LinearIterations: 7
  14:31:08      info          peano::fluid::TrivialgridEventHandle2VTKWriter4FluidAdapter::endIteration      
Accumulated and integrated outflow is: 0

  14:31:08      info          peano::petsc::PETScNonLinearEquations::jacobianGrid()        iteration started.
  14:31:08      info          peano::fluid::NonLinearTrivialgridFluidSimulation::computeNavierStokesJacobian()      runtime for Jacobian: 0 (CPU time), 0.00186586 (calendar time)
  14:31:08      info          peano::fluid::NonLinearTrivialgridFluidSimulation::computeNavierStokesFunction()      runtime for B-evaluation: 0 (CPU time), 0.000849247 (calendar time)
  14:31:08      info          peano::petsc::PETScNonLinearEquations::monitorNonLinearSolver()      residual norm at iteration 3: 3.69354e-13; LinearIterations: 12
  14:31:08      info          peano::fluid::TrivialgridEventHandle2VTKWriter4FluidAdapter::endIteration      
Accumulated and integrated outflow is: 0

  14:31:08      info          peano::petsc::PETScNonLinearSolver::solve()                  NLGS solver completed in 3 iterations; conv. reason=3
  14:31:08      info          peano::petsc::PETScNonLinearSolver::solve()                  NLGS solver converged!
  14:31:08      info          peano::fluid::FluidSimulation::solveNonLinearSystem()        non-linear solution completed with iterations:3
  14:31:08      info          peano::fluid::TrivialgridEventHandle2VTKWriter4FluidAdapter::endIteration      
Accumulated and integrated outflow is: 0

  14:31:08      info          UserInterface::writeFluidTimeStepInfo(...)                   |    1       |    1.00000e-03  |   0.00000e+00  |   0.00000e+00  |   0.00000e+00  |   0.00000e+00  |   -nan  |   -nan  |   0.00000e+00  |   0.00000e+00  |   -1.00000e+00  |   -1    |   72   |   56     |  3.00000e-02     |  -1     |  -1.00000e+00     |  113  |   8.54262e+01, -1.24345e-14, 
  14:31:08      info          peano::fluid::SteadyStateIntegrationTestChannel::testTrivialgrid9x9ObstacleInChannelNoPreSteps()      testTrivialgrid9x9ObstacleInChannelNoPreSteps(ANALYTICAL) OK

test testTrivialgrid9x9ObstacleInChannelNoPreSteps(JACOBIAN_ASSEMBLING_FINITEDIFF)
  14:31:08      info          peano::fluid::SteadyStateIntegrationTestChannel::testTrivialgrid9x9ObstacleInChannelNoPreSteps(FINITEDIFF)      running test case
  14:31:08      info          peano::fluid::AbstractCalculateF::AbstractCalculateF()       using gravity with values: 0, 0
  14:31:08      info          peano::trivialgrid::TrivialgridDataContainer::allocateMemory()      allocate grid with 100 vertex dofs and 81 cell dofs
  14:31:08      info          peano::trivialgrid::Trivialgrid::Trivialgrid(...)            Trivialgrid(): number of grid points: 10, 10, domain size: 1, 1, domain offset: 0, 0
  14:31:08      info          peano::fluid::TrivialgridFluidRunner::createJacobianAdapterAndTrivialgrid()      creating Jacobian instances for assembling type: ANALYTICAL (matrix-free=0)
  14:31:08      warning       peano::ode::ODESolver::checkSettings()                       no restart writing in use!
[0]PETSC ERROR: --------------------- Error Message ------------------------------------
[0]PETSC ERROR: Null argument, when expecting valid pointer!
[0]PETSC ERROR: Null Object: Parameter # 1!
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: Petsc Release Version 3.2.0, Patch 7, Thu Mar 15 09:30:51 CDT 2012 
[0]PETSC ERROR: See docs/changes/index.html for recent updates.
[0]PETSC ERROR: See docs/faq.html for hints about trouble shooting.
[0]PETSC ERROR: See docs/index.html for manual pages.
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: ./build/debug/dim2/fluid/peano-fluid on a petsc-3.2 named atsccs58 by liebm Thu May 31 14:31:08 2012
[0]PETSC ERROR: Libraries linked from /work_fast/liebm/petsc-3.2-serial-debug/lib
[0]PETSC ERROR: Configure run at Thu May 31 10:27:55 2012
[0]PETSC ERROR: Configure options --PETSC_ARCH=petsc-3.2-serial-debug --prefix=/work_fast/liebm/petsc-3.2-serial-debug --with-debugging=1 --with-cxx=gcc --with-fc=gfortran --with-cc=gcc --download-superlu=1 --with-mpi=0
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: MatGetFactor() line 3929 in /work_fast/liebm/petsc-3.2-p7/src/mat/interface/matrix.c
[0]PETSC ERROR: PCFactorSetUpMatSolverPackage_Factor() line 17 in /work_fast/liebm/petsc-3.2-p7/src/ksp/pc/impls/factor/factimpl.c
[0]PETSC ERROR: PCFactorSetUpMatSolverPackage() line 26 in /work_fast/liebm/petsc-3.2-p7/src/ksp/pc/impls/factor/factor.c
  14:31:08      info          peano::fluid::FluidSimulation::runFluidSimulation()          preparing the grid
  14:31:08      info          peano::fluid::TrivialgridFluidSimulation::parseGeometry()      starting geometry parsing
  14:31:08      info          peano::fluid::FluidSimulation::runFluidSimulation()          counting the inner cells and setting boundary conditions
  14:31:08      info          peano::fluid::TrivialgridFluidSimulation::updateGrid         updating grid...
  14:31:08      info          peano::fluid::FluidSimulation::implementSetInitialValue()      assembling the matrix
  14:31:08      info          peano::fluid::TrivialgridFluidSimulation::createPETScSolver()      PETSc KSP Object info: , type: cg, maximum iterations=10000, rtol=1e-07, atol=1e-07, divtol=10000, left precond.; PETSc PC Object info: , type: jacobi, 
  14:31:08      info          peano::fluid::TrivialgridFluidSimulation::assembleMatrix()::Assemble Q iteration      total number of clock ticks within block (cpu-time,calendar-time): (0s,0.000597954s)
  14:31:08      info          peano::fluid::FluidSimulation::implementSetInitialValue()      memory consumption after matrix assemblation: 112 MB
  14:31:08      info          peano::fluid::FluidSimulation::implementSetInitialValue()      global time for matrix assemblation:
  14:31:08      info          FluidSimulation::implementSetInitialValue()                  total number of clock ticks within block (cpu-time,calendar-time): (0s,0.00101686s)
  14:31:08      info          peano::fluid::TrivialgridEventHandle2VTKWriter4FluidAdapter::endIteration      
Accumulated and integrated outflow is: 0

  14:31:08      info          UserInterface::writeFluidTimeStepInfoHeader()                || time step || T_sim total   || norm(du/u)_2h || norm(du/u)_max|| norm(du)_2h   || norm(du)_max  || norm(dp/p)_2h || norm(dp/p)_max|| norm(dp)_2h   || norm(dp)_max  || resdiuum      || depth || \#cells || \#dofNodes || cpu sec./step || \#its/LGS-sol.  || cpu sec./LGS-sol. || mem usage MB || f_glob on nr. 4
  14:31:08      info          peano::fluid::NonLinearTrivialgridFluidSimulation::implementSetInitialValue()      starting pseudo-timestepping with 0 steps and specified step size=0.001
  14:31:08      warning       petscError::logPETScError                                    Attention: no PetscErrorBaseMessage imitated!
[0]PETSC ERROR: --------------------- Error Message ------------------------------------
[0]PETSC ERROR: Null argument, when expecting valid pointer!
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: Petsc Release Version 3.2.0, Patch 7, Thu Mar 15 09:30:51 CDT 2012 
[0]PETSC ERROR: See docs/changes/index.html for recent updates.
[0]PETSC ERROR: See docs/faq.html for hints about trouble shooting.
[0]PETSC ERROR: See docs/index.html for manual pages.
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: ./build/debug/dim2/fluid/peano-fluid on a petsc-3.2 named atsccs58 by liebm Thu May 31 14:31:08 2012
[0]PETSC ERROR: Libraries linked from /work_fast/liebm/petsc-3.2-serial-debug/lib
[0]PETSC ERROR: Configure run at Thu May 31 10:27:55 2012
[0]PETSC ERROR: Configure options --PETSC_ARCH=petsc-3.2-serial-debug --prefix=/work_fast/liebm/petsc-3.2-serial-debug --with-debugging=1 --with-cxx=gcc --with-fc=gfortran --with-cc=gcc --download-superlu=1 --with-mpi=0
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: peano::petsc::PETScNonLinearSolver::setupLinearSolver() line 365 in petscpetsc/PETScNonLinearSolver.cpp
  14:31:08      error         petscError::logPetscTraceBackErrorHandler                    Major PETSc error occured in function peano::petsc::PETScNonLinearSolver::setupLinearSolver, line 365, dir. petsc, file petsc/PETScNonLinearSolver.cpp.

  14:31:08      warning       petscError::logPetscTraceBackErrorHandler                    Implementation not yet completed
  14:31:08      warning       petscError::logPETScError                                    PetscErrorCode is: 85
  14:31:08      warning       petscError::logPETScError                                    Attention: no MPI abort for main or unknown function imitated!
[0]PETSC ERROR: --------------------- Error Message ------------------------------------
[0]PETSC ERROR: Operation done in wrong order!
[0]PETSC ERROR: Matrix not yet factored; call after KSPSetUp() or PCSetUp()!
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: Petsc Release Version 3.2.0, Patch 7, Thu Mar 15 09:30:51 CDT 2012 
[0]PETSC ERROR: See docs/changes/index.html for recent updates.
[0]PETSC ERROR: See docs/faq.html for hints about trouble shooting.
[0]PETSC ERROR: See docs/index.html for manual pages.
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: ./build/debug/dim2/fluid/peano-fluid on a petsc-3.2 named atsccs58 by liebm Thu May 31 14:31:08 2012
[0]PETSC ERROR: Libraries linked from /work_fast/liebm/petsc-3.2-serial-debug/lib
[0]PETSC ERROR: Configure run at Thu May 31 10:27:55 2012
[0]PETSC ERROR: Configure options --PETSC_ARCH=petsc-3.2-serial-debug --prefix=/work_fast/liebm/petsc-3.2-serial-debug --with-debugging=1 --with-cxx=gcc --with-fc=gfortran --with-cc=gcc --download-superlu=1 --with-mpi=0
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: PCFactorGetMatrix_Factor() line 176 in /work_fast/liebm/petsc-3.2-p7/src/ksp/pc/impls/factor/factimpl.c
[0]PETSC ERROR: PCFactorGetMatrix() line 1220 in /work_fast/liebm/petsc-3.2-p7/src/ksp/pc/interface/precon.c
  14:31:08      warning       petscError::logPETScError                                    Attention: no PetscErrorBaseMessage imitated!
[0]PETSC ERROR: --------------------- Error Message ------------------------------------
[0]PETSC ERROR: Operation done in wrong order!
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: Petsc Release Version 3.2.0, Patch 7, Thu Mar 15 09:30:51 CDT 2012 
[0]PETSC ERROR: See docs/changes/index.html for recent updates.
[0]PETSC ERROR: See docs/faq.html for hints about trouble shooting.
[0]PETSC ERROR: See docs/index.html for manual pages.
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: ./build/debug/dim2/fluid/peano-fluid on a petsc-3.2 named atsccs58 by liebm Thu May 31 14:31:08 2012
[0]PETSC ERROR: Libraries linked from /work_fast/liebm/petsc-3.2-serial-debug/lib
[0]PETSC ERROR: Configure run at Thu May 31 10:27:55 2012
[0]PETSC ERROR: Configure options --PETSC_ARCH=petsc-3.2-serial-debug --prefix=/work_fast/liebm/petsc-3.2-serial-debug --with-debugging=1 --with-cxx=gcc --with-fc=gfortran --with-cc=gcc --download-superlu=1 --with-mpi=0
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: peano::petsc::PETScNonLinearSolver::setupLinearSolver() line 367 in petscpetsc/PETScNonLinearSolver.cpp
  14:31:08      error         petscError::logPetscTraceBackErrorHandler                    Major PETSc error occured in function peano::petsc::PETScNonLinearSolver::setupLinearSolver, line 367, dir. petsc, file petsc/PETScNonLinearSolver.cpp.

  14:31:08      warning       petscError::logPetscTraceBackErrorHandler                    Implementation not yet completed
  14:31:08      warning       petscError::logPETScError                                    PetscErrorCode is: 58
  14:31:08      warning       petscError::logPETScError                                    Attention: no MPI abort for main or unknown function imitated!
[0]PETSC ERROR: --------------------- Error Message ------------------------------------
[0]PETSC ERROR: Invalid argument!
[0]PETSC ERROR: Wrong type of object: Parameter # 1!
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: Petsc Release Version 3.2.0, Patch 7, Thu Mar 15 09:30:51 CDT 2012 
[0]PETSC ERROR: See docs/changes/index.html for recent updates.
[0]PETSC ERROR: See docs/faq.html for hints about trouble shooting.
[0]PETSC ERROR: See docs/index.html for manual pages.
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: ./build/debug/dim2/fluid/peano-fluid on a petsc-3.2 named atsccs58 by liebm Thu May 31 14:31:08 2012
[0]PETSC ERROR: Libraries linked from /work_fast/liebm/petsc-3.2-serial-debug/lib
[0]PETSC ERROR: Configure run at Thu May 31 10:27:55 2012
[0]PETSC ERROR: Configure options --PETSC_ARCH=petsc-3.2-serial-debug --prefix=/work_fast/liebm/petsc-3.2-serial-debug --with-debugging=1 --with-cxx=gcc --with-fc=gfortran --with-cc=gcc --download-superlu=1 --with-mpi=0
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: MatSuperluSetILUDropTol() line 455 in /work_fast/liebm/petsc-3.2-p7/src/mat/impls/aij/seq/superlu/superlu.c
  14:31:08      warning       petscError::logPETScError                                    Attention: no PetscErrorBaseMessage imitated!
[0]PETSC ERROR: --------------------- Error Message ------------------------------------
[0]PETSC ERROR: Invalid argument!
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: Petsc Release Version 3.2.0, Patch 7, Thu Mar 15 09:30:51 CDT 2012 
[0]PETSC ERROR: See docs/changes/index.html for recent updates.
[0]PETSC ERROR: See docs/faq.html for hints about trouble shooting.
[0]PETSC ERROR: See docs/index.html for manual pages.
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: ./build/debug/dim2/fluid/peano-fluid on a petsc-3.2 named atsccs58 by liebm Thu May 31 14:31:08 2012
[0]PETSC ERROR: Libraries linked from /work_fast/liebm/petsc-3.2-serial-debug/lib
[0]PETSC ERROR: Configure run at Thu May 31 10:27:55 2012
[0]PETSC ERROR: Configure options --PETSC_ARCH=petsc-3.2-serial-debug --prefix=/work_fast/liebm/petsc-3.2-serial-debug --with-debugging=1 --with-cxx=gcc --with-fc=gfortran --with-cc=gcc --download-superlu=1 --with-mpi=0
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: peano::petsc::PETScNonLinearSolver::setupLinearSolver() line 369 in petscpetsc/PETScNonLinearSolver.cpp
  14:31:08      error         petscError::logPetscTraceBackErrorHandler                    Major PETSc error occured in function peano::petsc::PETScNonLinearSolver::setupLinearSolver, line 369, dir. petsc, file petsc/PETScNonLinearSolver.cpp.

  14:31:08      warning       petscError::logPetscTraceBackErrorHandler                    Implementation not yet completed
  14:31:08      warning       petscError::logPETScError                                    PetscErrorCode is: 62
  14:31:08      warning       petscError::logPETScError                                    Attention: no MPI abort for main or unknown function imitated!
  14:31:08      info          peano::fluid::TrivialgridEventHandle2VTKWriter4FluidAdapter::endIteration      
Accumulated and integrated outflow is: 0

  14:31:08      info          peano::ode::ODESolver::solve()                               starting time integration. StartTime=0, endTime=1, startTimeStepNr=1, endTimeStepNr=1
  14:31:08      info          peano::fluid::NonLinearTrivialgridFluidSimulation::computeNavierStokesFunction()      runtime for B-evaluation: 0 (CPU time), 0.000849247 (calendar time)
  14:31:08      info          peano::petsc::PETScNonLinearEquations::monitorNonLinearSolver()      residual norm at iteration 0: 3.24893; LinearIterations: 0
  14:31:08      info          peano::fluid::TrivialgridEventHandle2VTKWriter4FluidAdapter::endIteration      
Accumulated and integrated outflow is: 0

  14:31:08      info          peano::petsc::PETScNonLinearEquations::jacobianGrid()        iteration started.
  14:31:08      info          peano::fluid::NonLinearTrivialgridFluidSimulation::computeNavierStokesJacobian()      runtime for Jacobian: 0 (CPU time), 0.00209475 (calendar time)
  14:31:08      info          peano::fluid::NonLinearTrivialgridFluidSimulation::computeNavierStokesFunction()      runtime for B-evaluation: 0 (CPU time), 0.000848532 (calendar time)
  14:31:08      info          peano::petsc::PETScNonLinearEquations::monitorNonLinearSolver()      residual norm at iteration 1: 0.445035; LinearIterations: 2
  14:31:08      info          peano::fluid::TrivialgridEventHandle2VTKWriter4FluidAdapter::endIteration      
Accumulated and integrated outflow is: 0

  14:31:08      info          peano::petsc::PETScNonLinearEquations::jacobianGrid()        iteration started.
  14:31:08      info          peano::fluid::NonLinearTrivialgridFluidSimulation::computeNavierStokesJacobian()      runtime for Jacobian: 0 (CPU time), 0.00186658 (calendar time)
  14:31:08      info          peano::fluid::NonLinearTrivialgridFluidSimulation::computeNavierStokesFunction()      runtime for B-evaluation: 0 (CPU time), 0.000863552 (calendar time)
  14:31:08      info          peano::petsc::PETScNonLinearEquations::monitorNonLinearSolver()      residual norm at iteration 2: 6.48912e-05; LinearIterations: 7
  14:31:08      info          peano::fluid::TrivialgridEventHandle2VTKWriter4FluidAdapter::endIteration      
Accumulated and integrated outflow is: 0

  14:31:08      info          peano::petsc::PETScNonLinearEquations::jacobianGrid()        iteration started.
  14:31:08      info          peano::fluid::NonLinearTrivialgridFluidSimulation::computeNavierStokesJacobian()      runtime for Jacobian: 0.01 (CPU time), 0.00210094 (calendar time)
  14:31:08      info          peano::fluid::NonLinearTrivialgridFluidSimulation::computeNavierStokesFunction()      runtime for B-evaluation: 0 (CPU time), 0.000846863 (calendar time)
  14:31:08      info          peano::petsc::PETScNonLinearEquations::monitorNonLinearSolver()      residual norm at iteration 3: 3.69354e-13; LinearIterations: 12
  14:31:08      info          peano::fluid::TrivialgridEventHandle2VTKWriter4FluidAdapter::endIteration      
Accumulated and integrated outflow is: 0

  14:31:08      info          peano::petsc::PETScNonLinearSolver::solve()                  NLGS solver completed in 3 iterations; conv. reason=3
  14:31:08      info          peano::petsc::PETScNonLinearSolver::solve()                  NLGS solver converged!
  14:31:08      info          peano::fluid::FluidSimulation::solveNonLinearSystem()        non-linear solution completed with iterations:3
  14:31:08      info          peano::fluid::TrivialgridEventHandle2VTKWriter4FluidAdapter::endIteration      
Accumulated and integrated outflow is: 0

  14:31:08      info          UserInterface::writeFluidTimeStepInfo(...)                   |    1       |    1.00000e-03  |   0.00000e+00  |   0.00000e+00  |   0.00000e+00  |   0.00000e+00  |   -nan  |   -nan  |   0.00000e+00  |   0.00000e+00  |   -1.00000e+00  |   -1    |   72   |   56     |  3.00000e-02     |  -1     |  -1.00000e+00     |  113  |   8.54262e+01, -1.24345e-14, 
  14:31:08      info          peano::fluid::SteadyStateIntegrationTestChannel::testTrivialgrid9x9ObstacleInChannelNoPreSteps()      testTrivialgrid9x9ObstacleInChannelNoPreSteps(FINITEDIFF) OK
  14:31:08      info          tarch::tests::TestCaseCollection::run()                      running test case collection "fluid" .. ok
  14:31:08      info          tarch::tests::TestCaseCollection::run()                      running test case collection "fluid-parallel" .. ok
  14:31:08      info          tarch::tests::TestCaseCollection::run()                    running test case collection "integration tests" .... ok
-------------- next part --------------
==3762== Memcheck, a memory error detector
==3762== Copyright (C) 2002-2009, and GNU GPL'd, by Julian Seward et al.
==3762== Using Valgrind-3.6.0.SVN-Debian and LibVEX; rerun with -h for copyright info
==3762== Command: ./build/debug/dim2/fluid/peano-fluid configuration-integration-test.xml
==3762== 
 1338467464   14:31:04     [atsccs58]   debug        /::validateProgramArguments(int,char**)                 Using configuration file configuration-integration-test.xml
 1338467464   14:31:04     [atsccs58]   debug        peano::petsc::PETScFrame::init()                        received parameters: ./build/debug/dim2/fluid/peano-fluid configuration-integration-test.xml 
[0]PETSC ERROR: --------------------- Error Message ------------------------------------
[0]PETSC ERROR: Null argument, when expecting valid pointer!
[0]PETSC ERROR: Null Object: Parameter # 1!
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: Petsc Release Version 3.2.0, Patch 7, Thu Mar 15 09:30:51 CDT 2012 
[0]PETSC ERROR: See docs/changes/index.html for recent updates.
[0]PETSC ERROR: See docs/faq.html for hints about trouble shooting.
[0]PETSC ERROR: See docs/index.html for manual pages.
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: ./build/debug/dim2/fluid/peano-fluid on a petsc-3.2 named atsccs58 by liebm Thu May 31 14:31:04 2012
[0]PETSC ERROR: Libraries linked from /work_fast/liebm/petsc-3.2-serial-debug/lib
[0]PETSC ERROR: Configure run at Thu May 31 10:27:55 2012
[0]PETSC ERROR: Configure options --PETSC_ARCH=petsc-3.2-serial-debug --prefix=/work_fast/liebm/petsc-3.2-serial-debug --with-debugging=1 --with-cxx=gcc --with-fc=gfortran --with-cc=gcc --download-superlu=1 --with-mpi=0
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: MatGetFactor() line 3929 in /work_fast/liebm/petsc-3.2-p7/src/mat/interface/matrix.c
[0]PETSC ERROR: PCFactorSetUpMatSolverPackage_Factor() line 17 in /work_fast/liebm/petsc-3.2-p7/src/ksp/pc/impls/factor/factimpl.c
[0]PETSC ERROR: PCFactorSetUpMatSolverPackage() line 26 in /work_fast/liebm/petsc-3.2-p7/src/ksp/pc/impls/factor/factor.c
  14:31:04      info          UserInterface::writeHeader()                             peano - release T2
  14:31:04      info          UserInterface::writeHeader()                             2d, loaded components: stacks geometry plotter trivialgrid fluid fluid-scenario grid petsc ode
  14:31:04      info          UserInterface::writeHeader()                             opts:       
  14:31:04      info          UserInterface::writeHeader()                             grid-opts: d-loop persistent-attr packed 
  14:31:04      info          UserInterface::writeHeader()                             $Revision: 1.88 $
  14:31:04      info          UserInterface::writeHeader()                             2005 - 2008 Tobias Neckel, Tobias Weinzierl, TUM, Informatik V

test testTrivialgrid3x3ComputeNavierStokesFunction
  14:31:05      info          peano::fluid::AbstractCalculateF::AbstractCalculateF()       using gravity with values: 0, 0
  14:31:05      info          peano::trivialgrid::TrivialgridDataContainer::allocateMemory()      allocate grid with 16 vertex dofs and 9 cell dofs
  14:31:05      info          peano::trivialgrid::Trivialgrid::Trivialgrid(...)            Trivialgrid(): number of grid points: 4, 4, domain size: 1, 1, domain offset: 0, 0
  14:31:05      info          peano::fluid::TrivialgridFluidRunner::createJacobianAdapterAndTrivialgrid()      creating Jacobian instances for assembling type: FINITEDIFF (matrix-free=0)
  14:31:05      info          peano::fluid::FluidSimulation::runFluidSimulation()          preparing the grid
  14:31:05      info          peano::fluid::TrivialgridFluidSimulation::parseGeometry()      starting geometry parsing
  14:31:05      info          peano::fluid::FluidSimulation::runFluidSimulation()          counting the inner cells and setting boundary conditions
  14:31:05      info          peano::fluid::TrivialgridFluidSimulation::updateGrid         updating grid...
  14:31:05      info          peano::fluid::FluidSimulation::implementSetInitialValue()      assembling the matrix
  14:31:06      info          peano::fluid::TrivialgridFluidSimulation::createPETScSolver()      PETSc KSP Object info: , type: cg, maximum iterations=10000, rtol=1e-07, atol=1e-07, divtol=10000, left precond.; PETSc PC Object info: , type: jacobi, 
  14:31:06      info          peano::fluid::TrivialgridFluidSimulation::assembleMatrix()::Assemble Q iteration      total number of clock ticks within block (cpu-time,calendar-time): (0.06s,0.0543659s)
  14:31:06      info          peano::fluid::FluidSimulation::implementSetInitialValue()      memory consumption after matrix assemblation: 277 MB
  14:31:06      info          peano::fluid::FluidSimulation::implementSetInitialValue()      global time for matrix assemblation:
  14:31:06      info          FluidSimulation::implementSetInitialValue()                  total number of clock ticks within block (cpu-time,calendar-time): (0.44s,0.440282s)
  14:31:06      info          UserInterface::writeFluidTimeStepInfoHeader()                || time step || T_sim total   || norm(du/u)_2h || norm(du/u)_max|| norm(du)_2h   || norm(du)_max  || norm(dp/p)_2h || norm(dp/p)_max|| norm(dp)_2h   || norm(dp)_max  || resdiuum      || depth || \#cells || \#dofNodes || cpu sec./step || \#its/LGS-sol.  || cpu sec./LGS-sol. || mem usage MB || f_glob on nr. 4
  14:31:06      info          peano::fluid::NonLinearTrivialgridFluidSimulation::implementSetInitialValue()      starting pseudo-timestepping with 1 steps and specified step size=0.001
  14:31:06      warning       petscError::logPETScError                                    Attention: no PetscErrorBaseMessage imitated!
[0]PETSC ERROR: --------------------- Error Message ------------------------------------
[0]PETSC ERROR: Null argument, when expecting valid pointer!
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: Petsc Release Version 3.2.0, Patch 7, Thu Mar 15 09:30:51 CDT 2012 
[0]PETSC ERROR: See docs/changes/index.html for recent updates.
[0]PETSC ERROR: See docs/faq.html for hints about trouble shooting.
[0]PETSC ERROR: See docs/index.html for manual pages.
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: ./build/debug/dim2/fluid/peano-fluid on a petsc-3.2 named atsccs58 by liebm Thu May 31 14:31:04 2012
[0]PETSC ERROR: Libraries linked from /work_fast/liebm/petsc-3.2-serial-debug/lib
[0]PETSC ERROR: Configure run at Thu May 31 10:27:55 2012
[0]PETSC ERROR: Configure options --PETSC_ARCH=petsc-3.2-serial-debug --prefix=/work_fast/liebm/petsc-3.2-serial-debug --with-debugging=1 --with-cxx=gcc --with-fc=gfortran --with-cc=gcc --download-superlu=1 --with-mpi=0
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: peano::petsc::PETScNonLinearSolver::setupLinearSolver() line 365 in petscpetsc/PETScNonLinearSolver.cpp
  14:31:06      error         petscError::logPetscTraceBackErrorHandler                    Major PETSc error occured in function peano::petsc::PETScNonLinearSolver::setupLinearSolver, line 365, dir. petsc, file petsc/PETScNonLinearSolver.cpp.

  14:31:06      warning       petscError::logPetscTraceBackErrorHandler                    Implementation not yet completed
  14:31:06      warning       petscError::logPETScError                                    PetscErrorCode is: 85
  14:31:06      warning       petscError::logPETScError                                    Attention: no MPI abort for main or unknown function imitated!
[0]PETSC ERROR: --------------------- Error Message ------------------------------------
[0]PETSC ERROR: Operation done in wrong order!
[0]PETSC ERROR: Matrix not yet factored; call after KSPSetUp() or PCSetUp()!
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: Petsc Release Version 3.2.0, Patch 7, Thu Mar 15 09:30:51 CDT 2012 
[0]PETSC ERROR: See docs/changes/index.html for recent updates.
[0]PETSC ERROR: See docs/faq.html for hints about trouble shooting.
[0]PETSC ERROR: See docs/index.html for manual pages.
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: ./build/debug/dim2/fluid/peano-fluid on a petsc-3.2 named atsccs58 by liebm Thu May 31 14:31:04 2012
[0]PETSC ERROR: Libraries linked from /work_fast/liebm/petsc-3.2-serial-debug/lib
[0]PETSC ERROR: Configure run at Thu May 31 10:27:55 2012
[0]PETSC ERROR: Configure options --PETSC_ARCH=petsc-3.2-serial-debug --prefix=/work_fast/liebm/petsc-3.2-serial-debug --with-debugging=1 --with-cxx=gcc --with-fc=gfortran --with-cc=gcc --download-superlu=1 --with-mpi=0
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: PCFactorGetMatrix_Factor() line 176 in /work_fast/liebm/petsc-3.2-p7/src/ksp/pc/impls/factor/factimpl.c
[0]PETSC ERROR: PCFactorGetMatrix() line 1220 in /work_fast/liebm/petsc-3.2-p7/src/ksp/pc/interface/precon.c
  14:31:06      warning       petscError::logPETScError                                    Attention: no PetscErrorBaseMessage imitated!
[0]PETSC ERROR: --------------------- Error Message ------------------------------------
[0]PETSC ERROR: Operation done in wrong order!
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: Petsc Release Version 3.2.0, Patch 7, Thu Mar 15 09:30:51 CDT 2012 
[0]PETSC ERROR: See docs/changes/index.html for recent updates.
[0]PETSC ERROR: See docs/faq.html for hints about trouble shooting.
[0]PETSC ERROR: See docs/index.html for manual pages.
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: ./build/debug/dim2/fluid/peano-fluid on a petsc-3.2 named atsccs58 by liebm Thu May 31 14:31:04 2012
[0]PETSC ERROR: Libraries linked from /work_fast/liebm/petsc-3.2-serial-debug/lib
[0]PETSC ERROR: Configure run at Thu May 31 10:27:55 2012
[0]PETSC ERROR: Configure options --PETSC_ARCH=petsc-3.2-serial-debug --prefix=/work_fast/liebm/petsc-3.2-serial-debug --with-debugging=1 --with-cxx=gcc --with-fc=gfortran --with-cc=gcc --download-superlu=1 --with-mpi=0
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: peano::petsc::PETScNonLinearSolver::setupLinearSolver() line 367 in petscpetsc/PETScNonLinearSolver.cpp
  14:31:06      error         petscError::logPetscTraceBackErrorHandler                    Major PETSc error occured in function peano::petsc::PETScNonLinearSolver::setupLinearSolver, line 367, dir. petsc, file petsc/PETScNonLinearSolver.cpp.

  14:31:06      warning       petscError::logPetscTraceBackErrorHandler                    Implementation not yet completed
  14:31:06      warning       petscError::logPETScError                                    PetscErrorCode is: 58
  14:31:06      warning       petscError::logPETScError                                    Attention: no MPI abort for main or unknown function imitated!
==3762== Conditional jump or move depends on uninitialised value(s)
==3762==    at 0x1CC43A8: MatSuperluSetILUDropTol (superlu.c:455)
==3762==    by 0x192899D: peano::petsc::PETScNonLinearSolver::setupLinearSolver(_p_KSP*&, std::string, std::string, double, double, int) (PETScNonLinearSolver.cpp:368)
==3762==    by 0x192716E: peano::petsc::PETScNonLinearSolver::initialize(int, int, int) (PETScNonLinearSolver.cpp:242)
==3762==    by 0x901675: peano::fluid::NonLinearTrivialgridFluidSimulation::implementSetInitialValue(bool, double, int, double) (NonLinearTrivialgridFluidSimulation.cpp:540)
==3762==    by 0x17AE3D8: peano::fluid::SteadyStateIntegrationTestChannel::testTrivialgrid3x3ComputeNavierStokesFunction() (SteadyStateIntegrationTestChannel.cpp:114)
==3762==    by 0x17B28C7: peano::fluid::SteadyStateIntegrationTestChannel::run() (SteadyStateIntegrationTestChannel.cpp:487)
==3762==    by 0x19BE3B3: tarch::tests::TestCaseCollection::run() (TestCaseCollection.cpp:42)
==3762==    by 0x19BE3B3: tarch::tests::TestCaseCollection::run() (TestCaseCollection.cpp:42)
==3762==    by 0x408BCD: peano::IntegrationTestCaseRunner::run(tarch::configuration::IntegrationTestConfiguration const&) (IntegrationTestCaseRunner.cpp:127)
==3762==    by 0x412D5E: main (main.cpp:205)
==3762== 
==3762== Conditional jump or move depends on uninitialised value(s)
==3762==    at 0x1CC43FB: MatSuperluSetILUDropTol (superlu.c:455)
==3762==    by 0x192899D: peano::petsc::PETScNonLinearSolver::setupLinearSolver(_p_KSP*&, std::string, std::string, double, double, int) (PETScNonLinearSolver.cpp:368)
==3762==    by 0x192716E: peano::petsc::PETScNonLinearSolver::initialize(int, int, int) (PETScNonLinearSolver.cpp:242)
==3762==    by 0x901675: peano::fluid::NonLinearTrivialgridFluidSimulation::implementSetInitialValue(bool, double, int, double) (NonLinearTrivialgridFluidSimulation.cpp:540)
==3762==    by 0x17AE3D8: peano::fluid::SteadyStateIntegrationTestChannel::testTrivialgrid3x3ComputeNavierStokesFunction() (SteadyStateIntegrationTestChannel.cpp:114)
==3762==    by 0x17B28C7: peano::fluid::SteadyStateIntegrationTestChannel::run() (SteadyStateIntegrationTestChannel.cpp:487)
==3762==    by 0x19BE3B3: tarch::tests::TestCaseCollection::run() (TestCaseCollection.cpp:42)
==3762==    by 0x19BE3B3: tarch::tests::TestCaseCollection::run() (TestCaseCollection.cpp:42)
==3762==    by 0x408BCD: peano::IntegrationTestCaseRunner::run(tarch::configuration::IntegrationTestConfiguration const&) (IntegrationTestCaseRunner.cpp:127)
==3762==    by 0x412D5E: main (main.cpp:205)
==3762== 
[0]PETSC ERROR: --------------------- Error Message ------------------------------------
[0]PETSC ERROR: Corrupt argument: see http://www.mcs.anl.gov/petsc/petsc-as/documentation/faq.html#valgrind!
[0]PETSC ERROR: Invalid Pointer to Object: Parameter # 1!
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: Petsc Release Version 3.2.0, Patch 7, Thu Mar 15 09:30:51 CDT 2012 
[0]PETSC ERROR: See docs/changes/index.html for recent updates.
[0]PETSC ERROR: See docs/faq.html for hints about trouble shooting.
[0]PETSC ERROR: See docs/index.html for manual pages.
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: ./build/debug/dim2/fluid/peano-fluid on a petsc-3.2 named atsccs58 by liebm Thu May 31 14:31:04 2012
[0]PETSC ERROR: Libraries linked from /work_fast/liebm/petsc-3.2-serial-debug/lib
[0]PETSC ERROR: Configure run at Thu May 31 10:27:55 2012
[0]PETSC ERROR: Configure options --PETSC_ARCH=petsc-3.2-serial-debug --prefix=/work_fast/liebm/petsc-3.2-serial-debug --with-debugging=1 --with-cxx=gcc --with-fc=gfortran --with-cc=gcc --download-superlu=1 --with-mpi=0
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: MatSuperluSetILUDropTol() line 455 in /work_fast/liebm/petsc-3.2-p7/src/mat/impls/aij/seq/superlu/superlu.c
  14:31:06      warning       petscError::logPETScError                                    Attention: no PetscErrorBaseMessage imitated!
[0]PETSC ERROR: --------------------- Error Message ------------------------------------
[0]PETSC ERROR: Corrupt argument: see http://www.mcs.anl.gov/petsc/petsc-as/documentation/faq.html#valgrind!
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: Petsc Release Version 3.2.0, Patch 7, Thu Mar 15 09:30:51 CDT 2012 
[0]PETSC ERROR: See docs/changes/index.html for recent updates.
[0]PETSC ERROR: See docs/faq.html for hints about trouble shooting.
[0]PETSC ERROR: See docs/index.html for manual pages.
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: ./build/debug/dim2/fluid/peano-fluid on a petsc-3.2 named atsccs58 by liebm Thu May 31 14:31:04 2012
[0]PETSC ERROR: Libraries linked from /work_fast/liebm/petsc-3.2-serial-debug/lib
[0]PETSC ERROR: Configure run at Thu May 31 10:27:55 2012
[0]PETSC ERROR: Configure options --PETSC_ARCH=petsc-3.2-serial-debug --prefix=/work_fast/liebm/petsc-3.2-serial-debug --with-debugging=1 --with-cxx=gcc --with-fc=gfortran --with-cc=gcc --download-superlu=1 --with-mpi=0
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: peano::petsc::PETScNonLinearSolver::setupLinearSolver() line 369 in petscpetsc/PETScNonLinearSolver.cpp
  14:31:06      error         petscError::logPetscTraceBackErrorHandler                    Major PETSc error occured in function peano::petsc::PETScNonLinearSolver::setupLinearSolver, line 369, dir. petsc, file petsc/PETScNonLinearSolver.cpp.

  14:31:06      warning       petscError::logPetscTraceBackErrorHandler                    Implementation not yet completed
  14:31:06      warning       petscError::logPETScError                                    PetscErrorCode is: 64
  14:31:06      warning       petscError::logPETScError                                    Attention: no MPI abort for main or unknown function imitated!
  14:31:07      info          peano::fluid::NonLinearTrivialgridFluidSimulation::computeNavierStokesFunction()      runtime for B-evaluation: 0.04 (CPU time), 0.0409479 (calendar time)

test testTrivialgrid3x3FreeChannelTwoPreSteps(JACOBIAN_ASSEMBLING_ANALYTICAL)
  14:31:07      info          peano::fluid::SteadyStateIntegrationTestChannel::testTrivialgrid3x3FreeChannelTwoPreSteps(ANALYTICAL)      running test case
  14:31:07      info          peano::fluid::AbstractCalculateF::AbstractCalculateF()       using gravity with values: 0, 0
  14:31:07      info          peano::trivialgrid::TrivialgridDataContainer::allocateMemory()      allocate grid with 16 vertex dofs and 9 cell dofs
  14:31:07      info          peano::trivialgrid::Trivialgrid::Trivialgrid(...)            Trivialgrid(): number of grid points: 4, 4, domain size: 1, 1, domain offset: 0, 0
  14:31:07      info          peano::fluid::TrivialgridFluidRunner::createJacobianAdapterAndTrivialgrid()      creating Jacobian instances for assembling type: FINITEDIFF (matrix-free=0)
  14:31:07      warning       peano::ode::ODESolver::checkSettings()                       no restart writing in use!
[0]PETSC ERROR: --------------------- Error Message ------------------------------------
[0]PETSC ERROR: Null argument, when expecting valid pointer!
[0]PETSC ERROR: Null Object: Parameter # 1!
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: Petsc Release Version 3.2.0, Patch 7, Thu Mar 15 09:30:51 CDT 2012 
[0]PETSC ERROR: See docs/changes/index.html for recent updates.
[0]PETSC ERROR: See docs/faq.html for hints about trouble shooting.
[0]PETSC ERROR: See docs/index.html for manual pages.
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: ./build/debug/dim2/fluid/peano-fluid on a petsc-3.2 named atsccs58 by liebm Thu May 31 14:31:04 2012
[0]PETSC ERROR: Libraries linked from /work_fast/liebm/petsc-3.2-serial-debug/lib
[0]PETSC ERROR: Configure run at Thu May 31 10:27:55 2012
[0]PETSC ERROR: Configure options --PETSC_ARCH=petsc-3.2-serial-debug --prefix=/work_fast/liebm/petsc-3.2-serial-debug --with-debugging=1 --with-cxx=gcc --with-fc=gfortran --with-cc=gcc --download-superlu=1 --with-mpi=0
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: MatGetFactor() line 3929 in /work_fast/liebm/petsc-3.2-p7/src/mat/interface/matrix.c
[0]PETSC ERROR: PCFactorSetUpMatSolverPackage_Factor() line 17 in /work_fast/liebm/petsc-3.2-p7/src/ksp/pc/impls/factor/factimpl.c
[0]PETSC ERROR: PCFactorSetUpMatSolverPackage() line 26 in /work_fast/liebm/petsc-3.2-p7/src/ksp/pc/impls/factor/factor.c
  14:31:07      info          peano::fluid::FluidSimulation::runFluidSimulation()          preparing the grid
  14:31:07      info          peano::fluid::TrivialgridFluidSimulation::parseGeometry()      starting geometry parsing
  14:31:07      info          peano::fluid::FluidSimulation::runFluidSimulation()          counting the inner cells and setting boundary conditions
  14:31:07      info          peano::fluid::TrivialgridFluidSimulation::updateGrid         updating grid...
  14:31:07      info          peano::fluid::FluidSimulation::implementSetInitialValue()      assembling the matrix
  14:31:07      info          peano::fluid::TrivialgridFluidSimulation::createPETScSolver()      PETSc KSP Object info: , type: cg, maximum iterations=10000, rtol=1e-07, atol=1e-07, divtol=10000, left precond.; PETSc PC Object info: , type: jacobi, 
  14:31:07      info          peano::fluid::TrivialgridFluidSimulation::assembleMatrix()::Assemble Q iteration      total number of clock ticks within block (cpu-time,calendar-time): (0s,0.00335407s)
  14:31:07      info          peano::fluid::FluidSimulation::implementSetInitialValue()      memory consumption after matrix assemblation: 283 MB
  14:31:07      info          peano::fluid::FluidSimulation::implementSetInitialValue()      global time for matrix assemblation:
  14:31:07      info          FluidSimulation::implementSetInitialValue()                  total number of clock ticks within block (cpu-time,calendar-time): (0.01s,0.0105739s)
  14:31:07      info          UserInterface::writeFluidTimeStepInfoHeader()                || time step || T_sim total   || norm(du/u)_2h || norm(du/u)_max|| norm(du)_2h   || norm(du)_max  || norm(dp/p)_2h || norm(dp/p)_max|| norm(dp)_2h   || norm(dp)_max  || resdiuum      || depth || \#cells || \#dofNodes || cpu sec./step || \#its/LGS-sol.  || cpu sec./LGS-sol. || mem usage MB || f_glob on nr. 4
  14:31:07      info          peano::fluid::NonLinearTrivialgridFluidSimulation::implementSetInitialValue()      starting pseudo-timestepping with 2 steps and specified step size=0.001
  14:31:07      warning       petscError::logPETScError                                    Attention: no PetscErrorBaseMessage imitated!
[0]PETSC ERROR: --------------------- Error Message ------------------------------------
[0]PETSC ERROR: Null argument, when expecting valid pointer!
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: Petsc Release Version 3.2.0, Patch 7, Thu Mar 15 09:30:51 CDT 2012 
[0]PETSC ERROR: See docs/changes/index.html for recent updates.
[0]PETSC ERROR: See docs/faq.html for hints about trouble shooting.
[0]PETSC ERROR: See docs/index.html for manual pages.
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: ./build/debug/dim2/fluid/peano-fluid on a petsc-3.2 named atsccs58 by liebm Thu May 31 14:31:04 2012
[0]PETSC ERROR: Libraries linked from /work_fast/liebm/petsc-3.2-serial-debug/lib
[0]PETSC ERROR: Configure run at Thu May 31 10:27:55 2012
[0]PETSC ERROR: Configure options --PETSC_ARCH=petsc-3.2-serial-debug --prefix=/work_fast/liebm/petsc-3.2-serial-debug --with-debugging=1 --with-cxx=gcc --with-fc=gfortran --with-cc=gcc --download-superlu=1 --with-mpi=0
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: peano::petsc::PETScNonLinearSolver::setupLinearSolver() line 365 in petscpetsc/PETScNonLinearSolver.cpp
  14:31:07      error         petscError::logPetscTraceBackErrorHandler                    Major PETSc error occured in function peano::petsc::PETScNonLinearSolver::setupLinearSolver, line 365, dir. petsc, file petsc/PETScNonLinearSolver.cpp.

  14:31:07      warning       petscError::logPetscTraceBackErrorHandler                    Implementation not yet completed
  14:31:07      warning       petscError::logPETScError                                    PetscErrorCode is: 85
  14:31:07      warning       petscError::logPETScError                                    Attention: no MPI abort for main or unknown function imitated!
[0]PETSC ERROR: --------------------- Error Message ------------------------------------
[0]PETSC ERROR: Operation done in wrong order!
[0]PETSC ERROR: Matrix not yet factored; call after KSPSetUp() or PCSetUp()!
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: Petsc Release Version 3.2.0, Patch 7, Thu Mar 15 09:30:51 CDT 2012 
[0]PETSC ERROR: See docs/changes/index.html for recent updates.
[0]PETSC ERROR: See docs/faq.html for hints about trouble shooting.
[0]PETSC ERROR: See docs/index.html for manual pages.
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: ./build/debug/dim2/fluid/peano-fluid on a petsc-3.2 named atsccs58 by liebm Thu May 31 14:31:04 2012
[0]PETSC ERROR: Libraries linked from /work_fast/liebm/petsc-3.2-serial-debug/lib
[0]PETSC ERROR: Configure run at Thu May 31 10:27:55 2012
[0]PETSC ERROR: Configure options --PETSC_ARCH=petsc-3.2-serial-debug --prefix=/work_fast/liebm/petsc-3.2-serial-debug --with-debugging=1 --with-cxx=gcc --with-fc=gfortran --with-cc=gcc --download-superlu=1 --with-mpi=0
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: PCFactorGetMatrix_Factor() line 176 in /work_fast/liebm/petsc-3.2-p7/src/ksp/pc/impls/factor/factimpl.c
[0]PETSC ERROR: PCFactorGetMatrix() line 1220 in /work_fast/liebm/petsc-3.2-p7/src/ksp/pc/interface/precon.c
  14:31:07      warning       petscError::logPETScError                                    Attention: no PetscErrorBaseMessage imitated!
[0]PETSC ERROR: --------------------- Error Message ------------------------------------
[0]PETSC ERROR: Operation done in wrong order!
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: Petsc Release Version 3.2.0, Patch 7, Thu Mar 15 09:30:51 CDT 2012 
[0]PETSC ERROR: See docs/changes/index.html for recent updates.
[0]PETSC ERROR: See docs/faq.html for hints about trouble shooting.
[0]PETSC ERROR: See docs/index.html for manual pages.
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: ./build/debug/dim2/fluid/peano-fluid on a petsc-3.2 named atsccs58 by liebm Thu May 31 14:31:04 2012
[0]PETSC ERROR: Libraries linked from /work_fast/liebm/petsc-3.2-serial-debug/lib
[0]PETSC ERROR: Configure run at Thu May 31 10:27:55 2012
[0]PETSC ERROR: Configure options --PETSC_ARCH=petsc-3.2-serial-debug --prefix=/work_fast/liebm/petsc-3.2-serial-debug --with-debugging=1 --with-cxx=gcc --with-fc=gfortran --with-cc=gcc --download-superlu=1 --with-mpi=0
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: peano::petsc::PETScNonLinearSolver::setupLinearSolver() line 367 in petscpetsc/PETScNonLinearSolver.cpp
  14:31:07      error         petscError::logPetscTraceBackErrorHandler                    Major PETSc error occured in function peano::petsc::PETScNonLinearSolver::setupLinearSolver, line 367, dir. petsc, file petsc/PETScNonLinearSolver.cpp.

  14:31:07      warning       petscError::logPetscTraceBackErrorHandler                    Implementation not yet completed
  14:31:07      warning       petscError::logPETScError                                    PetscErrorCode is: 58
  14:31:07      warning       petscError::logPETScError                                    Attention: no MPI abort for main or unknown function imitated!
[0]PETSC ERROR: --------------------- Error Message ------------------------------------
[0]PETSC ERROR: Corrupt argument: see http://www.mcs.anl.gov/petsc/petsc-as/documentation/faq.html#valgrind!
[0]PETSC ERROR: Invalid Pointer to Object: Parameter # 1!
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: Petsc Release Version 3.2.0, Patch 7, Thu Mar 15 09:30:51 CDT 2012 
[0]PETSC ERROR: See docs/changes/index.html for recent updates.
[0]PETSC ERROR: See docs/faq.html for hints about trouble shooting.
[0]PETSC ERROR: See docs/index.html for manual pages.
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: ./build/debug/dim2/fluid/peano-fluid on a petsc-3.2 named atsccs58 by liebm Thu May 31 14:31:04 2012
[0]PETSC ERROR: Libraries linked from /work_fast/liebm/petsc-3.2-serial-debug/lib
[0]PETSC ERROR: Configure run at Thu May 31 10:27:55 2012
[0]PETSC ERROR: Configure options --PETSC_ARCH=petsc-3.2-serial-debug --prefix=/work_fast/liebm/petsc-3.2-serial-debug --with-debugging=1 --with-cxx=gcc --with-fc=gfortran --with-cc=gcc --download-superlu=1 --with-mpi=0
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: MatSuperluSetILUDropTol() line 455 in /work_fast/liebm/petsc-3.2-p7/src/mat/impls/aij/seq/superlu/superlu.c
  14:31:07      warning       petscError::logPETScError                                    Attention: no PetscErrorBaseMessage imitated!
[0]PETSC ERROR: --------------------- Error Message ------------------------------------
[0]PETSC ERROR: Corrupt argument: see http://www.mcs.anl.gov/petsc/petsc-as/documentation/faq.html#valgrind!
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: Petsc Release Version 3.2.0, Patch 7, Thu Mar 15 09:30:51 CDT 2012 
[0]PETSC ERROR: See docs/changes/index.html for recent updates.
[0]PETSC ERROR: See docs/faq.html for hints about trouble shooting.
[0]PETSC ERROR: See docs/index.html for manual pages.
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: ./build/debug/dim2/fluid/peano-fluid on a petsc-3.2 named atsccs58 by liebm Thu May 31 14:31:04 2012
[0]PETSC ERROR: Libraries linked from /work_fast/liebm/petsc-3.2-serial-debug/lib
[0]PETSC ERROR: Configure run at Thu May 31 10:27:55 2012
[0]PETSC ERROR: Configure options --PETSC_ARCH=petsc-3.2-serial-debug --prefix=/work_fast/liebm/petsc-3.2-serial-debug --with-debugging=1 --with-cxx=gcc --with-fc=gfortran --with-cc=gcc --download-superlu=1 --with-mpi=0
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: peano::petsc::PETScNonLinearSolver::setupLinearSolver() line 369 in petscpetsc/PETScNonLinearSolver.cpp
  14:31:07      error         petscError::logPetscTraceBackErrorHandler                    Major PETSc error occured in function peano::petsc::PETScNonLinearSolver::setupLinearSolver, line 369, dir. petsc, file petsc/PETScNonLinearSolver.cpp.

  14:31:07      warning       petscError::logPetscTraceBackErrorHandler                    Implementation not yet completed
  14:31:07      warning       petscError::logPETScError                                    PetscErrorCode is: 64
  14:31:07      warning       petscError::logPETScError                                    Attention: no MPI abort for main or unknown function imitated!
  14:31:07      info          peano::ode::ODESolver::solve()                               starting time integration. StartTime=0, endTime=1, startTimeStepNr=1, endTimeStepNr=1
  14:31:07      info          peano::fluid::NonLinearTrivialgridFluidSimulation::computeNavierStokesFunction()      runtime for B-evaluation: 0 (CPU time), 0.00469422 (calendar time)
  14:31:07      info          peano::petsc::PETScNonLinearEquations::monitorNonLinearSolver()      residual norm at iteration 0: 1.18128e-13; LinearIterations: 0
  14:31:07      info          peano::petsc::PETScNonLinearEquations::jacobianGrid()        iteration started.
  14:31:07      info          peano::fluid::NonLinearTrivialgridFluidSimulation::computeNavierStokesJacobian()      runtime for Jacobian: 0.08 (CPU time), 0.0804036 (calendar time)
  14:31:08      info          peano::fluid::NonLinearTrivialgridFluidSimulation::computeNavierStokesFunction()      runtime for B-evaluation: 0.01 (CPU time), 0.0048914 (calendar time)
  14:31:08      info          peano::petsc::PETScNonLinearEquations::monitorNonLinearSolver()      residual norm at iteration 1: 7.45947e-16; LinearIterations: 1
  14:31:08      info          peano::petsc::PETScNonLinearSolver::solve()                  NLGS solver completed in 1 iterations; conv. reason=4
  14:31:08      info          peano::petsc::PETScNonLinearSolver::solve()                  NLGS solver converged!
  14:31:08      info          peano::fluid::FluidSimulation::solveNonLinearSystem()        non-linear solution completed with iterations:1
  14:31:08      info          UserInterface::writeFluidTimeStepInfo(...)                   |    1       |    1.00000e-03  |   -nan  |   -nan  |   0.00000e+00  |   0.00000e+00  |   -nan  |   -nan  |   0.00000e+00  |   0.00000e+00  |   2.90332e-13  |   -1    |   9   |   6     |  8.00000e-01     |  3     |  0.00000e+00     |  284  |   0.00000e+00, 0.00000e+00, 
  14:31:08      info          peano::fluid::SteadyStateIntegrationTestChannel::testTrivialgrid3x3FreeChannelTwoPreSteps()      testTrivialgrid3x3FreeChannelTwoPreSteps(ANALYTICAL) OK

test testTrivialgrid3x3FreeChannelTwoPreSteps(JACOBIAN_ASSEMBLING_FINITEDIFF)
  14:31:08      info          peano::fluid::SteadyStateIntegrationTestChannel::testTrivialgrid3x3FreeChannelTwoPreSteps(FINITEDIFF)      running test case
  14:31:08      info          peano::fluid::AbstractCalculateF::AbstractCalculateF()       using gravity with values: 0, 0
  14:31:08      info          peano::trivialgrid::TrivialgridDataContainer::allocateMemory()      allocate grid with 16 vertex dofs and 9 cell dofs
  14:31:08      info          peano::trivialgrid::Trivialgrid::Trivialgrid(...)            Trivialgrid(): number of grid points: 4, 4, domain size: 1, 1, domain offset: 0, 0
  14:31:08      info          peano::fluid::TrivialgridFluidRunner::createJacobianAdapterAndTrivialgrid()      creating Jacobian instances for assembling type: FINITEDIFF (matrix-free=0)
  14:31:08      warning       peano::ode::ODESolver::checkSettings()                       no restart writing in use!
[0]PETSC ERROR: --------------------- Error Message ------------------------------------
[0]PETSC ERROR: Null argument, when expecting valid pointer!
[0]PETSC ERROR: Null Object: Parameter # 1!
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: Petsc Release Version 3.2.0, Patch 7, Thu Mar 15 09:30:51 CDT 2012 
[0]PETSC ERROR: See docs/changes/index.html for recent updates.
[0]PETSC ERROR: See docs/faq.html for hints about trouble shooting.
[0]PETSC ERROR: See docs/index.html for manual pages.
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: ./build/debug/dim2/fluid/peano-fluid on a petsc-3.2 named atsccs58 by liebm Thu May 31 14:31:04 2012
[0]PETSC ERROR: Libraries linked from /work_fast/liebm/petsc-3.2-serial-debug/lib
[0]PETSC ERROR: Configure run at Thu May 31 10:27:55 2012
[0]PETSC ERROR: Configure options --PETSC_ARCH=petsc-3.2-serial-debug --prefix=/work_fast/liebm/petsc-3.2-serial-debug --with-debugging=1 --with-cxx=gcc --with-fc=gfortran --with-cc=gcc --download-superlu=1 --with-mpi=0
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: MatGetFactor() line 3929 in /work_fast/liebm/petsc-3.2-p7/src/mat/interface/matrix.c
[0]PETSC ERROR: PCFactorSetUpMatSolverPackage_Factor() line 17 in /work_fast/liebm/petsc-3.2-p7/src/ksp/pc/impls/factor/factimpl.c
[0]PETSC ERROR: PCFactorSetUpMatSolverPackage() line 26 in /work_fast/liebm/petsc-3.2-p7/src/ksp/pc/impls/factor/factor.c
  14:31:08      info          peano::fluid::FluidSimulation::runFluidSimulation()          preparing the grid
  14:31:08      info          peano::fluid::TrivialgridFluidSimulation::parseGeometry()      starting geometry parsing
  14:31:08      info          peano::fluid::FluidSimulation::runFluidSimulation()          counting the inner cells and setting boundary conditions
  14:31:08      info          peano::fluid::TrivialgridFluidSimulation::updateGrid         updating grid...
  14:31:09      info          peano::fluid::FluidSimulation::implementSetInitialValue()      assembling the matrix
  14:31:09      info          peano::fluid::TrivialgridFluidSimulation::createPETScSolver()      PETSc KSP Object info: , type: cg, maximum iterations=10000, rtol=1e-07, atol=1e-07, divtol=10000, left precond.; PETSc PC Object info: , type: jacobi, 
  14:31:09      info          peano::fluid::TrivialgridFluidSimulation::assembleMatrix()::Assemble Q iteration      total number of clock ticks within block (cpu-time,calendar-time): (0s,0.00506377s)
  14:31:09      info          peano::fluid::FluidSimulation::implementSetInitialValue()      memory consumption after matrix assemblation: 288 MB
  14:31:09      info          peano::fluid::FluidSimulation::implementSetInitialValue()      global time for matrix assemblation:
  14:31:09      info          FluidSimulation::implementSetInitialValue()                  total number of clock ticks within block (cpu-time,calendar-time): (0.01s,0.0144298s)
  14:31:09      info          UserInterface::writeFluidTimeStepInfoHeader()                || time step || T_sim total   || norm(du/u)_2h || norm(du/u)_max|| norm(du)_2h   || norm(du)_max  || norm(dp/p)_2h || norm(dp/p)_max|| norm(dp)_2h   || norm(dp)_max  || resdiuum      || depth || \#cells || \#dofNodes || cpu sec./step || \#its/LGS-sol.  || cpu sec./LGS-sol. || mem usage MB || f_glob on nr. 4
  14:31:09      info          peano::fluid::NonLinearTrivialgridFluidSimulation::implementSetInitialValue()      starting pseudo-timestepping with 2 steps and specified step size=0.001
  14:31:09      warning       petscError::logPETScError                                    Attention: no PetscErrorBaseMessage imitated!
[0]PETSC ERROR: --------------------- Error Message ------------------------------------
[0]PETSC ERROR: Null argument, when expecting valid pointer!
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: Petsc Release Version 3.2.0, Patch 7, Thu Mar 15 09:30:51 CDT 2012 
[0]PETSC ERROR: See docs/changes/index.html for recent updates.
[0]PETSC ERROR: See docs/faq.html for hints about trouble shooting.
[0]PETSC ERROR: See docs/index.html for manual pages.
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: ./build/debug/dim2/fluid/peano-fluid on a petsc-3.2 named atsccs58 by liebm Thu May 31 14:31:04 2012
[0]PETSC ERROR: Libraries linked from /work_fast/liebm/petsc-3.2-serial-debug/lib
[0]PETSC ERROR: Configure run at Thu May 31 10:27:55 2012
[0]PETSC ERROR: Configure options --PETSC_ARCH=petsc-3.2-serial-debug --prefix=/work_fast/liebm/petsc-3.2-serial-debug --with-debugging=1 --with-cxx=gcc --with-fc=gfortran --with-cc=gcc --download-superlu=1 --with-mpi=0
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: peano::petsc::PETScNonLinearSolver::setupLinearSolver() line 365 in petscpetsc/PETScNonLinearSolver.cpp
  14:31:09      error         petscError::logPetscTraceBackErrorHandler                    Major PETSc error occured in function peano::petsc::PETScNonLinearSolver::setupLinearSolver, line 365, dir. petsc, file petsc/PETScNonLinearSolver.cpp.

  14:31:09      warning       petscError::logPetscTraceBackErrorHandler                    Implementation not yet completed
  14:31:09      warning       petscError::logPETScError                                    PetscErrorCode is: 85
  14:31:09      warning       petscError::logPETScError                                    Attention: no MPI abort for main or unknown function imitated!
[0]PETSC ERROR: --------------------- Error Message ------------------------------------
[0]PETSC ERROR: Operation done in wrong order!
[0]PETSC ERROR: Matrix not yet factored; call after KSPSetUp() or PCSetUp()!
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: Petsc Release Version 3.2.0, Patch 7, Thu Mar 15 09:30:51 CDT 2012 
[0]PETSC ERROR: See docs/changes/index.html for recent updates.
[0]PETSC ERROR: See docs/faq.html for hints about trouble shooting.
[0]PETSC ERROR: See docs/index.html for manual pages.
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: ./build/debug/dim2/fluid/peano-fluid on a petsc-3.2 named atsccs58 by liebm Thu May 31 14:31:04 2012
[0]PETSC ERROR: Libraries linked from /work_fast/liebm/petsc-3.2-serial-debug/lib
[0]PETSC ERROR: Configure run at Thu May 31 10:27:55 2012
[0]PETSC ERROR: Configure options --PETSC_ARCH=petsc-3.2-serial-debug --prefix=/work_fast/liebm/petsc-3.2-serial-debug --with-debugging=1 --with-cxx=gcc --with-fc=gfortran --with-cc=gcc --download-superlu=1 --with-mpi=0
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: PCFactorGetMatrix_Factor() line 176 in /work_fast/liebm/petsc-3.2-p7/src/ksp/pc/impls/factor/factimpl.c
[0]PETSC ERROR: PCFactorGetMatrix() line 1220 in /work_fast/liebm/petsc-3.2-p7/src/ksp/pc/interface/precon.c
  14:31:09      warning       petscError::logPETScError                                    Attention: no PetscErrorBaseMessage imitated!
[0]PETSC ERROR: --------------------- Error Message ------------------------------------
[0]PETSC ERROR: Operation done in wrong order!
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: Petsc Release Version 3.2.0, Patch 7, Thu Mar 15 09:30:51 CDT 2012 
[0]PETSC ERROR: See docs/changes/index.html for recent updates.
[0]PETSC ERROR: See docs/faq.html for hints about trouble shooting.
[0]PETSC ERROR: See docs/index.html for manual pages.
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: ./build/debug/dim2/fluid/peano-fluid on a petsc-3.2 named atsccs58 by liebm Thu May 31 14:31:04 2012
[0]PETSC ERROR: Libraries linked from /work_fast/liebm/petsc-3.2-serial-debug/lib
[0]PETSC ERROR: Configure run at Thu May 31 10:27:55 2012
[0]PETSC ERROR: Configure options --PETSC_ARCH=petsc-3.2-serial-debug --prefix=/work_fast/liebm/petsc-3.2-serial-debug --with-debugging=1 --with-cxx=gcc --with-fc=gfortran --with-cc=gcc --download-superlu=1 --with-mpi=0
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: peano::petsc::PETScNonLinearSolver::setupLinearSolver() line 367 in petscpetsc/PETScNonLinearSolver.cpp
  14:31:09      error         petscError::logPetscTraceBackErrorHandler                    Major PETSc error occured in function peano::petsc::PETScNonLinearSolver::setupLinearSolver, line 367, dir. petsc, file petsc/PETScNonLinearSolver.cpp.

  14:31:09      warning       petscError::logPetscTraceBackErrorHandler                    Implementation not yet completed
  14:31:09      warning       petscError::logPETScError                                    PetscErrorCode is: 58
  14:31:09      warning       petscError::logPETScError                                    Attention: no MPI abort for main or unknown function imitated!
[0]PETSC ERROR: --------------------- Error Message ------------------------------------
[0]PETSC ERROR: Corrupt argument: see http://www.mcs.anl.gov/petsc/petsc-as/documentation/faq.html#valgrind!
[0]PETSC ERROR: Invalid Pointer to Object: Parameter # 1!
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: Petsc Release Version 3.2.0, Patch 7, Thu Mar 15 09:30:51 CDT 2012 
[0]PETSC ERROR: See docs/changes/index.html for recent updates.
[0]PETSC ERROR: See docs/faq.html for hints about trouble shooting.
[0]PETSC ERROR: See docs/index.html for manual pages.
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: ./build/debug/dim2/fluid/peano-fluid on a petsc-3.2 named atsccs58 by liebm Thu May 31 14:31:04 2012
[0]PETSC ERROR: Libraries linked from /work_fast/liebm/petsc-3.2-serial-debug/lib
[0]PETSC ERROR: Configure run at Thu May 31 10:27:55 2012
[0]PETSC ERROR: Configure options --PETSC_ARCH=petsc-3.2-serial-debug --prefix=/work_fast/liebm/petsc-3.2-serial-debug --with-debugging=1 --with-cxx=gcc --with-fc=gfortran --with-cc=gcc --download-superlu=1 --with-mpi=0
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: MatSuperluSetILUDropTol() line 455 in /work_fast/liebm/petsc-3.2-p7/src/mat/impls/aij/seq/superlu/superlu.c
  14:31:09      warning       petscError::logPETScError                                    Attention: no PetscErrorBaseMessage imitated!
[0]PETSC ERROR: --------------------- Error Message ------------------------------------
[0]PETSC ERROR: Corrupt argument: see http://www.mcs.anl.gov/petsc/petsc-as/documentation/faq.html#valgrind!
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: Petsc Release Version 3.2.0, Patch 7, Thu Mar 15 09:30:51 CDT 2012 
[0]PETSC ERROR: See docs/changes/index.html for recent updates.
[0]PETSC ERROR: See docs/faq.html for hints about trouble shooting.
[0]PETSC ERROR: See docs/index.html for manual pages.
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: ./build/debug/dim2/fluid/peano-fluid on a petsc-3.2 named atsccs58 by liebm Thu May 31 14:31:04 2012
[0]PETSC ERROR: Libraries linked from /work_fast/liebm/petsc-3.2-serial-debug/lib
[0]PETSC ERROR: Configure run at Thu May 31 10:27:55 2012
[0]PETSC ERROR: Configure options --PETSC_ARCH=petsc-3.2-serial-debug --prefix=/work_fast/liebm/petsc-3.2-serial-debug --with-debugging=1 --with-cxx=gcc --with-fc=gfortran --with-cc=gcc --download-superlu=1 --with-mpi=0
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: peano::petsc::PETScNonLinearSolver::setupLinearSolver() line 369 in petscpetsc/PETScNonLinearSolver.cpp
  14:31:09      error         petscError::logPetscTraceBackErrorHandler                    Major PETSc error occured in function peano::petsc::PETScNonLinearSolver::setupLinearSolver, line 369, dir. petsc, file petsc/PETScNonLinearSolver.cpp.

  14:31:09      warning       petscError::logPetscTraceBackErrorHandler                    Implementation not yet completed
  14:31:09      warning       petscError::logPETScError                                    PetscErrorCode is: 64
  14:31:09      warning       petscError::logPETScError                                    Attention: no MPI abort for main or unknown function imitated!
  14:31:09      info          peano::ode::ODESolver::solve()                               starting time integration. StartTime=0, endTime=1, startTimeStepNr=1, endTimeStepNr=1
  14:31:09      info          peano::fluid::NonLinearTrivialgridFluidSimulation::computeNavierStokesFunction()      runtime for B-evaluation: 0.01 (CPU time), 0.00466967 (calendar time)
  14:31:09      info          peano::petsc::PETScNonLinearEquations::monitorNonLinearSolver()      residual norm at iteration 0: 1.18128e-13; LinearIterations: 0
  14:31:09      info          peano::petsc::PETScNonLinearEquations::jacobianGrid()        iteration started.
  14:31:09      info          peano::fluid::NonLinearTrivialgridFluidSimulation::computeNavierStokesJacobian()      runtime for Jacobian: 0.03 (CPU time), 0.0290048 (calendar time)
  14:31:09      info          peano::fluid::NonLinearTrivialgridFluidSimulation::computeNavierStokesFunction()      runtime for B-evaluation: 0.01 (CPU time), 0.00472021 (calendar time)
  14:31:09      info          peano::petsc::PETScNonLinearEquations::monitorNonLinearSolver()      residual norm at iteration 1: 7.45947e-16; LinearIterations: 1
  14:31:09      info          peano::petsc::PETScNonLinearSolver::solve()                  NLGS solver completed in 1 iterations; conv. reason=4
  14:31:09      info          peano::petsc::PETScNonLinearSolver::solve()                  NLGS solver converged!
  14:31:09      info          peano::fluid::FluidSimulation::solveNonLinearSystem()        non-linear solution completed with iterations:1
  14:31:09      info          UserInterface::writeFluidTimeStepInfo(...)                   |    1       |    1.00000e-03  |   -nan  |   -nan  |   0.00000e+00  |   0.00000e+00  |   -nan  |   -nan  |   0.00000e+00  |   0.00000e+00  |   2.90332e-13  |   -1    |   9   |   6     |  7.00000e-02     |  3     |  1.00000e-02     |  288  |   0.00000e+00, 0.00000e+00, 
  14:31:09      info          peano::fluid::SteadyStateIntegrationTestChannel::testTrivialgrid3x3FreeChannelTwoPreSteps()      testTrivialgrid3x3FreeChannelTwoPreSteps(FINITEDIFF) OK

test testTrivialgrid9x9ObstacleInChannelNoPreSteps(JACOBIAN_ASSEMBLING_ANALYTICAL)
  14:31:09      info          peano::fluid::SteadyStateIntegrationTestChannel::testTrivialgrid9x9ObstacleInChannelNoPreSteps(ANALYTICAL)      running test case
  14:31:09      info          peano::fluid::AbstractCalculateF::AbstractCalculateF()       using gravity with values: 0, 0
  14:31:09      info          peano::trivialgrid::TrivialgridDataContainer::allocateMemory()      allocate grid with 100 vertex dofs and 81 cell dofs
  14:31:09      info          peano::trivialgrid::Trivialgrid::Trivialgrid(...)            Trivialgrid(): number of grid points: 10, 10, domain size: 1, 1, domain offset: 0, 0
  14:31:09      info          peano::fluid::TrivialgridFluidRunner::createJacobianAdapterAndTrivialgrid()      creating Jacobian instances for assembling type: ANALYTICAL (matrix-free=0)
  14:31:09      warning       peano::ode::ODESolver::checkSettings()                       no restart writing in use!
[0]PETSC ERROR: --------------------- Error Message ------------------------------------
[0]PETSC ERROR: Null argument, when expecting valid pointer!
[0]PETSC ERROR: Null Object: Parameter # 1!
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: Petsc Release Version 3.2.0, Patch 7, Thu Mar 15 09:30:51 CDT 2012 
[0]PETSC ERROR: See docs/changes/index.html for recent updates.
[0]PETSC ERROR: See docs/faq.html for hints about trouble shooting.
[0]PETSC ERROR: See docs/index.html for manual pages.
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: ./build/debug/dim2/fluid/peano-fluid on a petsc-3.2 named atsccs58 by liebm Thu May 31 14:31:04 2012
[0]PETSC ERROR: Libraries linked from /work_fast/liebm/petsc-3.2-serial-debug/lib
[0]PETSC ERROR: Configure run at Thu May 31 10:27:55 2012
[0]PETSC ERROR: Configure options --PETSC_ARCH=petsc-3.2-serial-debug --prefix=/work_fast/liebm/petsc-3.2-serial-debug --with-debugging=1 --with-cxx=gcc --with-fc=gfortran --with-cc=gcc --download-superlu=1 --with-mpi=0
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: MatGetFactor() line 3929 in /work_fast/liebm/petsc-3.2-p7/src/mat/interface/matrix.c
[0]PETSC ERROR: PCFactorSetUpMatSolverPackage_Factor() line 17 in /work_fast/liebm/petsc-3.2-p7/src/ksp/pc/impls/factor/factimpl.c
[0]PETSC ERROR: PCFactorSetUpMatSolverPackage() line 26 in /work_fast/liebm/petsc-3.2-p7/src/ksp/pc/impls/factor/factor.c
  14:31:09      info          peano::fluid::FluidSimulation::runFluidSimulation()          preparing the grid
  14:31:09      info          peano::fluid::TrivialgridFluidSimulation::parseGeometry()      starting geometry parsing
  14:31:10      info          peano::fluid::FluidSimulation::runFluidSimulation()          counting the inner cells and setting boundary conditions
  14:31:10      info          peano::fluid::TrivialgridFluidSimulation::updateGrid         updating grid...
  14:31:12      info          peano::fluid::FluidSimulation::implementSetInitialValue()      assembling the matrix
  14:31:12      info          peano::fluid::TrivialgridFluidSimulation::createPETScSolver()      PETSc KSP Object info: , type: cg, maximum iterations=10000, rtol=1e-07, atol=1e-07, divtol=10000, left precond.; PETSc PC Object info: , type: jacobi, 
  14:31:12      info          peano::fluid::TrivialgridFluidSimulation::assembleMatrix()::Assemble Q iteration      total number of clock ticks within block (cpu-time,calendar-time): (0.03s,0.0306334s)
  14:31:12      info          peano::fluid::FluidSimulation::implementSetInitialValue()      memory consumption after matrix assemblation: 289 MB
  14:31:12      info          peano::fluid::FluidSimulation::implementSetInitialValue()      global time for matrix assemblation:
  14:31:12      info          FluidSimulation::implementSetInitialValue()                  total number of clock ticks within block (cpu-time,calendar-time): (0.03s,0.0383279s)
  14:31:12      info          peano::fluid::TrivialgridEventHandle2VTKWriter4FluidAdapter::endIteration      
Accumulated and integrated outflow is: 0

  14:31:12      info          UserInterface::writeFluidTimeStepInfoHeader()                || time step || T_sim total   || norm(du/u)_2h || norm(du/u)_max|| norm(du)_2h   || norm(du)_max  || norm(dp/p)_2h || norm(dp/p)_max|| norm(dp)_2h   || norm(dp)_max  || resdiuum      || depth || \#cells || \#dofNodes || cpu sec./step || \#its/LGS-sol.  || cpu sec./LGS-sol. || mem usage MB || f_glob on nr. 4
  14:31:12      info          peano::fluid::NonLinearTrivialgridFluidSimulation::implementSetInitialValue()      starting pseudo-timestepping with 0 steps and specified step size=0.001
  14:31:12      warning       petscError::logPETScError                                    Attention: no PetscErrorBaseMessage imitated!
[0]PETSC ERROR: --------------------- Error Message ------------------------------------
[0]PETSC ERROR: Null argument, when expecting valid pointer!
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: Petsc Release Version 3.2.0, Patch 7, Thu Mar 15 09:30:51 CDT 2012 
[0]PETSC ERROR: See docs/changes/index.html for recent updates.
[0]PETSC ERROR: See docs/faq.html for hints about trouble shooting.
[0]PETSC ERROR: See docs/index.html for manual pages.
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: ./build/debug/dim2/fluid/peano-fluid on a petsc-3.2 named atsccs58 by liebm Thu May 31 14:31:04 2012
[0]PETSC ERROR: Libraries linked from /work_fast/liebm/petsc-3.2-serial-debug/lib
[0]PETSC ERROR: Configure run at Thu May 31 10:27:55 2012
[0]PETSC ERROR: Configure options --PETSC_ARCH=petsc-3.2-serial-debug --prefix=/work_fast/liebm/petsc-3.2-serial-debug --with-debugging=1 --with-cxx=gcc --with-fc=gfortran --with-cc=gcc --download-superlu=1 --with-mpi=0
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: peano::petsc::PETScNonLinearSolver::setupLinearSolver() line 365 in petscpetsc/PETScNonLinearSolver.cpp
  14:31:12      error         petscError::logPetscTraceBackErrorHandler                    Major PETSc error occured in function peano::petsc::PETScNonLinearSolver::setupLinearSolver, line 365, dir. petsc, file petsc/PETScNonLinearSolver.cpp.

  14:31:12      warning       petscError::logPetscTraceBackErrorHandler                    Implementation not yet completed
  14:31:12      warning       petscError::logPETScError                                    PetscErrorCode is: 85
  14:31:12      warning       petscError::logPETScError                                    Attention: no MPI abort for main or unknown function imitated!
[0]PETSC ERROR: --------------------- Error Message ------------------------------------
[0]PETSC ERROR: Operation done in wrong order!
[0]PETSC ERROR: Matrix not yet factored; call after KSPSetUp() or PCSetUp()!
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: Petsc Release Version 3.2.0, Patch 7, Thu Mar 15 09:30:51 CDT 2012 
[0]PETSC ERROR: See docs/changes/index.html for recent updates.
[0]PETSC ERROR: See docs/faq.html for hints about trouble shooting.
[0]PETSC ERROR: See docs/index.html for manual pages.
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: ./build/debug/dim2/fluid/peano-fluid on a petsc-3.2 named atsccs58 by liebm Thu May 31 14:31:04 2012
[0]PETSC ERROR: Libraries linked from /work_fast/liebm/petsc-3.2-serial-debug/lib
[0]PETSC ERROR: Configure run at Thu May 31 10:27:55 2012
[0]PETSC ERROR: Configure options --PETSC_ARCH=petsc-3.2-serial-debug --prefix=/work_fast/liebm/petsc-3.2-serial-debug --with-debugging=1 --with-cxx=gcc --with-fc=gfortran --with-cc=gcc --download-superlu=1 --with-mpi=0
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: PCFactorGetMatrix_Factor() line 176 in /work_fast/liebm/petsc-3.2-p7/src/ksp/pc/impls/factor/factimpl.c
[0]PETSC ERROR: PCFactorGetMatrix() line 1220 in /work_fast/liebm/petsc-3.2-p7/src/ksp/pc/interface/precon.c
  14:31:12      warning       petscError::logPETScError                                    Attention: no PetscErrorBaseMessage imitated!
[0]PETSC ERROR: --------------------- Error Message ------------------------------------
[0]PETSC ERROR: Operation done in wrong order!
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: Petsc Release Version 3.2.0, Patch 7, Thu Mar 15 09:30:51 CDT 2012 
[0]PETSC ERROR: See docs/changes/index.html for recent updates.
[0]PETSC ERROR: See docs/faq.html for hints about trouble shooting.
[0]PETSC ERROR: See docs/index.html for manual pages.
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: ./build/debug/dim2/fluid/peano-fluid on a petsc-3.2 named atsccs58 by liebm Thu May 31 14:31:04 2012
[0]PETSC ERROR: Libraries linked from /work_fast/liebm/petsc-3.2-serial-debug/lib
[0]PETSC ERROR: Configure run at Thu May 31 10:27:55 2012
[0]PETSC ERROR: Configure options --PETSC_ARCH=petsc-3.2-serial-debug --prefix=/work_fast/liebm/petsc-3.2-serial-debug --with-debugging=1 --with-cxx=gcc --with-fc=gfortran --with-cc=gcc --download-superlu=1 --with-mpi=0
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: peano::petsc::PETScNonLinearSolver::setupLinearSolver() line 367 in petscpetsc/PETScNonLinearSolver.cpp
  14:31:12      error         petscError::logPetscTraceBackErrorHandler                    Major PETSc error occured in function peano::petsc::PETScNonLinearSolver::setupLinearSolver, line 367, dir. petsc, file petsc/PETScNonLinearSolver.cpp.

  14:31:12      warning       petscError::logPetscTraceBackErrorHandler                    Implementation not yet completed
  14:31:12      warning       petscError::logPETScError                                    PetscErrorCode is: 58
  14:31:12      warning       petscError::logPETScError                                    Attention: no MPI abort for main or unknown function imitated!
[0]PETSC ERROR: --------------------- Error Message ------------------------------------
[0]PETSC ERROR: Corrupt argument: see http://www.mcs.anl.gov/petsc/petsc-as/documentation/faq.html#valgrind!
[0]PETSC ERROR: Invalid Pointer to Object: Parameter # 1!
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: Petsc Release Version 3.2.0, Patch 7, Thu Mar 15 09:30:51 CDT 2012 
[0]PETSC ERROR: See docs/changes/index.html for recent updates.
[0]PETSC ERROR: See docs/faq.html for hints about trouble shooting.
[0]PETSC ERROR: See docs/index.html for manual pages.
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: ./build/debug/dim2/fluid/peano-fluid on a petsc-3.2 named atsccs58 by liebm Thu May 31 14:31:04 2012
[0]PETSC ERROR: Libraries linked from /work_fast/liebm/petsc-3.2-serial-debug/lib
[0]PETSC ERROR: Configure run at Thu May 31 10:27:55 2012
[0]PETSC ERROR: Configure options --PETSC_ARCH=petsc-3.2-serial-debug --prefix=/work_fast/liebm/petsc-3.2-serial-debug --with-debugging=1 --with-cxx=gcc --with-fc=gfortran --with-cc=gcc --download-superlu=1 --with-mpi=0
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: MatSuperluSetILUDropTol() line 455 in /work_fast/liebm/petsc-3.2-p7/src/mat/impls/aij/seq/superlu/superlu.c
  14:31:12      warning       petscError::logPETScError                                    Attention: no PetscErrorBaseMessage imitated!
[0]PETSC ERROR: --------------------- Error Message ------------------------------------
[0]PETSC ERROR: Corrupt argument: see http://www.mcs.anl.gov/petsc/petsc-as/documentation/faq.html#valgrind!
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: Petsc Release Version 3.2.0, Patch 7, Thu Mar 15 09:30:51 CDT 2012 
[0]PETSC ERROR: See docs/changes/index.html for recent updates.
[0]PETSC ERROR: See docs/faq.html for hints about trouble shooting.
[0]PETSC ERROR: See docs/index.html for manual pages.
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: ./build/debug/dim2/fluid/peano-fluid on a petsc-3.2 named atsccs58 by liebm Thu May 31 14:31:04 2012
[0]PETSC ERROR: Libraries linked from /work_fast/liebm/petsc-3.2-serial-debug/lib
[0]PETSC ERROR: Configure run at Thu May 31 10:27:55 2012
[0]PETSC ERROR: Configure options --PETSC_ARCH=petsc-3.2-serial-debug --prefix=/work_fast/liebm/petsc-3.2-serial-debug --with-debugging=1 --with-cxx=gcc --with-fc=gfortran --with-cc=gcc --download-superlu=1 --with-mpi=0
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: peano::petsc::PETScNonLinearSolver::setupLinearSolver() line 369 in petscpetsc/PETScNonLinearSolver.cpp
  14:31:12      error         petscError::logPetscTraceBackErrorHandler                    Major PETSc error occured in function peano::petsc::PETScNonLinearSolver::setupLinearSolver, line 369, dir. petsc, file petsc/PETScNonLinearSolver.cpp.

  14:31:12      warning       petscError::logPetscTraceBackErrorHandler                    Implementation not yet completed
  14:31:12      warning       petscError::logPETScError                                    PetscErrorCode is: 64
  14:31:12      warning       petscError::logPETScError                                    Attention: no MPI abort for main or unknown function imitated!
  14:31:12      info          peano::fluid::TrivialgridEventHandle2VTKWriter4FluidAdapter::endIteration      
Accumulated and integrated outflow is: 0

  14:31:12      info          peano::ode::ODESolver::solve()                               starting time integration. StartTime=0, endTime=1, startTimeStepNr=1, endTimeStepNr=1
  14:31:12      info          peano::fluid::NonLinearTrivialgridFluidSimulation::computeNavierStokesFunction()      runtime for B-evaluation: 0.04 (CPU time), 0.0394928 (calendar time)
  14:31:12      info          peano::petsc::PETScNonLinearEquations::monitorNonLinearSolver()      residual norm at iteration 0: 3.24893; LinearIterations: 0
  14:31:12      info          peano::fluid::TrivialgridEventHandle2VTKWriter4FluidAdapter::endIteration      
Accumulated and integrated outflow is: 0

  14:31:12      info          peano::petsc::PETScNonLinearEquations::jacobianGrid()        iteration started.
  14:31:12      info          peano::fluid::NonLinearTrivialgridFluidSimulation::computeNavierStokesJacobian()      runtime for Jacobian: 0.08 (CPU time), 0.0848253 (calendar time)
  14:31:12      info          peano::fluid::NonLinearTrivialgridFluidSimulation::computeNavierStokesFunction()      runtime for B-evaluation: 0.04 (CPU time), 0.0393052 (calendar time)
  14:31:12      info          peano::petsc::PETScNonLinearEquations::monitorNonLinearSolver()      residual norm at iteration 1: 0.445035; LinearIterations: 2
  14:31:13      info          peano::fluid::TrivialgridEventHandle2VTKWriter4FluidAdapter::endIteration      
Accumulated and integrated outflow is: 0

  14:31:13      info          peano::petsc::PETScNonLinearEquations::jacobianGrid()        iteration started.
  14:31:13      info          peano::fluid::NonLinearTrivialgridFluidSimulation::computeNavierStokesJacobian()      runtime for Jacobian: 0.07 (CPU time), 0.0622749 (calendar time)
  14:31:13      info          peano::fluid::NonLinearTrivialgridFluidSimulation::computeNavierStokesFunction()      runtime for B-evaluation: 0.04 (CPU time), 0.0393724 (calendar time)
  14:31:13      info          peano::petsc::PETScNonLinearEquations::monitorNonLinearSolver()      residual norm at iteration 2: 6.48912e-05; LinearIterations: 7
  14:31:13      info          peano::fluid::TrivialgridEventHandle2VTKWriter4FluidAdapter::endIteration      
Accumulated and integrated outflow is: 0

  14:31:13      info          peano::petsc::PETScNonLinearEquations::jacobianGrid()        iteration started.
  14:31:13      info          peano::fluid::NonLinearTrivialgridFluidSimulation::computeNavierStokesJacobian()      runtime for Jacobian: 0.06 (CPU time), 0.0622993 (calendar time)
  14:31:13      info          peano::fluid::NonLinearTrivialgridFluidSimulation::computeNavierStokesFunction()      runtime for B-evaluation: 0.04 (CPU time), 0.0419505 (calendar time)
  14:31:13      info          peano::petsc::PETScNonLinearEquations::monitorNonLinearSolver()      residual norm at iteration 3: 3.69087e-13; LinearIterations: 12
  14:31:13      info          peano::fluid::TrivialgridEventHandle2VTKWriter4FluidAdapter::endIteration      
Accumulated and integrated outflow is: 0

  14:31:13      info          peano::petsc::PETScNonLinearSolver::solve()                  NLGS solver completed in 3 iterations; conv. reason=3
  14:31:13      info          peano::petsc::PETScNonLinearSolver::solve()                  NLGS solver converged!
  14:31:13      info          peano::fluid::FluidSimulation::solveNonLinearSystem()        non-linear solution completed with iterations:3
  14:31:13      info          peano::fluid::TrivialgridEventHandle2VTKWriter4FluidAdapter::endIteration      
Accumulated and integrated outflow is: 0

  14:31:13      info          UserInterface::writeFluidTimeStepInfo(...)                   |    1       |    1.00000e-03  |   0.00000e+00  |   0.00000e+00  |   0.00000e+00  |   0.00000e+00  |   -nan  |   -nan  |   0.00000e+00  |   0.00000e+00  |   -1.00000e+00  |   -1    |   72   |   56     |  8.70000e-01     |  -1     |  -1.00000e+00     |  290  |   8.54262e+01, -7.99361e-15, 
  14:31:13      info          peano::fluid::SteadyStateIntegrationTestChannel::testTrivialgrid9x9ObstacleInChannelNoPreSteps()      testTrivialgrid9x9ObstacleInChannelNoPreSteps(ANALYTICAL) OK

test testTrivialgrid9x9ObstacleInChannelNoPreSteps(JACOBIAN_ASSEMBLING_FINITEDIFF)
  14:31:13      info          peano::fluid::SteadyStateIntegrationTestChannel::testTrivialgrid9x9ObstacleInChannelNoPreSteps(FINITEDIFF)      running test case
  14:31:13      info          peano::fluid::AbstractCalculateF::AbstractCalculateF()       using gravity with values: 0, 0
  14:31:13      info          peano::trivialgrid::TrivialgridDataContainer::allocateMemory()      allocate grid with 100 vertex dofs and 81 cell dofs
  14:31:13      info          peano::trivialgrid::Trivialgrid::Trivialgrid(...)            Trivialgrid(): number of grid points: 10, 10, domain size: 1, 1, domain offset: 0, 0
  14:31:13      info          peano::fluid::TrivialgridFluidRunner::createJacobianAdapterAndTrivialgrid()      creating Jacobian instances for assembling type: ANALYTICAL (matrix-free=0)
  14:31:13      warning       peano::ode::ODESolver::checkSettings()                       no restart writing in use!
[0]PETSC ERROR: --------------------- Error Message ------------------------------------
[0]PETSC ERROR: Null argument, when expecting valid pointer!
[0]PETSC ERROR: Null Object: Parameter # 1!
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: Petsc Release Version 3.2.0, Patch 7, Thu Mar 15 09:30:51 CDT 2012 
[0]PETSC ERROR: See docs/changes/index.html for recent updates.
[0]PETSC ERROR: See docs/faq.html for hints about trouble shooting.
[0]PETSC ERROR: See docs/index.html for manual pages.
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: ./build/debug/dim2/fluid/peano-fluid on a petsc-3.2 named atsccs58 by liebm Thu May 31 14:31:04 2012
[0]PETSC ERROR: Libraries linked from /work_fast/liebm/petsc-3.2-serial-debug/lib
[0]PETSC ERROR: Configure run at Thu May 31 10:27:55 2012
[0]PETSC ERROR: Configure options --PETSC_ARCH=petsc-3.2-serial-debug --prefix=/work_fast/liebm/petsc-3.2-serial-debug --with-debugging=1 --with-cxx=gcc --with-fc=gfortran --with-cc=gcc --download-superlu=1 --with-mpi=0
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: MatGetFactor() line 3929 in /work_fast/liebm/petsc-3.2-p7/src/mat/interface/matrix.c
[0]PETSC ERROR: PCFactorSetUpMatSolverPackage_Factor() line 17 in /work_fast/liebm/petsc-3.2-p7/src/ksp/pc/impls/factor/factimpl.c
[0]PETSC ERROR: PCFactorSetUpMatSolverPackage() line 26 in /work_fast/liebm/petsc-3.2-p7/src/ksp/pc/impls/factor/factor.c
  14:31:13      info          peano::fluid::FluidSimulation::runFluidSimulation()          preparing the grid
  14:31:13      info          peano::fluid::TrivialgridFluidSimulation::parseGeometry()      starting geometry parsing
  14:31:14      info          peano::fluid::FluidSimulation::runFluidSimulation()          counting the inner cells and setting boundary conditions
  14:31:14      info          peano::fluid::TrivialgridFluidSimulation::updateGrid         updating grid...
  14:31:16      info          peano::fluid::FluidSimulation::implementSetInitialValue()      assembling the matrix
  14:31:16      info          peano::fluid::TrivialgridFluidSimulation::createPETScSolver()      PETSc KSP Object info: , type: cg, maximum iterations=10000, rtol=1e-07, atol=1e-07, divtol=10000, left precond.; PETSc PC Object info: , type: jacobi, 
  14:31:16      info          peano::fluid::TrivialgridFluidSimulation::assembleMatrix()::Assemble Q iteration      total number of clock ticks within block (cpu-time,calendar-time): (0.03s,0.0327389s)
  14:31:16      info          peano::fluid::FluidSimulation::implementSetInitialValue()      memory consumption after matrix assemblation: 290 MB
  14:31:16      info          peano::fluid::FluidSimulation::implementSetInitialValue()      global time for matrix assemblation:
  14:31:16      info          FluidSimulation::implementSetInitialValue()                  total number of clock ticks within block (cpu-time,calendar-time): (0.04s,0.0402725s)
  14:31:16      info          peano::fluid::TrivialgridEventHandle2VTKWriter4FluidAdapter::endIteration      
Accumulated and integrated outflow is: 0

  14:31:16      info          UserInterface::writeFluidTimeStepInfoHeader()                || time step || T_sim total   || norm(du/u)_2h || norm(du/u)_max|| norm(du)_2h   || norm(du)_max  || norm(dp/p)_2h || norm(dp/p)_max|| norm(dp)_2h   || norm(dp)_max  || resdiuum      || depth || \#cells || \#dofNodes || cpu sec./step || \#its/LGS-sol.  || cpu sec./LGS-sol. || mem usage MB || f_glob on nr. 4
  14:31:16      info          peano::fluid::NonLinearTrivialgridFluidSimulation::implementSetInitialValue()      starting pseudo-timestepping with 0 steps and specified step size=0.001
  14:31:16      warning       petscError::logPETScError                                    Attention: no PetscErrorBaseMessage imitated!
[0]PETSC ERROR: --------------------- Error Message ------------------------------------
[0]PETSC ERROR: Null argument, when expecting valid pointer!
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: Petsc Release Version 3.2.0, Patch 7, Thu Mar 15 09:30:51 CDT 2012 
[0]PETSC ERROR: See docs/changes/index.html for recent updates.
[0]PETSC ERROR: See docs/faq.html for hints about trouble shooting.
[0]PETSC ERROR: See docs/index.html for manual pages.
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: ./build/debug/dim2/fluid/peano-fluid on a petsc-3.2 named atsccs58 by liebm Thu May 31 14:31:04 2012
[0]PETSC ERROR: Libraries linked from /work_fast/liebm/petsc-3.2-serial-debug/lib
[0]PETSC ERROR: Configure run at Thu May 31 10:27:55 2012
[0]PETSC ERROR: Configure options --PETSC_ARCH=petsc-3.2-serial-debug --prefix=/work_fast/liebm/petsc-3.2-serial-debug --with-debugging=1 --with-cxx=gcc --with-fc=gfortran --with-cc=gcc --download-superlu=1 --with-mpi=0
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: peano::petsc::PETScNonLinearSolver::setupLinearSolver() line 365 in petscpetsc/PETScNonLinearSolver.cpp
  14:31:16      error         petscError::logPetscTraceBackErrorHandler                    Major PETSc error occured in function peano::petsc::PETScNonLinearSolver::setupLinearSolver, line 365, dir. petsc, file petsc/PETScNonLinearSolver.cpp.

  14:31:16      warning       petscError::logPetscTraceBackErrorHandler                    Implementation not yet completed
  14:31:16      warning       petscError::logPETScError                                    PetscErrorCode is: 85
  14:31:16      warning       petscError::logPETScError                                    Attention: no MPI abort for main or unknown function imitated!
[0]PETSC ERROR: --------------------- Error Message ------------------------------------
[0]PETSC ERROR: Operation done in wrong order!
[0]PETSC ERROR: Matrix not yet factored; call after KSPSetUp() or PCSetUp()!
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: Petsc Release Version 3.2.0, Patch 7, Thu Mar 15 09:30:51 CDT 2012 
[0]PETSC ERROR: See docs/changes/index.html for recent updates.
[0]PETSC ERROR: See docs/faq.html for hints about trouble shooting.
[0]PETSC ERROR: See docs/index.html for manual pages.
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: ./build/debug/dim2/fluid/peano-fluid on a petsc-3.2 named atsccs58 by liebm Thu May 31 14:31:04 2012
[0]PETSC ERROR: Libraries linked from /work_fast/liebm/petsc-3.2-serial-debug/lib
[0]PETSC ERROR: Configure run at Thu May 31 10:27:55 2012
[0]PETSC ERROR: Configure options --PETSC_ARCH=petsc-3.2-serial-debug --prefix=/work_fast/liebm/petsc-3.2-serial-debug --with-debugging=1 --with-cxx=gcc --with-fc=gfortran --with-cc=gcc --download-superlu=1 --with-mpi=0
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: PCFactorGetMatrix_Factor() line 176 in /work_fast/liebm/petsc-3.2-p7/src/ksp/pc/impls/factor/factimpl.c
[0]PETSC ERROR: PCFactorGetMatrix() line 1220 in /work_fast/liebm/petsc-3.2-p7/src/ksp/pc/interface/precon.c
  14:31:16      warning       petscError::logPETScError                                    Attention: no PetscErrorBaseMessage imitated!
[0]PETSC ERROR: --------------------- Error Message ------------------------------------
[0]PETSC ERROR: Operation done in wrong order!
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: Petsc Release Version 3.2.0, Patch 7, Thu Mar 15 09:30:51 CDT 2012 
[0]PETSC ERROR: See docs/changes/index.html for recent updates.
[0]PETSC ERROR: See docs/faq.html for hints about trouble shooting.
[0]PETSC ERROR: See docs/index.html for manual pages.
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: ./build/debug/dim2/fluid/peano-fluid on a petsc-3.2 named atsccs58 by liebm Thu May 31 14:31:04 2012
[0]PETSC ERROR: Libraries linked from /work_fast/liebm/petsc-3.2-serial-debug/lib
[0]PETSC ERROR: Configure run at Thu May 31 10:27:55 2012
[0]PETSC ERROR: Configure options --PETSC_ARCH=petsc-3.2-serial-debug --prefix=/work_fast/liebm/petsc-3.2-serial-debug --with-debugging=1 --with-cxx=gcc --with-fc=gfortran --with-cc=gcc --download-superlu=1 --with-mpi=0
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: peano::petsc::PETScNonLinearSolver::setupLinearSolver() line 367 in petscpetsc/PETScNonLinearSolver.cpp
  14:31:16      error         petscError::logPetscTraceBackErrorHandler                    Major PETSc error occured in function peano::petsc::PETScNonLinearSolver::setupLinearSolver, line 367, dir. petsc, file petsc/PETScNonLinearSolver.cpp.

  14:31:16      warning       petscError::logPetscTraceBackErrorHandler                    Implementation not yet completed
  14:31:16      warning       petscError::logPETScError                                    PetscErrorCode is: 58
  14:31:16      warning       petscError::logPETScError                                    Attention: no MPI abort for main or unknown function imitated!
[0]PETSC ERROR: --------------------- Error Message ------------------------------------
[0]PETSC ERROR: Corrupt argument: see http://www.mcs.anl.gov/petsc/petsc-as/documentation/faq.html#valgrind!
[0]PETSC ERROR: Invalid Pointer to Object: Parameter # 1!
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: Petsc Release Version 3.2.0, Patch 7, Thu Mar 15 09:30:51 CDT 2012 
[0]PETSC ERROR: See docs/changes/index.html for recent updates.
[0]PETSC ERROR: See docs/faq.html for hints about trouble shooting.
[0]PETSC ERROR: See docs/index.html for manual pages.
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: ./build/debug/dim2/fluid/peano-fluid on a petsc-3.2 named atsccs58 by liebm Thu May 31 14:31:04 2012
[0]PETSC ERROR: Libraries linked from /work_fast/liebm/petsc-3.2-serial-debug/lib
[0]PETSC ERROR: Configure run at Thu May 31 10:27:55 2012
[0]PETSC ERROR: Configure options --PETSC_ARCH=petsc-3.2-serial-debug --prefix=/work_fast/liebm/petsc-3.2-serial-debug --with-debugging=1 --with-cxx=gcc --with-fc=gfortran --with-cc=gcc --download-superlu=1 --with-mpi=0
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: MatSuperluSetILUDropTol() line 455 in /work_fast/liebm/petsc-3.2-p7/src/mat/impls/aij/seq/superlu/superlu.c
  14:31:16      warning       petscError::logPETScError                                    Attention: no PetscErrorBaseMessage imitated!
[0]PETSC ERROR: --------------------- Error Message ------------------------------------
[0]PETSC ERROR: Corrupt argument: see http://www.mcs.anl.gov/petsc/petsc-as/documentation/faq.html#valgrind!
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: Petsc Release Version 3.2.0, Patch 7, Thu Mar 15 09:30:51 CDT 2012 
[0]PETSC ERROR: See docs/changes/index.html for recent updates.
[0]PETSC ERROR: See docs/faq.html for hints about trouble shooting.
[0]PETSC ERROR: See docs/index.html for manual pages.
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: ./build/debug/dim2/fluid/peano-fluid on a petsc-3.2 named atsccs58 by liebm Thu May 31 14:31:04 2012
[0]PETSC ERROR: Libraries linked from /work_fast/liebm/petsc-3.2-serial-debug/lib
[0]PETSC ERROR: Configure run at Thu May 31 10:27:55 2012
[0]PETSC ERROR: Configure options --PETSC_ARCH=petsc-3.2-serial-debug --prefix=/work_fast/liebm/petsc-3.2-serial-debug --with-debugging=1 --with-cxx=gcc --with-fc=gfortran --with-cc=gcc --download-superlu=1 --with-mpi=0
[0]PETSC ERROR: ------------------------------------------------------------------------
[0]PETSC ERROR: peano::petsc::PETScNonLinearSolver::setupLinearSolver() line 369 in petscpetsc/PETScNonLinearSolver.cpp
  14:31:16      error         petscError::logPetscTraceBackErrorHandler                    Major PETSc error occured in function peano::petsc::PETScNonLinearSolver::setupLinearSolver, line 369, dir. petsc, file petsc/PETScNonLinearSolver.cpp.

  14:31:16      warning       petscError::logPetscTraceBackErrorHandler                    Implementation not yet completed
  14:31:16      warning       petscError::logPETScError                                    PetscErrorCode is: 64
  14:31:16      warning       petscError::logPETScError                                    Attention: no MPI abort for main or unknown function imitated!
  14:31:16      info          peano::fluid::TrivialgridEventHandle2VTKWriter4FluidAdapter::endIteration      
Accumulated and integrated outflow is: 0

  14:31:16      info          peano::ode::ODESolver::solve()                               starting time integration. StartTime=0, endTime=1, startTimeStepNr=1, endTimeStepNr=1
  14:31:16      info          peano::fluid::NonLinearTrivialgridFluidSimulation::computeNavierStokesFunction()      runtime for B-evaluation: 0.04 (CPU time), 0.0396516 (calendar time)
  14:31:16      info          peano::petsc::PETScNonLinearEquations::monitorNonLinearSolver()      residual norm at iteration 0: 3.24893; LinearIterations: 0
  14:31:16      info          peano::fluid::TrivialgridEventHandle2VTKWriter4FluidAdapter::endIteration      
Accumulated and integrated outflow is: 0

  14:31:16      info          peano::petsc::PETScNonLinearEquations::jacobianGrid()        iteration started.
  14:31:17      info          peano::fluid::NonLinearTrivialgridFluidSimulation::computeNavierStokesJacobian()      runtime for Jacobian: 0.06 (CPU time), 0.0622516 (calendar time)
  14:31:17      info          peano::fluid::NonLinearTrivialgridFluidSimulation::computeNavierStokesFunction()      runtime for B-evaluation: 0.04 (CPU time), 0.0400362 (calendar time)
  14:31:17      info          peano::petsc::PETScNonLinearEquations::monitorNonLinearSolver()      residual norm at iteration 1: 0.445035; LinearIterations: 2
  14:31:17      info          peano::fluid::TrivialgridEventHandle2VTKWriter4FluidAdapter::endIteration      
Accumulated and integrated outflow is: 0

  14:31:17      info          peano::petsc::PETScNonLinearEquations::jacobianGrid()        iteration started.
  14:31:17      info          peano::fluid::NonLinearTrivialgridFluidSimulation::computeNavierStokesJacobian()      runtime for Jacobian: 0.06 (CPU time), 0.0621722 (calendar time)
  14:31:17      info          peano::fluid::NonLinearTrivialgridFluidSimulation::computeNavierStokesFunction()      runtime for B-evaluation: 0.03 (CPU time), 0.0395648 (calendar time)
  14:31:17      info          peano::petsc::PETScNonLinearEquations::monitorNonLinearSolver()      residual norm at iteration 2: 6.48912e-05; LinearIterations: 7
  14:31:17      info          peano::fluid::TrivialgridEventHandle2VTKWriter4FluidAdapter::endIteration      
Accumulated and integrated outflow is: 0

  14:31:17      info          peano::petsc::PETScNonLinearEquations::jacobianGrid()        iteration started.
  14:31:17      info          peano::fluid::NonLinearTrivialgridFluidSimulation::computeNavierStokesJacobian()      runtime for Jacobian: 0.06 (CPU time), 0.0616219 (calendar time)
  14:31:17      info          peano::fluid::NonLinearTrivialgridFluidSimulation::computeNavierStokesFunction()      runtime for B-evaluation: 0.04 (CPU time), 0.0397391 (calendar time)
  14:31:17      info          peano::petsc::PETScNonLinearEquations::monitorNonLinearSolver()      residual norm at iteration 3: 3.69087e-13; LinearIterations: 12
  14:31:17      info          peano::fluid::TrivialgridEventHandle2VTKWriter4FluidAdapter::endIteration      
Accumulated and integrated outflow is: 0

  14:31:17      info          peano::petsc::PETScNonLinearSolver::solve()                  NLGS solver completed in 3 iterations; conv. reason=3
  14:31:17      info          peano::petsc::PETScNonLinearSolver::solve()                  NLGS solver converged!
  14:31:17      info          peano::fluid::FluidSimulation::solveNonLinearSystem()        non-linear solution completed with iterations:3
  14:31:17      info          peano::fluid::TrivialgridEventHandle2VTKWriter4FluidAdapter::endIteration      
Accumulated and integrated outflow is: 0

  14:31:17      info          UserInterface::writeFluidTimeStepInfo(...)                   |    1       |    1.00000e-03  |   0.00000e+00  |   0.00000e+00  |   0.00000e+00  |   0.00000e+00  |   -nan  |   -nan  |   0.00000e+00  |   0.00000e+00  |   -1.00000e+00  |   -1    |   72   |   56     |  7.70000e-01     |  -1     |  -1.00000e+00     |  290  |   8.54262e+01, -7.99361e-15, 
  14:31:17      info          peano::fluid::SteadyStateIntegrationTestChannel::testTrivialgrid9x9ObstacleInChannelNoPreSteps()      testTrivialgrid9x9ObstacleInChannelNoPreSteps(FINITEDIFF) OK
  14:31:17      info          tarch::tests::TestCaseCollection::run()                      running test case collection "fluid" .. ok
  14:31:17      info          tarch::tests::TestCaseCollection::run()                      running test case collection "fluid-parallel" .. ok
  14:31:17      info          tarch::tests::TestCaseCollection::run()                    running test case collection "integration tests" .... ok
==3762== 
==3762== HEAP SUMMARY:
==3762==     in use at exit: 2,688 bytes in 64 blocks
==3762==   total heap usage: 335,866 allocs, 335,802 frees, 64,575,358 bytes allocated
==3762== 
==3762== LEAK SUMMARY:
==3762==    definitely lost: 312 bytes in 3 blocks
==3762==    indirectly lost: 2,376 bytes in 61 blocks
==3762==      possibly lost: 0 bytes in 0 blocks
==3762==    still reachable: 0 bytes in 0 blocks
==3762==         suppressed: 0 bytes in 0 blocks
==3762== Rerun with --leak-check=full to see details of leaked memory
==3762== 
==3762== For counts of detected and suppressed errors, rerun with: -v
==3762== Use --track-origins=yes to see where uninitialised values come from
==3762== ERROR SUMMARY: 10 errors from 2 contexts (suppressed: 4 from 4)


More information about the petsc-users mailing list