[petsc-users] Jacobian free in SNES

Konstantinos Kontzialis ckontzialis at lycos.com
Sat Nov 5 14:40:19 CDT 2011


On 11/05/2011 08:28 PM, petsc-users-request at mcs.anl.gov wrote:
> Jacobian free in SNES
Dear all,

  I upgraded to version 3.2. However, I still have some problems:

I code the following:

ierr = TSCreate(sys.comm, &sys.ts);
         CHKERRQ(ierr);

         ierr = TSSetSolution(sys.ts, sys.gsv);
         CHKERRQ(ierr);

         ierr = TSSetIFunction(sys.ts, sys.gres0, 
base_residual_implicit, &sys);
         CHKERRQ(ierr);

         ISColoring iscoloring;
         MatFDColoring fdcoloring;

         ierr = jacobian_diff_numerical(sys, &sys.P);
         CHKERRQ(ierr);

         ierr = MatGetColoring(sys.P, MATCOLORINGSL, &iscoloring);
         CHKERRQ(ierr);

         ierr = MatFDColoringCreate(sys.P, iscoloring, &fdcoloring);
         CHKERRQ(ierr);

         ierr = MatFDColoringSetFunction(fdcoloring, base_residual_implicit,
&sys);
         CHKERRQ(ierr);

         ierr = TSSetInitialTimeStep(sys.ts, sys.con->tm, sys.con->dt);
         CHKERRQ(ierr);

         ierr = TSSetDuration(sys.ts, 100e+6, sys.con->etime);
         CHKERRQ(ierr);

         ierr = TSSetFromOptions(sys.ts);
         CHKERRQ(ierr);

         ierr = TSSetUp(sys.ts);
         CHKERRQ(ierr);

         ierr = TSGetSNES(sys.ts, &sys.snes);
         CHKERRQ(ierr);

         ierr = MatCreateSNESMF(sys.snes, &sys.J);
         CHKERRQ(ierr);

         ierr = SNESSetJacobian(sys.snes, sys.J, sys.P,
                 SNESDefaultComputeJacobianColor, fdcoloring);
         CHKERRQ(ierr);

         ierr = TSView(sys.ts, PETSC_VIEWER_STDOUT_WORLD);
         CHKERRQ(ierr);

         i = 10000;
         ierr = TSStep(sys.ts);
         CHKERRQ(ierr);


I run with:

mpiexec -n 8 valgrind ./hoac cylinder -llf_flux -n_out 5 -end_time 
10000.0 -explicit -explicit_type 2 -ts_type beuler -pc_type asm 
-ksp_right_pc -sub_pc_type ilu -sub_pc_factor_mat_ordering_type rcm 
1.0e-8 -gl -sub_pc_factor_levels 2 -dt 2.0e-1 -snes_monitor -snes_stol 
1.0e-50 -snes_ksp_ew -snes_ls_maxstep 10.0 -snes_stol 1.0e-50 
-snes_max_linear_solve_fail 50 -snes_max_fail 50 
-ksp_monitor_true_residual -snes_mf_operator

and I get:


**********************************************************************
   METIS 4.0.3 Copyright 1998, Regents of the University of Minnesota

Graph Information ---------------------------------------------------
   Name: mesh.graph, #Vertices: 400, #Edges: 780, #Parts: 8

Recursive Partitioning... -------------------------------------------
   8-way Edge-Cut:     102, Balance:  1.00

Timing Information --------------------------------------------------
   I/O:                     0.000
   Partitioning:            0.000   (PMETIS time)
   Total:                   0.000
**********************************************************************


Approximation order = 1
# DOF = 6080
# nodes in mesh = 400
# elements in mesh = 380
Euler solution
Using LLF flux


   0 KSP preconditioned resid norm 4.015618492963e+01 true resid norm 
2.209663952405e+02 ||r(i)||/||b|| 1.000000000000e+00
   1 KSP preconditioned resid norm 4.431081191507e-14 true resid norm 
2.384009492855e-13 ||r(i)||/||b|| 1.078901382384e-15
TS Object: 8 MPI processes
   type: beuler
   maximum steps=100000000
   maximum time=10000
   total number of nonlinear solver iterations=0
   total number of nonlinear solve failures=0
   total number of linear solver iterations=0
   total number of rejected steps=0
   SNES Object:   8 MPI processes
     type: ls
       line search variant: SNESLineSearchCubic
       alpha=1.000000000000e-04, maxstep=1.000000000000e+01, 
minlambda=1.000000000000e-12
     maximum iterations=50, maximum function evaluations=10000
     tolerances: relative=1e-08, absolute=1e-50, solution=1e-50
     total number of linear solver iterations=0
     total number of function evaluations=0
     Eisenstat-Walker computation of KSP relative tolerance (version 2)
       rtol_0=0.3, rtol_max=0.9, threshold=0.1
       gamma=1, alpha=1.61803, alpha2=1.61803
     KSP Object:     8 MPI processes
       type: gmres
         GMRES: restart=30, using Classical (unmodified) Gram-Schmidt 
Orthogonalization with no iterative refinement
         GMRES: happy breakdown tolerance 1e-30
       maximum iterations=10000, initial guess is zero
       tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
       left preconditioning
       using DEFAULT norm type for convergence test
     PC Object:     8 MPI processes
       type: asm
         Additive Schwarz: total subdomain blocks not yet set, amount of 
overlap = 1
         Additive Schwarz: restriction/interpolation type - RESTRICT
       linear system matrix:
       Matrix Object:       8 MPI processes
         type: mffd
         rows=6080, cols=6080
             matrix-free approximation:
               err=1e-07 (relative error in function evaluation)
               The compute h routine has not yet been set


     0 SNES Function norm 2.822902692891e-01




