petsc-dev make test breaks with 2 processes?
mspieg
mspieg at ldeo.columbia.edu
Tue Sep 25 22:46:03 CDT 2007
Hi all,
I just pulled, reconfigured and rebuilt petsc-dev (changeset:
11135:7c2e5fab809d) and the 2 processor test failed with an error
from PetscLogFlops (see error message below). The same configuration
file works fine in the the latest release 2.3.3-p6. Not immediately
critical, but I need petsc-dev for the PCDMMGDM routines (of which
I'm still tracking down a pernicous bug, but am getting close).
All help greatly appreciated
cheers
marc
p.s. system is MacOSX 10.4.10, mpich2-1.0.5p4
-------------output of make test----------------------
Running test examples to verify correct installation
C/C++ example src/snes/examples/tutorials/ex19 run successfully with
1 MPI process
Possible error running C/C++ src/snes/examples/tutorials/ex19 with 2
MPI processes
See http://www.mcs.anl.gov/petsc/petsc-as/documentation/
troubleshooting.html
lid velocity = 0.0016, prandtl # = 1, grashof # = 1
[0]PETSC ERROR: --------------------- Error Message
------------------------------------
[0]PETSC ERROR: Argument out of range!
[0]PETSC ERROR: PetscLogFlops: flop-count given is neagitive: -32.00!
[0]PETSC ERROR:
------------------------------------------------------------------------
[0]PETSC ERROR: Petsc Development Version 2.3.3, Patch 6, unknown HG
revision: unknown
[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: ./ex19 on a macosx-gn named mingus.home by mspieg Tue
Sep 25 23:34:58 2007
[0]PETSC ERROR: Libraries linked from /Applications/petsc/petsc-dev/lib
[0]PETSC ERROR: Configure run at Tue Sep 25 23:12:21 2007
[0]PETSC ERROR: Configure options CC=gcc FC=gfortran --with-python --
with-shared=1 --with-dynamic=1 --with-mpi-dir=/Applications/mpich/
mpich2-1.0.5p4 --do
[1]PETSC ERROR: --------------------- Error Message
------------------------------------
[1]PETSC ERROR: Argument out of range!
[1]PETSC ERROR: PetscLogFlops: flop-count given is neagitive: -84.00!
[1]PETSC ERROR:
------------------------------------------------------------------------
[1]PETSC ERROR: Petsc Development Version 2.3.3, Patch 6, unknown HG
revision: unknown
[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: ./ex19 on a macosx-gn named mingus.home by mspieg Tue
Sep 25 23:34:58 2007
[1]PETSC ERROR: Libraries linked from /Applications/petsc/petsc-dev/lib
[1]PETSC ERROR: Configure run at Tue Sep 25 23:12:21 2007
[1]PETSC ERROR: Configure options CC=gcc FC=gfortran --with-python --
with-shared=1 --with-dynamic=1 --with-mpi-dir=/Applications/mpich/
mpich2-1.0.5p4 --download-mpich-pm=gforker --with-debugging=1
PETSC_ARCH=macosx-gnu-local-g
[0]PETSC ERROR:
------------------------------------------------------------------------
[0]PETSC ERROR: MatMultAdd_SeqMAIJ_4() line 585 in src/mat/impls/maij/
maij.c
[0]PETSC ERROR: MatMult_MPIMAIJ_dof() line 2118 in src/mat/impls/maij/
maij.c
[0]PETSC ERROR: MatMult() line 1670 in src/mat/interface/matrix.c
[0]PETSC ERROR: MatInterpolate() line 5925 in src/mat/interface/matrix.c
[0]PETSC ERROR: PCMGFCycle_Private() line 28 in src/ksp/pc/impls/mg/
fmg.c
[0]PETSC ERROR: PCApply_MG() line 207 in src/ksp/pc/impls/mg/mg.c
[0]PETSC ERROR: PCApply() line 356 in src/ksp/pc/interface/precon.c
[0]PETSC ERROR: FGMREScycle() line 232 in src/ksp/ksp/impls/gmres/
fgmres/fgmres.c
[0]PETSC ERROR: KSPSolve_FGMRES() line 358 in src/ksp/ksp/impls/gmres/
fgmres/fgmres.c
[0]PETSC ERROR: KSPSolve() line 378 in src/ksp/ksp/interface/itfunc.c
[0]PETSC ERROR: SNES_KSPSolve() line 2539 in src/snes/interface/snes.c
[0]PETSC ERROR: SNESSolve_LS() line 184 in src/snes/wnload-mpich-
pm=gforker --with-debugging=1 PETSC_ARCH=macosx-gnu-local-g
[1]PETSC ERROR:
------------------------------------------------------------------------
[1]PETSC ERROR: MatMultAdd_SeqMAIJ_4() line 585 in src/mat/impls/maij/
maij.c
[1]PETSC ERROR: MatMult_MPIMAIJ_dof() line 2118 in src/mat/impls/maij/
maij.c
[1]PETSC ERROR: MatMult() line 1670 in src/mat/interface/matrix.c
[1]PETSC ERROR: MatInterpolate() line 5925 in src/mat/interface/matrix.c
[1]PETSC ERROR: PCMGFCycle_Private() line 28 in src/ksp/pc/impls/mg/
fmg.c
[1]PETSC ERROR: PCApply_MG() line 207 in src/ksp/pc/impls/mg/mg.c
[1]PETSC ERROR: PCApply() line 356 in src/ksp/pc/interface/precon.c
[1]PETSC ERROR: FGMREScycle() line 232 in src/ksp/ksp/impls/gmres/
fgmres/fgmres.c
[1]PETSC ERROR: KSPSolve_FGMRES() line 358 in src/ksp/ksp/impls/gmres/
fgmres/fgmres.c
[1]PETSC ERROR: KSPSolve() line 378 in src/ksp/ksp/interface/itfunc.c
[1]PETSC ERROR: SNES_KSPSolve() line 2539 in src/snes/interface/snes.c
[1]PETSC ERROR: SNESSolve_LS() line 184 in src/snes/impls/ls/ls.c
[0]PETSC ERROR: SNESSolve() line 1867 in src/snes/interface/snes.c
[0]PETSC ERROR: DMMGSolveSNES() line 510 in src/snes/utils/damgsnes.c
[0]PETSC ERROR: DMMGSolve() line 393 in src/snes/utils/damg.c
[0]PETSC ERROR: main() line 154 in src/snes/examples/tutorials/ex19.c
[cli_0]: aborting job:
application called MPI_Abort(MPI_COMM_WORLD, 1) - process 0
impls/ls/ls.c
[1]PETSC ERROR: SNESSolve() line 1867 in src/snes/interface/snes.c
[1]PETSC ERROR: DMMGSolveSNES() line 510 in src/snes/utils/damgsnes.c
[1]PETSC ERROR: DMMGSolve() line 393 in src/snes/utils/damg.c
[1]PETSC ERROR: main() line 154 in src/snes/examples/tutorials/ex19.c
[cli_1]: aborting job:
application called MPI_Abort(MPI_COMM_WORLD, 1) - process 1
Graphics example src/snes/examples/tutorials/ex19 run successfully
with 1 MPI process
Fortran example src/snes/examples/tutorials/ex5f run successfully
with 1 MPI process
Completed test examples
----------------------------------------------------
Marc Spiegelman
Lamont-Doherty Earth Observatory
Dept. of Applied Physics/Applied Math
Columbia University
http://www.ldeo.columbia.edu/~mspieg
----------------------------------------------------
-------------- next part --------------
An HTML attachment was scrubbed...
URL: <http://lists.mcs.anl.gov/pipermail/petsc-dev/attachments/20070925/9865efe1/attachment.html>
More information about the petsc-dev
mailing list