Using -pc_jacobi_rowmax or -pc_jacobi_rowsum

Nguyen, Hung V ERDC-ITL-MS Hung.V.Nguyen at usace.army.mil
Wed Feb 11 11:01:49 CST 2009


 Hello Mathew,


>1) We need the entire error message, which will include a stack trace.

The entire error message is the same as running ex2.c in
$PETSC_DIR/src/ksp/ksp/examples/tutorials, see below.

> 2) What version of PETSc are you running?

/usr/local/usp/PETtools/CE/MATH/petsc-2.3.3-p15

>3) I cannot reproduce this problem in PETSc 3.0.0

I can reproduce this problem with PETSc 2.3.3-p15


hvnguyen:jade20% aprun -n 2 ./ex2 -ksp_type cg -pc_type jacobi
Norm of error 1.6744e-05 iterations 13
Application 555812 resources: utime 0, stime 5

hvnguyen:jade20% aprun -n 2 ./ex2 -ksp_type cg -pc_type jacobi
-pc_jacobi_rowmax
[1]PETSC ERROR: [0]PETSC ERROR: --------------------- Error Message
------------------------------------
--------------------- Error Message ------------------------------------
[1]PETSC ERROR: No support for this operation for this object type!
[0]PETSC ERROR: [1]PETSC ERROR: Mat type mpiaij!
[1]PETSC ERROR:
------------------------------------------------------------------------
[1]PETSC ERROR: Petsc Release Version 2.3.3, Patch 15, Tue Sep 23 10:02:49
CDT 2008 HG revision: 31306062cd1a6f6a2496fccb4878f485c9b91760
[1]PETSC ERROR: See docs/changes/index.html for recent updates.
[1]PETSC ERROR: See docs/faq.html for hints about trouble shooting.
[1]PETSC ERROR: See docs/index.html for manual pages.
[1]PETSC ERROR:
------------------------------------------------------------------------
[1]PETSC ERROR: No support for this operation for this object type!
./ex2 on a CrayXT4-O named nid01795 by Unknown Wed Feb 11 16:57:45 2009
[1]PETSC ERROR: Libraries linked from
/usr/local/usp/PETtools/CE/MATH/petsc-2.3.3-p15/lib/CrayXT4-O
[1]PETSC ERROR: Configure run at Tue Oct 28 15:32:12 2008
[1]PETSC ERROR: [0]PETSC ERROR: Mat type mpiaij!
[0]PETSC ERROR:
------------------------------------------------------------------------
[0]PETSC ERROR: Petsc Release Version 2.3.3, Patch 15, Tue Sep 23 10:02:49
CDT 2008 HG revision: 31306062cd1a6f6a2496fccb4878f485c9b91760
[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: Configure options --with-memcmp-ok --sizeof_char=1
--sizeof_void_p=8 --sizeof_short=2 --sizeof_int=4 --sizeof_long=8
--sizeof_long_long=8 --sizeof_float=4 --sizeof_double=8 --bits_per_byte=8
--sizeof_MPI_Comm=4 --sizeof_MPI_Fint=4 --with-batch=1 --with-fc=ftn
--with-cc=cc --with-blas-lib=-lsci --with-lapack-lib=-lsci
--with-mpi-dir=/opt/xt-mpt/2.0.49/mpich2-64/P2 --with-mpi-shared=0
--with-shared=0 --with-debugging=0 --with-error-checking=0
-PETSC_ARCH=CrayXT4-O
[1]PETSC ERROR: ./ex2 on a CrayXT4-O named nid01795 by Unknown Wed Feb 11
16:57:45 2009
[0]PETSC ERROR:
------------------------------------------------------------------------
[1]PETSC ERROR: Libraries linked from
/usr/local/usp/PETtools/CE/MATH/petsc-2.3.3-p15/lib/CrayXT4-O
[0]PETSC ERROR: Configure run at Tue Oct 28 15:32:12 2008
[0]PETSC ERROR: aborting job:
application called MPI_Abort(MPI_COMM_WORLD, 1) - process 1
aborting job:
application called MPI_Abort(MPI_COMM_WORLD, 1) - process 0
MatGetRowMaxAbs() line 3405 in src/mat/interface/matrix.c
Configure options --with-memcmp-ok --sizeof_char=1 --sizeof_void_p=8
--sizeof_short=2 --sizeof_int=4 --sizeof_long=8 --sizeof_long_long=8
--sizeof_float=4 --sizeof_double=8 --bits_per_byte=8 --sizeof_MPI_Comm=4
--sizeof_MPI_Fint=4 --with-batch=1 --with-fc=ftn --with-cc=cc
--with-blas-lib=-lsci --with-lapack-lib=-lsci
--with-mpi-dir=/opt/xt-mpt/2.0.49/mpich2-64/P2 --with-mpi-shared=0
--with-shared=0 --with-debugging=0 --with-error-checking=0
-PETSC_ARCH=CrayXT4-O
[0]PETSC ERROR: [1]PETSC ERROR:
------------------------------------------------------------------------
PCSetUp_Jacobi() line 162 in src/ksp/pc/impls/jacobi/jacobi.c
[0]PETSC ERROR: [1]PETSC ERROR: MatGetRowMaxAbs() line 3405 in
src/mat/interface/matrix.c
PCSetUp_Jacobi_NonSymmetric() line 249 in src/ksp/pc/impls/jacobi/jacobi.c
[1]PETSC ERROR: [0]PETSC ERROR: PCApply_Jacobi() line 274 in
src/ksp/pc/impls/jacobi/jacobi.c
PCSetUp_Jacobi() line 162 in src/ksp/pc/impls/jacobi/jacobi.c
[1]PETSC ERROR: [0]PETSC ERROR: PCApply() line 356 in
src/ksp/pc/interface/precon.c
PCSetUp_Jacobi_NonSymmetric() line 249 in src/ksp/pc/impls/jacobi/jacobi.c
[1]PETSC ERROR: [0]PETSC ERROR: KSPSolve_CG() line 146 in
src/ksp/ksp/impls/cg/cg.c
PCApply_Jacobi() line 274 in src/ksp/pc/impls/jacobi/jacobi.c
[1]PETSC ERROR: [0]PETSC ERROR: KSPSolve() line 379 in
src/ksp/ksp/interface/itfunc.c
PCApply() line 356 in src/ksp/pc/interface/precon.c
[1]PETSC ERROR: [0]PETSC ERROR: main() line 192 in
src/ksp/ksp/examples/tutorials/ex2.c
KSPSolve_CG() line 146 in src/ksp/ksp/impls/cg/cg.c
[0]PETSC ERROR: KSPSolve() line 379 in src/ksp/ksp/interface/itfunc.c
[0]PETSC ERROR: main() line 192 in src/ksp/ksp/examples/tutorials/ex2.c
[NID 1795]Apid 555813: initiated application termination
Application 555813 exit codes: 1
Application 555813 resources: utime 0, stime 6
hvnguyen:jade20%


 
-----Original Message-----
From: petsc-users-bounces at mcs.anl.gov
[mailto:petsc-users-bounces at mcs.anl.gov] On Behalf Of Matthew Knepley
Sent: Wednesday, February 11, 2009 10:41 AM
To: PETSc users list
Subject: Re: Using -pc_jacobi_rowmax or -pc_jacobi_rowsum

On Wed, Feb 11, 2009 at 9:52 AM, Nguyen, Hung V ERDC-ITL-MS
<Hung.V.Nguyen at usace.army.mil> wrote:
> All,
>
> I tried to use the jacobi preconditioner with maximum entry in each 
> row as the diagonal preconditioner and got the error message below. 
> The matrix was built with mpiaij type. Does it require different type of
matrix?

1) We need the entire error message, which will include a stack trace.