==25984== Invalid read of size 4
==25981== Invalid read of size 4
==25981==    at 0x4FC73CD: MatMult (matrix.c:2157)
==25981==    by 0x406BD3: base_residual_implicit 
(base_residual_implicit.c:29)
==25981==    by 0x50597C2: MatFDColoringApply_BAIJ (baij.c:2815)
==25981==    by 0x5022C69: MatFDColoringApply (fdmatrix.c:517)
==25981==    by 0x57D2E9B: SNESDefaultComputeJacobianColor (snesj2.c:48)
==25981==    by 0x57B7852: SNESComputeJacobian (snes.c:1357)
==25981==    by 0x57FAEF8: SNESSolve_LS (ls.c:188)
==25981==    by 0x57C43AA: SNESSolve (snes.c:2676)
==25981==    by 0x58694E1: TSStep_Theta (theta.c:41)
==25981==    by 0x58812D6: TSStep (ts.c:1776)
==25981==    by 0x4208A5: explicit_time (explicit_time.c:148)
==25981==    by 0x429E14: main (hoac.c:1250)
==25981==  Address 0xe800000000b84400 is not stack'd, malloc'd or 
(recently) free'd
==25981==
==25984==    at 0x4FC73CD: MatMult (matrix.c:2157)
==25984==    by 0x406BD3: base_residual_implicit 
(base_residual_implicit.c:29)
==25984==    by 0x50597C2: MatFDColoringApply_BAIJ (baij.c:2815)
==25984==    by 0x5022C69: MatFDColoringApply (fdmatrix.c:517)
==25984==    by 0x57D2E9B: SNESDefaultComputeJacobianColor (snesj2.c:48)
==25984==    by 0x57B7852: SNESComputeJacobian (snes.c:1357)
==25984==    by 0x57FAEF8: SNESSolve_LS (ls.c:188)
==25984==    by 0x57C43AA: SNESSolve (snes.c:2676)
==25984==    by 0x58694E1: TSStep_Theta (theta.c:41)
==25984==    by 0x58812D6: TSStep (ts.c:1776)
==25984==    by 0x4208A5: explicit_time (explicit_time.c:148)
==25984==    by 0x429E14: main (hoac.c:1250)
==25984==  Address 0xe800000000b84400 is not stack'd, malloc'd or 
(recently) free'd
==25984==
==25983== Invalid read of size 4
==25983==    at 0x4FC73CD: MatMult (matrix.c:2157)
==25983==    by 0x406BD3: base_residual_implicit 
(base_residual_implicit.c:29)
==25983==    by 0x50597C2: MatFDColoringApply_BAIJ (baij.c:2815)
==25983==    by 0x5022C69: MatFDColoringApply (fdmatrix.c:517)
==25983==    by 0x57D2E9B: SNESDefaultComputeJacobianColor (snesj2.c:48)
==25983==    by 0x57B7852: SNESComputeJacobian (snes.c:1357)
==25983==    by 0x57FAEF8: SNESSolve_LS (ls.c:188)
==25983==    by 0x57C43AA: SNESSolve (snes.c:2676)
==25983==    by 0x58694E1: TSStep_Theta (theta.c:41)
==25983==    by 0x58812D6: TSStep (ts.c:1776)
==25983==    by 0x4208A5: explicit_time (explicit_time.c:148)
==25983==    by 0x429E14: main (hoac.c:1250)
==25983==  Address 0xe800000000b84400 is not stack'd, malloc'd or 
(recently) free'd
==25983==
==25979== Invalid read of size 4
==25979==    at 0x4FC73CD: MatMult (matrix.c:2157)
==25979==    by 0x406BD3: base_residual_implicit 
(base_residual_implicit.c:29)
==25979==    by 0x50597C2: MatFDColoringApply_BAIJ (baij.c:2815)
==25978== Invalid read of size 4
==25978==    at 0x4FC73CD: MatMult (matrix.c:2157)
==25982== Invalid read of size 4
==25982==    at 0x4FC73CD: MatMult (matrix.c:2157)
==25982==    by 0x406BD3: base_residual_implicit 
(base_residual_implicit.c:29)
==25978==    by 0x406BD3: base_residual_implicit 
(base_residual_implicit.c:29)
==25978==    by 0x50597C2: MatFDColoringApply_BAIJ (baij.c:2815)
==25978==    by 0x5022C69: MatFDColoringApply (fdmatrix.c:517)
==25978==    by 0x57D2E9B: SNESDefaultComputeJacobianColor (snesj2.c:48)
==25982==    by 0x50597C2: MatFDColoringApply_BAIJ (baij.c:2815)
==25982==    by 0x5022C69: MatFDColoringApply (fdmatrix.c:517)
==25982==    by 0x57D2E9B: SNESDefaultComputeJacobianColor (snesj2.c:48)
==25982==    by 0x57B7852: SNESComputeJacobian (snes.c:1357)
==25978==    by 0x57B7852: SNESComputeJacobian (snes.c:1357)
==25978==    by 0x57FAEF8: SNESSolve_LS (ls.c:188)
==25978==    by 0x57C43AA: SNESSolve (snes.c:2676)
==25982==    by 0x57FAEF8: SNESSolve_LS (ls.c:188)
==25982==    by 0x57C43AA: SNESSolve (snes.c:2676)
==25982==    by 0x58694E1: TSStep_Theta (theta.c:41)
==25978==    by 0x58694E1: TSStep_Theta (theta.c:41)
==25978==    by 0x58812D6: TSStep (ts.c:1776)
==25978==    by 0x4208A5: explicit_time (explicit_time.c:148)
==25982==    by 0x58812D6: TSStep (ts.c:1776)
==25982==    by 0x4208A5: explicit_time (explicit_time.c:148)
==25982==    by 0x429E14: main (hoac.c:1250)
==25982==  Address 0xe800000000b84400 is not stack'd, malloc'd or 
(recently) free'd
==25978==    by 0x429E14: main (hoac.c:1250)
==25978==  Address 0xe800000000b84400 is not stack'd, malloc'd or 
(recently) free'd
==25978==
==25982==
==25979==    by 0x5022C69: MatFDColoringApply (fdmatrix.c:517)
==25979==    by 0x57D2E9B: SNESDefaultComputeJacobianColor (snesj2.c:48)
==25979==    by 0x57B7852: SNESComputeJacobian (snes.c:1357)
==25979==    by 0x57FAEF8: SNESSolve_LS (ls.c:188)
==25979==    by 0x57C43AA: SNESSolve (snes.c:2676)
==25979==    by 0x58694E1: TSStep_Theta (theta.c:41)
==25979==    by 0x58812D6: TSStep (ts.c:1776)
==25979==    by 0x4208A5: explicit_time (explicit_time.c:148)
==25979==    by 0x429E14: main (hoac.c:1250)
==25979==  Address 0xe800000000b84400 is not stack'd, malloc'd or 
(recently) free'd
==25979==
==25977== Invalid read of size 4
==25977==    at 0x4FC73CD: MatMult (matrix.c:2157)
==25977==    by 0x406BD3: base_residual_implicit 
(base_residual_implicit.c:29)
==25977==    by 0x50597C2: MatFDColoringApply_BAIJ (baij.c:2815)
==25977==    by 0x5022C69: MatFDColoringApply (fdmatrix.c:517)
==25977==    by 0x57D2E9B: SNESDefaultComputeJacobianColor (snesj2.c:48)
==25977==    by 0x57B7852: SNESComputeJacobian (snes.c:1357)
==25977==    by 0x57FAEF8: SNESSolve_LS (ls.c:188)
==25977==    by 0x57C43AA: SNESSolve (snes.c:2676)
==25977==    by 0x58694E1: TSStep_Theta (theta.c:41)
==25977==    by 0x58812D6: TSStep (ts.c:1776)
==25977==    by 0x4208A5: explicit_time (explicit_time.c:148)
==25977==    by 0x429E14: main (hoac.c:1250)
==25977==  Address 0xe800000000b84400 is not stack'd, malloc'd or 
(recently) free'd
==25977==
[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 
ERROR: or try http://valgrind.org on GNU/linux and Apple Mac OS X to 
find memory corruption errors
==25980== Invalid read of size 4
==25980==    at 0x4FC73CD: MatMult (matrix.c:2157)
==25980==    by 0x406BD3: base_residual_implicit 
(base_residual_implicit.c:29)
==25980==    by 0x50597C2: MatFDColoringApply_BAIJ (baij.c:2815)
==25980==    by 0x5022C69: MatFDColoringApply (fdmatrix.c:517)
==25980==    by 0x57D2E9B: SNESDefaultComputeJacobianColor (snesj2.c:48)
==25980==    by 0x57B7852: SNESComputeJacobian (snes.c:1357)
==25980==    by 0x57FAEF8: SNESSolve_LS (ls.c:188)
==25980==    by 0x57C43AA: SNESSolve (snes.c:2676)
==25980==    by 0x58694E1: TSStep_Theta (theta.c:41)
==25980==    by 0x58812D6: TSStep (ts.c:1776)
[4]PETSC ERROR: ==25980==    by 0x4208A5: explicit_time 
(explicit_time.c:148)
==25980==    by 0x429E14: main (hoac.c:1250)
==25980==  Address 0xe800000000b84400 is not stack'd, malloc'd or 
(recently) free'd
==25980==
[7]PETSC ERROR: [0]PETSC ERROR: likely location of problem given in 
stack below
[6]PETSC ERROR: [0]PETSC ERROR: ---------------------  Stack Frames 
------------------------------------
[1]PETSC ERROR: [5]PETSC ERROR: [2]PETSC ERROR: [0]PETSC ERROR: Note: 
The EXACT line numbers in the stack are not available,
[0]PETSC ERROR: 
------------------------------------------------------------------------
       INSTEAD the line number of the start of the function
------------------------------------------------------------------------
[0]PETSC ERROR:       is given.
[4]PETSC ERROR: [7]PETSC ERROR: Caught signal number 11 SEGV: 
Segmentation Violation, probably memory access out of range
Caught signal number 11 SEGV: Segmentation Violation, probably memory 
access out of range
[4]PETSC ERROR: 
------------------------------------------------------------------------
Try option -start_in_debugger or -on_error_attach_debugger
[7]PETSC ERROR: Try option -start_in_debugger or -on_error_attach_debugger
[4]PETSC ERROR: or see 
http://www.mcs.anl.gov/petsc/petsc-as/documentation/faq.html#valgrind[7]PETSC 
ERROR: [0]PETSC ERROR: or see 
http://www.mcs.anl.gov/petsc/petsc-as/documentation/faq.html#valgrind[4]PETSC 
ERROR: or try http://valgrind.org on GNU/linux and Apple Mac OS X to 
find memory corruption errors
[7]PETSC ERROR: or try http://valgrind.org on GNU/linux and Apple Mac OS 
X to find memory corruption errors
[6]PETSC ERROR: Caught signal number 11 SEGV: Segmentation Violation, 
probably memory access out of range
[6]PETSC ERROR: Try option -start_in_debugger or -on_error_attach_debugger
------------------------------------------------------------------------
[6]PETSC ERROR: 
------------------------------------------------------------------------
------------------------------------------------------------------------
or see 
http://www.mcs.anl.gov/petsc/petsc-as/documentation/faq.html#valgrind[6]PETSC 
ERROR: or try http://valgrind.org on GNU/linux and Apple Mac OS X to 
find memory corruption errors
[0] MatMult line 2156 
/home/kontzialis/petsc-3.2-p5/src/mat/interface/matrix.c
[0]PETSC ERROR: [0] base_residual_implicit line 27 
"unknowndirectory/"../src/base_residual_implicit.c
[2]PETSC ERROR: [5]PETSC ERROR: [1]PETSC ERROR: Caught signal number 11 
SEGV: Segmentation Violation, probably memory access out of range
Caught signal number 11 SEGV: Segmentation Violation, probably memory 
access out of range
Caught signal number 11 SEGV: Segmentation Violation, probably memory 
access out of range
[0]PETSC ERROR: [2]PETSC ERROR: [5]PETSC ERROR: [1]PETSC ERROR: Try 
option -start_in_debugger or -on_error_attach_debugger
Try option -start_in_debugger or -on_error_attach_debugger
Try option -start_in_debugger or -on_error_attach_debugger
[0] MatFDColoringApply_BAIJ line 2768 
/home/kontzialis/petsc-3.2-p5/src/mat/impls/baij/seq/baij.c
[1]PETSC ERROR: [5]PETSC ERROR: or see 
http://www.mcs.anl.gov/petsc/petsc-as/documentation/faq.html#valgrind[2]PETSC 
ERROR: or see 
http://www.mcs.anl.gov/petsc/petsc-as/documentation/faq.html#valgrindor 
see 
http://www.mcs.anl.gov/petsc/petsc-as/documentation/faq.html#valgrind[0]PETSC 
ERROR: [0] MatFDColoringApply line 511 
/home/kontzialis/petsc-3.2-p5/src/mat/matfd/fdmatrix.c
[1]PETSC ERROR: [5]PETSC ERROR: or try http://valgrind.org on GNU/linux 
and Apple Mac OS X to find memory corruption errors
or try http://valgrind.org on GNU/linux and Apple Mac OS X to find 
memory corruption errors
[2]PETSC ERROR: or try http://valgrind.org on GNU/linux and Apple Mac OS 
X to find memory corruption errors
[4]PETSC ERROR: [0]PETSC ERROR: likely location of problem given in 
stack below
[7]PETSC ERROR: likely location of problem given in stack below
[4]PETSC ERROR: [0] SNESDefaultComputeJacobianColor line 40 
/home/kontzialis/petsc-3.2-p5/src/snes/interface/snesj2.c
---------------------  Stack Frames ------------------------------------
[7]PETSC ERROR: [0]PETSC ERROR: ---------------------  Stack Frames 
------------------------------------
[0] SNES user Jacobian function line 0 unknownunknown
[0]PETSC ERROR: [0] SNESComputeJacobian line 1322 
/home/kontzialis/petsc-3.2-p5/src/snes/interface/snes.c
[6]PETSC ERROR: likely location of problem given in stack below
[6]PETSC ERROR: ---------------------  Stack Frames 
------------------------------------
[3]PETSC ERROR: [1]PETSC ERROR: [5]PETSC ERROR: likely location of 
problem given in stack below
[2]PETSC ERROR: likely location of problem given in stack below
likely location of problem given in stack below
[1]PETSC ERROR: [5]PETSC ERROR: [2]PETSC ERROR: ---------------------  
Stack Frames ------------------------------------
---------------------  Stack Frames ------------------------------------
---------------------  Stack Frames ------------------------------------
[0]PETSC ERROR: --------------------- Error Message 
------------------------------------
[4]PETSC ERROR: [7]PETSC ERROR: Note: The EXACT line numbers in the 
stack are not available,
Note: The EXACT line numbers in the stack are not available,
[4]PETSC ERROR: [7]PETSC ERROR:       INSTEAD the line number of the 
start of the function
       INSTEAD the line number of the start of the function
[4]PETSC ERROR: [7]PETSC ERROR:       is given.
       is given.
[6]PETSC ERROR: Note: The EXACT line numbers in the stack are not available,
[6]PETSC ERROR:       INSTEAD the line number of the start of the function
[6]PETSC ERROR: [4]PETSC ERROR: [7]PETSC ERROR:       is given.
[0]PETSC ERROR: Signal received!
[6]PETSC ERROR: [0]PETSC ERROR: [2]PETSC ERROR: [7] MatMult line 2156 
/home/kontzialis/petsc-3.2-p5/src/mat/interface/matrix.c
[1]PETSC ERROR: [5]PETSC ERROR: Note: The EXACT line numbers in the 
stack are not available,
[4] MatMult line 2156 
/home/kontzialis/petsc-3.2-p5/src/mat/interface/matrix.c
Note: The EXACT line numbers in the stack are not available,
------------------------------------------------------------------------
Note: The EXACT line numbers in the stack are not available,
[7]PETSC ERROR: [2]PETSC ERROR: [4]PETSC ERROR:       INSTEAD the line 
number of the start of the function
[1]PETSC ERROR:       INSTEAD the line number of the start of the function
[5]PETSC ERROR: [7] base_residual_implicit line 27 
"unknowndirectory/"../src/base_residual_implicit.c
[4] base_residual_implicit line 27 
"unknowndirectory/"../src/base_residual_implicit.c
[7]PETSC ERROR:       INSTEAD the line number of the start of the function
[2]PETSC ERROR: [1]PETSC ERROR: [4]PETSC ERROR: [7] 
MatFDColoringApply_BAIJ line 2768 
/home/kontzialis/petsc-3.2-p5/src/mat/impls/baij/seq/baij.c
       is given.
       is given.
[5]PETSC ERROR: [4] MatFDColoringApply_BAIJ line 2768 
/home/kontzialis/petsc-3.2-p5/src/mat/impls/baij/seq/baij.c
[7]PETSC ERROR: [4]PETSC ERROR: [0]PETSC ERROR:       is given.
[7] MatFDColoringApply line 511 
/home/kontzialis/petsc-3.2-p5/src/mat/matfd/fdmatrix.c
Petsc Release Version 3.2.0, Patch 5, Sat Oct 29 13:45:54 CDT 2011
[4] MatFDColoringApply line 511 
/home/kontzialis/petsc-3.2-p5/src/mat/matfd/fdmatrix.c
[7]PETSC ERROR: [4]PETSC ERROR: [7] SNESDefaultComputeJacobianColor line 
40 /home/kontzialis/petsc-3.2-p5/src/snes/interface/snesj2.c
[6] MatMult line 2156 
/home/kontzialis/petsc-3.2-p5/src/mat/interface/matrix.c
[4] SNESDefaultComputeJacobianColor line 40 
/home/kontzialis/petsc-3.2-p5/src/snes/interface/snesj2.c
[7]PETSC ERROR: [4]PETSC ERROR: [7] SNES user Jacobian function line 0 
unknownunknown
[6]PETSC ERROR: [7]PETSC ERROR: [4] SNES user Jacobian function line 0 
unknownunknown
[0]PETSC ERROR: [7] SNESComputeJacobian line 1322 
/home/kontzialis/petsc-3.2-p5/src/snes/interface/snes.c
[6] base_residual_implicit line 27 
"unknowndirectory/"../src/base_residual_implicit.c
[4]PETSC ERROR: [6]PETSC ERROR: See docs/changes/index.html for recent 
updates.
[4] SNESComputeJacobian line 1322 
/home/kontzialis/petsc-3.2-p5/src/snes/interface/snes.c
[2]PETSC ERROR: [1]PETSC ERROR: [6] MatFDColoringApply_BAIJ line 2768 
/home/kontzialis/petsc-3.2-p5/src/mat/impls/baij/seq/baij.c
[6]PETSC ERROR: [5]PETSC ERROR: [6] MatFDColoringApply line 511 
/home/kontzialis/petsc-3.2-p5/src/mat/matfd/fdmatrix.c
[6]PETSC ERROR: [0]PETSC ERROR: [6] SNESDefaultComputeJacobianColor line 
40 /home/kontzialis/petsc-3.2-p5/src/snes/interface/snesj2.c
See docs/faq.html for hints about trouble shooting.
[6]PETSC ERROR: [6] SNES user Jacobian function line 0 unknownunknown
[6]PETSC ERROR: [0]PETSC ERROR: [6] SNESComputeJacobian line 1322 
/home/kontzialis/petsc-3.2-p5/src/snes/interface/snes.c
See docs/index.html for manual pages.
[0]PETSC ERROR: [1] MatMult line 2156 
/home/kontzialis/petsc-3.2-p5/src/mat/interface/matrix.c
[5] MatMult line 2156 
/home/kontzialis/petsc-3.2-p5/src/mat/interface/matrix.c
------------------------------------------------------------------------
[1]PETSC ERROR: [5]PETSC ERROR: [1] base_residual_implicit line 27 
"unknowndirectory/"../src/base_residual_implicit.c
[1]PETSC ERROR: [5] base_residual_implicit line 27 
"unknowndirectory/"../src/base_residual_implicit.c
[5]PETSC ERROR: [1] MatFDColoringApply_BAIJ line 2768 
/home/kontzialis/petsc-3.2-p5/src/mat/impls/baij/seq/baij.c
[5] MatFDColoringApply_BAIJ line 2768 
/home/kontzialis/petsc-3.2-p5/src/mat/impls/baij/seq/baij.c
[1]PETSC ERROR: [0]PETSC ERROR: [5]PETSC ERROR: [1] MatFDColoringApply 
line 511 /home/kontzialis/petsc-3.2-p5/src/mat/matfd/fdmatrix.c
[5] MatFDColoringApply line 511 
/home/kontzialis/petsc-3.2-p5/src/mat/matfd/fdmatrix.c
[1]PETSC ERROR: [5]PETSC ERROR: ./hoac on a linux-gnu named PlusSodaL by 
kontzialis Sat Nov  5 21:36:27 2011
[1] SNESDefaultComputeJacobianColor line 40 
/home/kontzialis/petsc-3.2-p5/src/snes/interface/snesj2.c
[5] SNESDefaultComputeJacobianColor line 40 
/home/kontzialis/petsc-3.2-p5/src/snes/interface/snesj2.c
[1]PETSC ERROR: [5]PETSC ERROR: [1] SNES user Jacobian function line 0 
unknownunknown
[1]PETSC ERROR: [5] SNES user Jacobian function line 0 unknownunknown
[1] SNESComputeJacobian line 1322 
/home/kontzialis/petsc-3.2-p5/src/snes/interface/snes.c
[5]PETSC ERROR: [0]PETSC ERROR: [5] SNESComputeJacobian line 1322 
/home/kontzialis/petsc-3.2-p5/src/snes/interface/snes.c
Libraries linked from /home/kontzialis/petsc-3.2-p5/linux-gnu-c-debug/lib
------------------------------------------------------------------------
[0]PETSC ERROR: Configure run at Sat Nov  5 20:58:12 2011
[0]PETSC ERROR: Configure options --with-debugging=1 
---with-mpi-dir=/usr/lib64/mpich2/bin --with-shared-libraries 
--with-shared-libraries --with-large-file-io=1 --with-precision=double 
--with-blacs=1 --download-blacs=yes --download-f-blas-lapack=yes 
--with-plapack=1 --download-plapack=yes --with-scalapack=1 
--download-scalapack=yes --with-superlu=1 --download-superlu=yes 
--with-superlu_dist=1 --download-superlu_dist=yes --with-ml=1 
--download-ml=yes --with-umfpack=1 --download-umfpack=yes --with-mpi=1 
--download-mpich=1 --with-sundials=1 --download-sundials=1 
--with-parmetis=1 --download-parmetis=1 --with-hypre=1 --download-hypre=1
[3]PETSC ERROR: [0]PETSC ERROR: Caught signal number 11 SEGV: 
Segmentation Violation, probably memory access out of range
------------------------------------------------------------------------
[7]PETSC ERROR: [3]PETSC ERROR: --------------------- Error Message 
------------------------------------
[4]PETSC ERROR: --------------------- Error Message 
------------------------------------
[0]PETSC ERROR: User provided function() line 0 in unknown directory 
unknown file
[2] MatMult line 2156 
/home/kontzialis/petsc-3.2-p5/src/mat/interface/matrix.c
[6]PETSC ERROR: --------------------- Error Message 
------------------------------------
[2]PETSC ERROR: Try option -start_in_debugger or -on_error_attach_debugger
[2] base_residual_implicit line 27 
"unknowndirectory/"../src/base_residual_implicit.c
[2]PETSC ERROR: [3]PETSC ERROR: [2] MatFDColoringApply_BAIJ line 2768 
/home/kontzialis/petsc-3.2-p5/src/mat/impls/baij/seq/baij.c
or see 
http://www.mcs.anl.gov/petsc/petsc-as/documentation/faq.html#valgrind[2]PETSC 
ERROR: [3]PETSC ERROR: [2] MatFDColoringApply line 511 
/home/kontzialis/petsc-3.2-p5/src/mat/matfd/fdmatrix.c
[2]PETSC ERROR: or try http://valgrind.org on GNU/linux and Apple Mac OS 
X to find memory corruption errors
[2] SNESDefaultComputeJacobianColor line 40 
/home/kontzialis/petsc-3.2-p5/src/snes/interface/snesj2.c
[2]PETSC ERROR: [2] SNES user Jacobian function line 0 unknownunknown
[2]PETSC ERROR: [2] SNESComputeJacobian line 1322 
/home/kontzialis/petsc-3.2-p5/src/snes/interface/snes.c
[1]PETSC ERROR: [5]PETSC ERROR: --------------------- Error Message 
------------------------------------
--------------------- Error Message ------------------------------------
[7]PETSC ERROR: Signal received!
[4]PETSC ERROR: Signal received!
[7]PETSC ERROR: 
------------------------------------------------------------------------
[4]PETSC ERROR: 
------------------------------------------------------------------------
[7]PETSC ERROR: Petsc Release Version 3.2.0, Patch 5, Sat Oct 29 
13:45:54 CDT 2011
[4]PETSC ERROR: Petsc Release Version 3.2.0, Patch 5, Sat Oct 29 
13:45:54 CDT 2011
[7]PETSC ERROR: [6]PETSC ERROR: See docs/changes/index.html for recent 
updates.
[4]PETSC ERROR: Signal received!
See docs/changes/index.html for recent updates.
[7]PETSC ERROR: See docs/faq.html for hints about trouble shooting.
[4]PETSC ERROR: [6]PETSC ERROR: [3]PETSC ERROR: See docs/faq.html for 
hints about trouble shooting.
likely location of problem given in stack below
------------------------------------------------------------------------
[7]PETSC ERROR: See docs/index.html for manual pages.
[3]PETSC ERROR: [4]PETSC ERROR: See docs/index.html for manual pages.
[6]PETSC ERROR: ---------------------  Stack Frames 
------------------------------------
Petsc Release Version 3.2.0, Patch 5, Sat Oct 29 13:45:54 CDT 2011
[7]PETSC ERROR: 
------------------------------------------------------------------------
[4]PETSC ERROR: 
------------------------------------------------------------------------
[6]PETSC ERROR: See docs/changes/index.html for recent updates.
[6]PETSC ERROR: [7]PETSC ERROR: [4]PETSC ERROR: See docs/faq.html for 
hints about trouble shooting.
./hoac on a linux-gnu named PlusSodaL by kontzialis Sat Nov  5 21:36:27 2011
./hoac on a linux-gnu named PlusSodaL by kontzialis Sat Nov  5 21:36:27 2011
[6]PETSC ERROR: [7]PETSC ERROR: See docs/index.html for manual pages.
Libraries linked from /home/kontzialis/petsc-3.2-p5/linux-gnu-c-debug/lib
[4]PETSC ERROR: Libraries linked from 
/home/kontzialis/petsc-3.2-p5/linux-gnu-c-debug/lib
[6]PETSC ERROR: 
------------------------------------------------------------------------
[7]PETSC ERROR: [4]PETSC ERROR: Configure run at Sat Nov  5 20:58:12 2011
[1]PETSC ERROR: Configure run at Sat Nov  5 20:58:12 2011
[5]PETSC ERROR: Signal received!
Signal received!
[6]PETSC ERROR: [7]PETSC ERROR: [4]PETSC ERROR: ./hoac on a linux-gnu 
named PlusSodaL by kontzialis Sat Nov  5 21:36:27 2011
Configure options --with-debugging=1 
---with-mpi-dir=/usr/lib64/mpich2/bin --with-shared-libraries 
--with-shared-libraries --with-large-file-io=1 --with-precision=double 
--with-blacs=1 --download-blacs=yes --download-f-blas-lapack=yes 
--with-plapack=1 --download-plapack=yes --with-scalapack=1 
--download-scalapack=yes --with-superlu=1 --download-superlu=yes 
--with-superlu_dist=1 --download-superlu_dist=yes --with-ml=1 
--download-ml=yes --with-umfpack=1 --download-umfpack=yes --with-mpi=1 
--download-mpich=1 --with-sundials=1 --download-sundials=1 
--with-parmetis=1 --download-parmetis=1 --with-hypre=1 --download-hypre=1
[1]PETSC ERROR: [2]PETSC ERROR: Configure options --with-debugging=1 
---with-mpi-dir=/usr/lib64/mpich2/bin --with-shared-libraries 
--with-shared-libraries --with-large-file-io=1 --with-precision=double 
--with-blacs=1 --download-blacs=yes --download-f-blas-lapack=yes 
--with-plapack=1 --download-plapack=yes --with-scalapack=1 
--download-scalapack=yes --with-superlu=1 --download-superlu=yes 
--with-superlu_dist=1 --download-superlu_dist=yes --with-ml=1 
--download-ml=yes --with-umfpack=1 --download-umfpack=yes --with-mpi=1 
--download-mpich=1 --with-sundials=1 --download-sundials=1 
--with-parmetis=1 --download-parmetis=1 --with-hypre=1 --download-hypre=1
[5]PETSC ERROR: 
------------------------------------------------------------------------
------------------------------------------------------------------------
--------------------- Error Message ------------------------------------
[7]PETSC ERROR: [6]PETSC ERROR: 
------------------------------------------------------------------------
[4]PETSC ERROR: Libraries linked from 
/home/kontzialis/petsc-3.2-p5/linux-gnu-c-debug/lib
[5]PETSC ERROR: [1]PETSC ERROR: 
------------------------------------------------------------------------
Petsc Release Version 3.2.0, Patch 5, Sat Oct 29 13:45:54 CDT 2011
Petsc Release Version 3.2.0, Patch 5, Sat Oct 29 13:45:54 CDT 2011
[6]PETSC ERROR: Configure run at Sat Nov  5 20:58:12 2011
[7]PETSC ERROR: [5]PETSC ERROR: [1]PETSC ERROR: [4]PETSC ERROR: User 
provided function() line 0 in unknown directory unknown file
See docs/changes/index.html for recent updates.
See docs/changes/index.html for recent updates.
User provided function() line 0 in unknown directory unknown file
[6]PETSC ERROR: Configure options --with-debugging=1 
---with-mpi-dir=/usr/lib64/mpich2/bin --with-shared-libraries 
--with-shared-libraries --with-large-file-io=1 --with-precision=double 
--with-blacs=1 --download-blacs=yes --download-f-blas-lapack=yes 
--with-plapack=1 --download-plapack=yes --with-scalapack=1 
--download-scalapack=yes --with-superlu=1 --download-superlu=yes 
--with-superlu_dist=1 --download-superlu_dist=yes --with-ml=1 
--download-ml=yes --with-umfpack=1 --download-umfpack=yes --with-mpi=1 
--download-mpich=1 --with-sundials=1 --download-sundials=1 
--with-parmetis=1 --download-parmetis=1 --with-hypre=1 --download-hypre=1
[1]PETSC ERROR: See docs/faq.html for hints about trouble shooting.
[5]PETSC ERROR: See docs/faq.html for hints about trouble shooting.
[6]PETSC ERROR: [1]PETSC ERROR: [5]PETSC ERROR: 
------------------------------------------------------------------------
See docs/index.html for manual pages.
See docs/index.html for manual pages.
[1]PETSC ERROR: [5]PETSC ERROR: 
------------------------------------------------------------------------
------------------------------------------------------------------------
[6]PETSC ERROR: User provided function() line 0 in unknown directory 
unknown file
[1]PETSC ERROR: [5]PETSC ERROR: ./hoac on a linux-gnu named PlusSodaL by 
kontzialis Sat Nov  5 21:36:27 2011
./hoac on a linux-gnu named PlusSodaL by kontzialis Sat Nov  5 21:36:27 2011
[1]PETSC ERROR: [5]PETSC ERROR: Libraries linked from 
/home/kontzialis/petsc-3.2-p5/linux-gnu-c-debug/lib
Libraries linked from /home/kontzialis/petsc-3.2-p5/linux-gnu-c-debug/lib
[5]PETSC ERROR: [1]PETSC ERROR: Configure run at Sat Nov  5 20:58:12 2011
Configure run at Sat Nov  5 20:58:12 2011
[5]PETSC ERROR: [1]PETSC ERROR: Configure options --with-debugging=1 
---with-mpi-dir=/usr/lib64/mpich2/bin --with-shared-libraries 
--with-shared-libraries --with-large-file-io=1 --with-precision=double 
--with-blacs=1 --download-blacs=yes --download-f-blas-lapack=yes 
--with-plapack=1 --download-plapack=yes --with-scalapack=1 
--download-scalapack=yes --with-superlu=1 --download-superlu=yes 
--with-superlu_dist=1 --download-superlu_dist=yes --with-ml=1 
--download-ml=yes --with-umfpack=1 --download-umfpack=yes --with-mpi=1 
--download-mpich=1 --with-sundials=1 --download-sundials=1 
--with-parmetis=1 --download-parmetis=1 --with-hypre=1 --download-hypre=1
Configure options --with-debugging=1 
---with-mpi-dir=/usr/lib64/mpich2/bin --with-shared-libraries 
--with-shared-libraries --with-large-file-io=1 --with-precision=double 
--with-blacs=1 --download-blacs=yes --download-f-blas-lapack=yes 
--with-plapack=1 --download-plapack=yes --with-scalapack=1 
--download-scalapack=yes --with-superlu=1 --download-superlu=yes 
--with-superlu_dist=1 --download-superlu_dist=yes --with-ml=1 
--download-ml=yes --with-umfpack=1 --download-umfpack=yes --with-mpi=1 
--download-mpich=1 --with-sundials=1 --download-sundials=1 
--with-parmetis=1 --download-parmetis=1 --with-hypre=1 --download-hypre=1
[1]PETSC ERROR: [5]PETSC ERROR: 
------------------------------------------------------------------------
------------------------------------------------------------------------
[1]PETSC ERROR: [5]PETSC ERROR: User provided function() line 0 in 
unknown directory unknown file
[2]PETSC ERROR: User provided function() line 0 in unknown directory 
unknown file
Signal received!
[2]PETSC ERROR: 
------------------------------------------------------------------------
[2]PETSC ERROR: Petsc Release Version 3.2.0, Patch 5, Sat Oct 29 
13:45:54 CDT 2011
[2]PETSC ERROR: See docs/changes/index.html for recent updates.
[2]PETSC ERROR: See docs/faq.html for hints about trouble shooting.
[3]PETSC ERROR: Note: The EXACT line numbers in the stack are not available,
[2]PETSC ERROR: See docs/index.html for manual pages.
[3]PETSC ERROR:       INSTEAD the line number of the start of the function
[2]PETSC ERROR: 
------------------------------------------------------------------------
[3]PETSC ERROR:       is given.
[2]PETSC ERROR: ./hoac on a linux-gnu named PlusSodaL by kontzialis Sat 
Nov  5 21:36:27 2011
[2]PETSC ERROR: Libraries linked from 
/home/kontzialis/petsc-3.2-p5/linux-gnu-c-debug/lib
[2]PETSC ERROR: [3]PETSC ERROR: Configure run at Sat Nov  5 20:58:12 2011
[2]PETSC ERROR: Configure options --with-debugging=1 
---with-mpi-dir=/usr/lib64/mpich2/bin --with-shared-libraries 
--with-shared-libraries --with-large-file-io=1 --with-precision=double 
--with-blacs=1 --download-blacs=yes --download-f-blas-lapack=yes 
--with-plapack=1 --download-plapack=yes --with-scalapack=1 
--download-scalapack=yes --with-superlu=1 --download-superlu=yes 
--with-superlu_dist=1 --download-superlu_dist=yes --with-ml=1 
--download-ml=yes --with-umfpack=1 --download-umfpack=yes --with-mpi=1 
--download-mpich=1 --with-sundials=1 --download-sundials=1 
--with-parmetis=1 --download-parmetis=1 --with-hypre=1 --download-hypre=1
application called MPI_Abort(MPI_COMM_WORLD, 59) - process 0
[2]PETSC ERROR: 
------------------------------------------------------------------------
[2]PETSC ERROR: User provided function() line 0 in unknown directory 
unknown file
[3] MatMult line 2156 
/home/kontzialis/petsc-3.2-p5/src/mat/interface/matrix.c
[3]PETSC ERROR: [3] base_residual_implicit line 27 
"unknowndirectory/"../src/base_residual_implicit.c
[3]PETSC ERROR: [3] MatFDColoringApply_BAIJ line 2768 
/home/kontzialis/petsc-3.2-p5/src/mat/impls/baij/seq/baij.c
[3]PETSC ERROR: [3] MatFDColoringApply line 511 
/home/kontzialis/petsc-3.2-p5/src/mat/matfd/fdmatrix.c
[3]PETSC ERROR: [3] SNESDefaultComputeJacobianColor line 40 
/home/kontzialis/petsc-3.2-p5/src/snes/interface/snesj2.c
[3]PETSC ERROR: [3] SNES user Jacobian function line 0 unknownunknown
[3]PETSC ERROR: [3] SNESComputeJacobian line 1322 
/home/kontzialis/petsc-3.2-p5/src/snes/interface/snes.c
[cli_0]: aborting job:
application called MPI_Abort(MPI_COMM_WORLD, 59) - process 0
application called MPI_Abort(MPI_COMM_WORLD, 59) - process 7
application called MPI_Abort(MPI_COMM_WORLD, 59) - process 4
application called MPI_Abort(MPI_COMM_WORLD, 59) - process 6
[cli_7]: [cli_4]: aborting job:
application called MPI_Abort(MPI_COMM_WORLD, 59) - process 7
application called MPI_Abort(MPI_COMM_WORLD, 59) - process 1
application called MPI_Abort(MPI_COMM_WORLD, 59) - process 5
aborting job:
application called MPI_Abort(MPI_COMM_WORLD, 59) - process 4
[cli_6]: aborting job:
application called MPI_Abort(MPI_COMM_WORLD, 59) - process 6
[cli_1]: [cli_5]: aborting job:
application called MPI_Abort(MPI_COMM_WORLD, 59) - process 1
aborting job:
application called MPI_Abort(MPI_COMM_WORLD, 59) - process 5
application called MPI_Abort(MPI_COMM_WORLD, 59) - process 2
[3]PETSC ERROR: --------------------- Error Message 
------------------------------------
[3]PETSC ERROR: Signal received!
[3]PETSC ERROR: 
------------------------------------------------------------------------
[3]PETSC ERROR: Petsc Release Version 3.2.0, Patch 5, Sat Oct 29 
13:45:54 CDT 2011
[3]PETSC ERROR: See docs/changes/index.html for recent updates.
[3]PETSC ERROR: See docs/faq.html for hints about trouble shooting.
[3]PETSC ERROR: See docs/index.html for manual pages.
[3]PETSC ERROR: 
------------------------------------------------------------------------
[3]PETSC ERROR: ./hoac on a linux-gnu named PlusSodaL by kontzialis Sat 
Nov  5 21:36:27 2011
[3]PETSC ERROR: [cli_2]: Libraries linked from 
/home/kontzialis/petsc-3.2-p5/linux-gnu-c-debug/lib
[3]PETSC ERROR: aborting job:
application called MPI_Abort(MPI_COMM_WORLD, 59) - process 2
Configure run at Sat Nov  5 20:58:12 2011
[3]PETSC ERROR: Configure options --with-debugging=1 
---with-mpi-dir=/usr/lib64/mpich2/bin --with-shared-libraries 
--with-shared-libraries --with-large-file-io=1 --with-precision=double 
--with-blacs=1 --download-blacs=yes --download-f-blas-lapack=yes 
--with-plapack=1 --download-plapack=yes --with-scalapack=1 
--download-scalapack=yes --with-superlu=1 --download-superlu=yes 
--with-superlu_dist=1 --download-superlu_dist=yes --with-ml=1 
--download-ml=yes --with-umfpack=1 --download-umfpack=yes --with-mpi=1 
--download-mpich=1 --with-sundials=1 --download-sundials=1 
--with-parmetis=1 --download-parmetis=1 --with-hypre=1 --download-hypre=1
[3]PETSC ERROR: 
------------------------------------------------------------------------
[3]PETSC ERROR: User provided function() line 0 in unknown directory 
unknown file
application called MPI_Abort(MPI_COMM_WORLD, 59) - process 3
[cli_3]: aborting job:
application called MPI_Abort(MPI_COMM_WORLD, 59) - process 3
==25984==
==25984== HEAP SUMMARY:
==25984==     in use at exit: 2,998,242 bytes in 3,058 blocks
==25984==   total heap usage: 6,616 allocs, 3,558 frees, 25,981,044 
bytes allocated
==25984==
==25983==
==25983== HEAP SUMMARY:
==25983==     in use at exit: 3,495,890 bytes in 3,233 blocks
==25983==   total heap usage: 6,903 allocs, 3,670 frees, 25,400,971 
bytes allocated
==25983==
==25977==
==25981==
==25977== HEAP SUMMARY:
==25977==     in use at exit: 3,068,055 bytes in 3,075 blocks
==25977==   total heap usage: 6,625 allocs, 3,550 frees, 22,077,530 
bytes allocated
==25977==
==25981== HEAP SUMMARY:
==25981==     in use at exit: 3,236,727 bytes in 3,119 blocks
==25981==   total heap usage: 6,700 allocs, 3,581 frees, 23,513,895 
bytes allocated
==25981==
==25978==
==25982==
==25982== HEAP SUMMARY:
==25982==     in use at exit: 3,291,403 bytes in 3,135 blocks
==25982==   total heap usage: 6,712 allocs, 3,577 frees, 24,919,538 
bytes allocated
==25982==
==25978== HEAP SUMMARY:
==25978==     in use at exit: 2,948,439 bytes in 3,043 blocks
==25978==   total heap usage: 6,477 allocs, 3,434 frees, 18,814,766 
bytes allocated
==25978==
==25979==
==25979== HEAP SUMMARY:
==25979==     in use at exit: 2,921,710 bytes in 3,093 blocks
==25979==   total heap usage: 6,538 allocs, 3,445 frees, 14,632,326 
bytes allocated
==25979==
==25980==
==25980== HEAP SUMMARY:
==25980==     in use at exit: 2,940,474 bytes in 3,056 blocks
==25980==   total heap usage: 6,597 allocs, 3,541 frees, 24,476,005 
bytes allocated
==25980==
==25984== LEAK SUMMARY:
==25984==    definitely lost: 584 bytes in 16 blocks
==25984==    indirectly lost: 128 bytes in 8 blocks
==25984==      possibly lost: 0 bytes in 0 blocks
==25984==    still reachable: 2,997,530 bytes in 3,034 blocks
==25984==         suppressed: 0 bytes in 0 blocks
==25984== Rerun with --leak-check=full to see details of leaked memory
==25984==
==25984== For counts of detected and suppressed errors, rerun with: -v
==25984== Use --track-origins=yes to see where uninitialised values come 
from
==25984== ERROR SUMMARY: 3 errors from 3 contexts (suppressed: 6 from 6)
==25977== LEAK SUMMARY:
==25977==    definitely lost: 584 bytes in 16 blocks
==25977==    indirectly lost: 128 bytes in 8 blocks
==25977==      possibly lost: 0 bytes in 0 blocks
==25977==    still reachable: 3,067,343 bytes in 3,051 blocks
==25977==         suppressed: 0 bytes in 0 blocks
==25977== Rerun with --leak-check=full to see details of leaked memory
==25977==
==25977== For counts of detected and suppressed errors, rerun with: -v
==25977== ERROR SUMMARY: 1 errors from 1 contexts (suppressed: 6 from 6)
==25981== LEAK SUMMARY:
==25981==    definitely lost: 584 bytes in 16 blocks
==25981==    indirectly lost: 128 bytes in 8 blocks
==25981==      possibly lost: 0 bytes in 0 blocks
==25981==    still reachable: 3,236,015 bytes in 3,095 blocks
==25981==         suppressed: 0 bytes in 0 blocks
==25981== Rerun with --leak-check=full to see details of leaked memory
==25981==
==25981== For counts of detected and suppressed errors, rerun with: -v
==25981== Use --track-origins=yes to see where uninitialised values come 
from
==25981== ERROR SUMMARY: 3 errors from 3 contexts (suppressed: 6 from 6)
==25983== LEAK SUMMARY:
==25983==    definitely lost: 584 bytes in 16 blocks
==25983==    indirectly lost: 128 bytes in 8 blocks
==25983==      possibly lost: 0 bytes in 0 blocks
==25983==    still reachable: 3,495,178 bytes in 3,209 blocks
==25983==         suppressed: 0 bytes in 0 blocks
==25983== Rerun with --leak-check=full to see details of leaked memory
==25983==
==25983== For counts of detected and suppressed errors, rerun with: -v
==25983== Use --track-origins=yes to see where uninitialised values come 
from
==25983== ERROR SUMMARY: 3 errors from 3 contexts (suppressed: 6 from 6)
==25978== LEAK SUMMARY:
==25978==    definitely lost: 584 bytes in 16 blocks
==25978==    indirectly lost: 128 bytes in 8 blocks
==25978==      possibly lost: 0 bytes in 0 blocks
==25978==    still reachable: 2,947,727 bytes in 3,019 blocks
==25978==         suppressed: 0 bytes in 0 blocks
==25978== Rerun with --leak-check=full to see details of leaked memory
==25978==
==25978== For counts of detected and suppressed errors, rerun with: -v
==25978== Use --track-origins=yes to see where uninitialised values come 
from
==25978== ERROR SUMMARY: 3 errors from 3 contexts (suppressed: 6 from 6)


My base_residual_implicit function is the following:

/******************************************************************************/
/* Function name: 
base_residual_implicit.c                                             */
/* Engineer: 
C.Kontzialis                                                     */
/* E-mail: 
ckontzialis at lycos.com                                              */
/* Function 
description:                                                      */
/* Function base_residual_implicit.c computes the residual at every 
element for the NS*/
/* 
equations.                                                                 
*/
/******************************************************************************/

/* Data structure for hoac */
#include "hoac.h"

PetscErrorCode base_residual_implicit(TS ts, /* Time stepper context [in] */
PetscReal t, /* Time t [in]*/
Vec sv, /* Global vector [in]*/
Vec svt, /* Global vector [in]*/
Vec gres, /* Global vector [out]*/
void *ctx /* HoAc Context [in]*/
)

{

     PetscErrorCode ierr;

     SYS sys = *((SYS *) ctx);

     PetscFunctionBegin;

     ierr = MatMult(sys.M, svt, sys.gsvk);
     CHKERRQ(ierr);

     ierr = residual(sv, gres, ctx);
     CHKERRQ(ierr);

     ierr = VecAXPY(gres, 1.0, sys.gsvk);
     CHKERRQ(ierr);

     PetscFunctionReturn(0);

} /* base_residual_implicit.c */


But, even though there is a computation of the residual and I get a result:

     0 SNES Function norm 2.822902692891e-01

an error occurs. Why? What should I do?

Thank you very much!!!

Kostas


More information about the petsc-users mailing list