2) What version of PETSc are you running?

3) I cannot reproduce this problem in PETSc 3.0.0

  cd $PETSC_DIR/src/ksp/ksp/examples/tutorials
  make ex2
  $MPIEXEC -n 2 ./ex2 -pc_type jacobi -pc_jacobi_rowmax

  Thanks,

     Matt

> Thank you.
>
> -Hung
>
>  hvnguyen:jade20% aprun -n 2 ./test_read_petsc -ksp_type cg -pc_type 
> jacobi -ksp_rtol 1.0e-12 -ksp_max_it 50000 Time in PETSc solver: 
> 4.725237 seconds
> The number of iteration       = 670
> The solution residual error = 3.221739e-09
> 2 norm 4.813996e-04
>  infinity norm 5.369620e-06
>  1 norm 1.255338e-01
> Application 555708 resources: utime 486, stime 12 hvnguyen:jade20%
>
> hvnguyen:jade20%  aprun -n 2  ./test_read_petsc  -ksp_type cg -pc_type 
> jacobi -ksp_rtol 1.0e-12 -ksp_max_it 50000 -pc_jacobi_rowmax [1]PETSC 
> ERROR: [0]PETSC ERROR: --------------------- Error Message
> ------------------------------------
> --------------------- Error Message 
> ------------------------------------
> [1]PETSC ERROR: [0]PETSC ERROR: No support for this operation for this 
> object type!
> [1]PETSC ERROR: Mat type mpiaij!
> [1]PETSC ERROR:
> ----------------------------------------------------------------------
> -- [1]PETSC ERROR: No support for this operation for this object type!
> [0]PETSC ERROR: Mat type mpiaij!
> [0]PETSC ERROR: Petsc Release Version 2.3.3, Patch 15, Tue Sep 23 
> 10:02:49 CDT 2008 HG revision:
> 31306062cd1a6f6a2496fccb4878f485c9b91760------------------------------
> -------
> -----------------------------------
> [1]PETSC ERROR: See docs/changes/index.html for recent updates.
> [1]PETSC ERROR: See docs/faq.html for hints about trouble shooting.
> [1]PETSC ERROR: See docs/index.html for manual pages.
>



--
What most experimenters take for granted before they begin their experiments
is infinitely more interesting than any results to which their experiments
lead.
-- Norbert Wiener


More information about the petsc-users mailing list