[petsc-users] GAMG issue

John Mousel john.mousel at gmail.com
Tue Mar 20 09:19:02 CDT 2012


Mark,

Sorry for the late reply. I've been on travel and hadn't had a chance to
pick this back up. I've tried running with the suggested options:

-ksp_type bcgsl -pc_type gamg  -pc_gamg_coarse_eq_limit 10
-pc_gamg_agg_nsmooths 1 -pc_gamg_sym_graph -mg_coarse_ksp_type richardson
-mg_coarse_pc_type sor -mg_coarse_pc_sor_its 8 -ksp_diagonal_scale
-ksp_diagonal_scale_fix -ksp_monitor_true_residual -ksp_view
-pc_gamg_verbose 1

With these options, the convergence starts to hang (see attached
GAMG_kspview.txt). The hanging happens for both -mg_coarse_ksp_type
richardson and preonly. It was my understanding from previous emails that
using preonly made it so that only the preconditioner was run, which in
this case would be 8 sweeps of SOR. If I get rid of the
-pc_gamg_agg_nsmooths 1 (see GAMG_kspview_nosmooth.txt), the problem
converges, but again the convergence is slow. Without this option, both
Richardson and preonly converge in 172 iterations.

Matt, I've checked and the problem does converge in the true residual using
GAMG, ML, HYPRE, and ILU preconditioned BiCG. I explicitly ensure that a
solution exists by projecting the rhs vector out of the nullity of the
transpose of operator.

John


On Fri, Mar 16, 2012 at 2:04 PM, Mark F. Adams <mark.adams at columbia.edu>wrote:

> John, did this get resolved?
> Mark
>
> On Mar 15, 2012, at 4:24 PM, John Mousel wrote:
>
> Mark,
>
> Running without the options you mentioned before leads to slightly worse
> performance (175 iterations).
> I have not been able to get run coarse grid solve to work with LU while
> running ML. It keeps experiencing a zero pivot, and all the combinations of
> shifting i've tried haven't lead me anywhere, hence the SOR on the course
> grid. Also, the ML manual suggests limiting the number of levels to 3 or 4
> and performing a few sweeps of an iterative method as opposed to a direct
> solve.
>
> John
>
> On Thu, Mar 15, 2012 at 12:04 PM, Mark F. Adams <mark.adams at columbia.edu>wrote:
>
>> You also want:  -pc_gamg_agg_nsmooths 1
>>
>> You are running plain aggregation.  If it is Poisson then smoothing is
>> good.
>>
>> Is this problem singular?  Can you try running ML with these parameters
>> and see if its performance degrades?  The ML implementation uses the PETSC
>> infrastructure and uses a very similar algorithm to GAMG-SA.  We should be
>> able to get these two to match pretty well.
>>
>> Mark
>>
>>
>> On Mar 15, 2012, at 12:21 PM, John Mousel wrote:
>>
>> Mark,
>>
>> I ran with those options removed (see the run options listed below).
>> Things actually got slightly worse. Now it's up to 142 iterations. I have
>> attached the ksp_view output.
>>
>> -ksp_type bcgsl -pc_type gamg -pc_gamg_sym_graph -ksp_diagonal_scale
>> -ksp_diagonal_scale_fix -mg_levels_ksp_type richardson -mg_levels_pc_type
>> sor -pc_gamg_verbose 1
>>
>>
>> John
>>
>>
>> On Thu, Mar 15, 2012 at 10:55 AM, Mark F. Adams <mark.adams at columbia.edu>wrote:
>>
>>> John, can you run again with:  -pc_gamg_verbose 1
>>>
>>> And I would not use: -pc_mg_levels 4 -mg_coarse_ksp_type preonly
>>> -mg_coarse_pc_type sor -mg_coarse_pc_sor_its 8
>>>
>>> 1) I think -mg_coarse_ksp_type preonly and -mg_coarse_pc_sor_its 8 do
>>> not do what you think.  I think this is the same as 1 iteration.  I think
>>> you want 'richardson' not 'preonly'.
>>>
>>> 2) Why are you using sor as the coarse solver?  If your problem is
>>> singular then you want to use as many levels as possible to get the coarse
>>> grid to be tiny.  I'm pretty sure HYPRE ignores the coarse solver
>>> parameters.  But ML uses them and it is converging well.
>>>
>>> 3) I would not specify the number of levels.  GAMG, and I think the
>>> rest, have internal logic for stopping a the right level.  If the coarse
>>> level is large and you use just 8 iterations of sor then convergence will
>>> suffer.
>>>
>>> Mark
>>>
>>> On Mar 15, 2012, at 11:13 AM, John Mousel wrote:
>>>
>>> Mark,
>>>
>>> The changes pulled through this morning. I've run it with the options
>>>
>>> -ksp_type bcgsl -pc_type gamg -pc_gamg_sym_graph -ksp_diagonal_scale
>>> -ksp_diagonal_scale_fix -pc_mg_levels 4 -mg_levels_ksp_type richardson
>>> -mg_levels_pc_type sor -mg_coarse_ksp_type preonly -mg_coarse_pc_type sor
>>> -mg_coarse_pc_sor_its 8
>>>
>>> and it converges in the true residual, but it's not converging as fast
>>> as anticpated. The matrix arises from a non-symmetric discretization of the
>>> Poisson equation. The solve takes GAMG 114 iterations, whereas ML takes 24
>>> iterations, BoomerAMG takes 22 iterations, and -ksp_type bcgsl -pc_type
>>> bjacobi -sub_pc_type ilu -sub_pc_factor_levels 4 takes around 170. I've
>>> attached the -ksp_view results for ML,GAMG, and HYPRE. I've attempted to
>>> make all the options the same on all levels for ML and GAMG.
>>>
>>> Any thoughts?
>>>
>>> John
>>>
>>>
>>> On Wed, Mar 14, 2012 at 6:04 PM, Mark F. Adams <mark.adams at columbia.edu>wrote:
>>>
>>>> Humm, I see it with hg view (appended).
>>>>
>>>> Satish, my main repo looks hosed.  I see this:
>>>>
>>>> ~/Codes/petsc-dev>hg update
>>>> abort: crosses branches (merge branches or use --clean to discard
>>>> changes)
>>>> ~/Codes/petsc-dev>hg merge
>>>> abort: branch 'default' has 3 heads - please merge with an explicit rev
>>>> (run 'hg heads .' to see heads)
>>>> ~/Codes/petsc-dev>hg heads
>>>> changeset:   22496:8e2a98268179
>>>> tag:         tip
>>>> user:        Barry Smith <bsmith at mcs.anl.gov>
>>>> date:        Wed Mar 14 16:42:25 2012 -0500
>>>> files:       src/vec/is/interface/f90-custom/zindexf90.c
>>>> src/vec/vec/interface/f90-custom/zvectorf90.c
>>>> description:
>>>> undoing manually changes I put in because Satish had a better fix
>>>>
>>>>
>>>> changeset:   22492:bda4df63072d
>>>> user:        Mark F. Adams <mark.adams at columbia.edu>
>>>> date:        Wed Mar 14 17:39:52 2012 -0400
>>>> files:       src/ksp/pc/impls/gamg/tools.c
>>>> description:
>>>> fix for unsymmetric matrices.
>>>>
>>>>
>>>> changeset:   22469:b063baf366e4
>>>> user:        Mark F. Adams <mark.adams at columbia.edu>
>>>> date:        Wed Mar 14 14:22:28 2012 -0400
>>>> files:       src/ksp/pc/impls/gamg/tools.c
>>>> description:
>>>> added fix for preallocation for unsymetric matrices.
>>>>
>>>> Mark
>>>>
>>>> my 'hg view' on my merge repo:
>>>>
>>>> Revision: 22492
>>>> Branch: default
>>>> Author: Mark F. Adams <mark.adams at columbia.edu>  2012-03-14 17:39:52
>>>> Committer: Mark F. Adams <mark.adams at columbia.edu>  2012-03-14 17:39:52
>>>> Tags: tip
>>>> Parent: 22491:451bbbd291c2 (Small fixes to the BT linesearch)
>>>>
>>>>     fix for unsymmetric matrices.
>>>>
>>>>
>>>> ------------------------ src/ksp/pc/impls/gamg/tools.c
>>>> ------------------------
>>>> @@ -103,7 +103,7 @@
>>>>    PetscErrorCode ierr;
>>>>    PetscInt       Istart,Iend,Ii,jj,ncols,nnz0,nnz1, NN, MM, nloc;
>>>>    PetscMPIInt    mype, npe;
>>>> -  Mat            Gmat = *a_Gmat, tGmat;
>>>> +  Mat            Gmat = *a_Gmat, tGmat, matTrans;
>>>>    MPI_Comm       wcomm = ((PetscObject)Gmat)->comm;
>>>>    const PetscScalar *vals;
>>>>    const PetscInt *idx;
>>>> @@ -127,6 +127,10 @@
>>>>    ierr = MatDiagonalScale( Gmat, diag, diag ); CHKERRQ(ierr);
>>>>    ierr = VecDestroy( &diag );           CHKERRQ(ierr);
>>>>
>>>> +  if( symm ) {
>>>> +    ierr = MatTranspose( Gmat, MAT_INITIAL_MATRIX, &matTrans );
>>>>  CHKERRQ(ierr);
>>>> +  }
>>>>  +
>>>>    /* filter - dup zeros out matrix */
>>>>    ierr = PetscMalloc( nloc*sizeof(PetscInt), &d_nnz ); CHKERRQ(ierr);
>>>>    ierr = PetscMalloc( nloc*sizeof(PetscInt), &o_nnz ); CHKERRQ(ierr);
>>>> @@ -135,6 +139,12 @@
>>>>      d_nnz[jj] = ncols;
>>>>      o_nnz[jj] = ncols;
>>>>      ierr = MatRestoreRow(Gmat,Ii,&ncols,PETSC_NULL,PETSC_NULL);
>>>> CHKERRQ(ierr);
>>>> +    if( symm ) {
>>>> +      ierr = MatGetRow(matTrans,Ii,&ncols,PETSC_NULL,PETSC_NULL);
>>>> CHKERRQ(ierr);
>>>> +      d_nnz[jj] += ncols;
>>>> +      o_nnz[jj] += ncols;
>>>> +      ierr = MatRestoreRow(matTrans,Ii,&ncols,PETSC_NULL,PETSC_NULL);
>>>> CHKERRQ(ierr);
>>>> +    }
>>>>      if( d_nnz[jj] > nloc ) d_nnz[jj] = nloc;
>>>>      if( o_nnz[jj] > (MM-nloc) ) o_nnz[jj] = MM - nloc;
>>>>    }
>>>> @@ -142,6 +152,9 @@
>>>>    CHKERRQ(ierr);
>>>>    ierr = PetscFree( d_nnz ); CHKERRQ(ierr);
>>>>    ierr = PetscFree( o_nnz ); CHKERRQ(ierr);
>>>> +  if( symm ) {
>>>> +    ierr = MatDestroy( &matTrans );  CHKERRQ(ierr);
>>>> +  }
>>>>
>>>>
>>>>
>>>>
>>>> On Mar 14, 2012, at 5:53 PM, John Mousel wrote:
>>>>
>>>> Mark,
>>>>
>>>> No change. Can you give me the location that you patched so I can check
>>>> to make sure it pulled?
>>>> I don't see it on the petsc-dev change log.
>>>>
>>>> John
>>>>
>>>> On Wed, Mar 14, 2012 at 4:40 PM, Mark F. Adams <mark.adams at columbia.edu
>>>> > wrote:
>>>>
>>>>> John, I've committed these changes, give a try.
>>>>>
>>>>> Mark
>>>>>
>>>>> On Mar 14, 2012, at 3:46 PM, Satish Balay wrote:
>>>>>
>>>>> > This is the usual merge [with uncommited changes] issue.
>>>>> >
>>>>> > You could use 'hg shelf' extension to shelve your local changes and
>>>>> > then do a merge [as Sean would suggest] - or do the merge in a
>>>>> > separate/clean clone [I normally do this..]
>>>>> >
>>>>> > i.e
>>>>> > cd ~/Codes
>>>>> > hg clone petsc-dev petsc-dev-merge
>>>>> > cd petsc-dev-merge
>>>>> > hg pull ssh://petsc@petsc.cs.iit.edu//hg/petsc/petsc-dev   #just to
>>>>> be sure, look for latest chagnes before merge..
>>>>> > hg merge
>>>>> > hg commit
>>>>> > hg push ssh://petsc@petsc.cs.iit.edu//hg/petsc/petsc-dev
>>>>> >
>>>>> > [now update your petsc-dev to latest]
>>>>> > cd ~/Codes/petsc-dev
>>>>> > hg pull
>>>>> > hg update
>>>>> >
>>>>> > Satish
>>>>> >
>>>>> > On Wed, 14 Mar 2012, Mark F. Adams wrote:
>>>>> >
>>>>> >> Great, that seems to work.
>>>>> >>
>>>>> >> I did a 'hg commit tools.c'
>>>>> >>
>>>>> >> and I want to push this file only.  I guess its the only thing in
>>>>> the change set so 'hg push' should be fine.  But I see this:
>>>>> >>
>>>>> >> ~/Codes/petsc-dev/src/ksp/pc/impls/gamg>hg update
>>>>> >> abort: crosses branches (merge branches or use --clean to discard
>>>>> changes)
>>>>> >> ~/Codes/petsc-dev/src/ksp/pc/impls/gamg>hg merge
>>>>> >> abort: outstanding uncommitted changes (use 'hg status' to list
>>>>> changes)
>>>>> >> ~/Codes/petsc-dev/src/ksp/pc/impls/gamg>hg status
>>>>> >> M include/petscmat.h
>>>>> >> M include/private/matimpl.h
>>>>> >> M src/ksp/pc/impls/gamg/agg.c
>>>>> >> M src/ksp/pc/impls/gamg/gamg.c
>>>>> >> M src/ksp/pc/impls/gamg/gamg.h
>>>>> >> M src/ksp/pc/impls/gamg/geo.c
>>>>> >> M src/mat/coarsen/coarsen.c
>>>>> >> M src/mat/coarsen/impls/hem/hem.c
>>>>> >> M src/mat/coarsen/impls/mis/mis.c
>>>>> >>
>>>>> >> Am I ready to do a push?
>>>>> >>
>>>>> >> Thanks,
>>>>> >> Mark
>>>>> >>
>>>>> >> On Mar 14, 2012, at 2:44 PM, Satish Balay wrote:
>>>>> >>
>>>>> >>> If commit is the last hg operation that you've done - then 'hg
>>>>> rollback' would undo this commit.
>>>>> >>>
>>>>> >>> Satish
>>>>> >>>
>>>>> >>> On Wed, 14 Mar 2012, Mark F. Adams wrote:
>>>>> >>>
>>>>> >>>> Damn, I'm not preallocating the graph perfectly for unsymmetric
>>>>> matrices and PETSc now dies on this.
>>>>> >>>>
>>>>> >>>> I have a fix but I committed it with other changes that I do not
>>>>> want to commit.  The changes are all in one file so I should be able to
>>>>> just commit this file.
>>>>> >>>>
>>>>> >>>> Anyone know how to delete a commit?
>>>>> >>>>
>>>>> >>>> I've tried:
>>>>> >>>>
>>>>> >>>> ~/Codes/petsc-dev/src/ksp/pc/impls/gamg>hg strip
>>>>> 22487:26ffb9eef17f
>>>>> >>>> hg: unknown command 'strip'
>>>>> >>>> 'strip' is provided by the following extension:
>>>>> >>>>
>>>>> >>>>   mq  manage a stack of patches
>>>>> >>>>
>>>>> >>>> use "hg help extensions" for information on enabling extensions
>>>>> >>>>
>>>>> >>>> But have not figured out how to load extensions.
>>>>> >>>>
>>>>> >>>> Mark
>>>>> >>>>
>>>>> >>>> On Mar 14, 2012, at 12:54 PM, John Mousel wrote:
>>>>> >>>>
>>>>> >>>>> Mark,
>>>>> >>>>>
>>>>> >>>>> I have a non-symmetric matrix. I am running with the following
>>>>> options.
>>>>> >>>>>
>>>>> >>>>> -pc_type gamg -pc_gamg_sym_graph -ksp_monitor_true_residual
>>>>> >>>>>
>>>>> >>>>> and with the inclusion of -pc_gamg_sym_graph, I get a new malloc
>>>>> error:
>>>>> >>>>>
>>>>> >>>>>
>>>>> >>>>> 0]PETSC ERROR: --------------------- Error Message
>>>>> ------------------------------------
>>>>> >>>>> [0]PETSC ERROR: Argument out of range!
>>>>> >>>>> [0]PETSC ERROR: New nonzero at (5150,9319) caused a malloc!
>>>>> >>>>> [0]PETSC ERROR:
>>>>> ------------------------------------------------------------------------
>>>>> >>>>> [0]PETSC ERROR: Petsc Development HG revision:
>>>>> 587b25035091aaa309c87c90ac64c13408ecf34e  HG Date: Wed Mar 14 09:22:54 2012
>>>>> -0500
>>>>> >>>>> [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: ../JohnRepo/VFOLD_exe on a linux-deb named
>>>>> wv.iihr.uiowa.edu by jmousel Wed Mar 14 11:51:35 2012
>>>>> >>>>> [0]PETSC ERROR: Libraries linked from
>>>>> /home/jmousel/NumericalLibraries/petsc-hg/petsc-dev/linux-debug/lib
>>>>> >>>>> [0]PETSC ERROR: Configure run at Wed Mar 14 09:46:39 2012
>>>>> >>>>> [0]PETSC ERROR: Configure options --download-blacs=1
>>>>> --download-hypre=1 --download-metis=1 --download-ml=1 --download-mpich=1
>>>>> --download-parmetis=1 --download-scalapack=1
>>>>> --with-blas-lapack-dir=/opt/intel11/mkl/lib/em64t --with-cc=gcc
>>>>> --with-cmake=/usr/local/bin/cmake --with-cxx=g++ --with-fc=ifort
>>>>> PETSC_ARCH=linux-debug
>>>>> >>>>> [0]PETSC ERROR:
>>>>> ------------------------------------------------------------------------
>>>>> >>>>> [0]PETSC ERROR: MatSetValues_MPIAIJ() line 506 in
>>>>> /home/jmousel/NumericalLibraries/petsc-hg/petsc-dev/src/mat/impls/aij/mpi/mpiaij.c
>>>>> >>>>> [0]PETSC ERROR: MatSetValues() line 1141 in
>>>>> /home/jmousel/NumericalLibraries/petsc-hg/petsc-dev/src/mat/interface/matrix.c
>>>>> >>>>> [0]PETSC ERROR: scaleFilterGraph() line 155 in
>>>>> /home/jmousel/NumericalLibraries/petsc-hg/petsc-dev/src/ksp/pc/impls/gamg/tools.c
>>>>> >>>>> [0]PETSC ERROR: PCGAMGgraph_AGG() line 865 in
>>>>> /home/jmousel/NumericalLibraries/petsc-hg/petsc-dev/src/ksp/pc/impls/gamg/agg.c
>>>>> >>>>> [0]PETSC ERROR: PCSetUp_GAMG() line 516 in
>>>>> /home/jmousel/NumericalLibraries/petsc-hg/petsc-dev/src/ksp/pc/impls/gamg/gamg.c
>>>>> >>>>> [0]PETSC ERROR: PCSetUp() line 832 in
>>>>> /home/jmousel/NumericalLibraries/petsc-hg/petsc-dev/src/ksp/pc/interface/precon.c
>>>>> >>>>> [0]PETSC ERROR: KSPSetUp() line 261 in
>>>>> /home/jmousel/NumericalLibraries/petsc-hg/petsc-dev/src/ksp/ksp/interface/itfunc.c
>>>>> >>>>> [0]PETSC ERROR: KSPSolve() line 385 in
>>>>> /home/jmousel/NumericalLibraries/petsc-hg/petsc-dev/src/ksp/ksp/interface/itfunc.c
>>>>> >>>>>
>>>>> >>>>>
>>>>> >>>>> John
>>>>> >>>>>
>>>>> >>>>>
>>>>> >>>>> On Wed, Mar 14, 2012 at 11:27 AM, Mark F. Adams <
>>>>> mark.adams at columbia.edu> wrote:
>>>>> >>>>>
>>>>> >>>>> On Mar 14, 2012, at 11:56 AM, John Mousel wrote:
>>>>> >>>>>
>>>>> >>>>>> Mark,
>>>>> >>>>>>
>>>>> >>>>>> The matrix is asymmetric. Does this require the setting of an
>>>>> option?
>>>>> >>>>>
>>>>> >>>>> Yes:  -pc_gamg_sym_graph
>>>>> >>>>>
>>>>> >>>>> Mark
>>>>> >>>>>
>>>>> >>>>>> I pulled petsc-dev this morning, so I should have (at least
>>>>> close to) the latest code.
>>>>> >>>>>>
>>>>> >>>>>> John
>>>>> >>>>>>
>>>>> >>>>>> On Wed, Mar 14, 2012 at 10:54 AM, Mark F. Adams <
>>>>> mark.adams at columbia.edu> wrote:
>>>>> >>>>>>
>>>>> >>>>>> On Mar 14, 2012, at 11:08 AM, John Mousel wrote:
>>>>> >>>>>>
>>>>> >>>>>>> I'm getting the following error when using GAMG.
>>>>> >>>>>>>
>>>>> >>>>>>> petsc-dev/src/ksp/pc/impls/gamg/agg.c:508: smoothAggs:
>>>>> Assertion `sgid==-1' failed.
>>>>> >>>>>>
>>>>> >>>>>> Is it possible that your matrix is structurally asymmetric?
>>>>> >>>>>>
>>>>> >>>>>> This code is evolving fast and so you will need to move to the
>>>>> dev version if you are not already using it. (I think I fixed a bug that
>>>>> hit this assert).
>>>>> >>>>>>
>>>>> >>>>>>>
>>>>> >>>>>>> When I try to alter the type of aggregation at the command
>>>>> line using -pc_gamg_type pa, I'm getting
>>>>> >>>>>>>
>>>>> >>>>>>> [0]PETSC ERROR: [1]PETSC ERROR: --------------------- Error
>>>>> Message ------------------------------------
>>>>> >>>>>>> [1]PETSC ERROR: Unknown type. Check for miss-spelling or
>>>>> missing external package needed for type:
>>>>> >>>>>>> see
>>>>> http://www.mcs.anl.gov/petsc/documentation/installation.html#external!
>>>>> >>>>>>> [1]PETSC ERROR: Unknown GAMG type pa given!
>>>>> >>>>>>>
>>>>> >>>>>>> Has there been a change in the aggregation options? I just
>>>>> pulled petsc-dev this morning.
>>>>> >>>>>>>
>>>>> >>>>>>
>>>>> >>>>>> Yes, this option is gone now.  You can use -pc_gamg_type agg
>>>>> for now.
>>>>> >>>>>>
>>>>> >>>>>> Mark
>>>>> >>>>>>
>>>>> >>>>>>> John
>>>>> >>>>>>
>>>>> >>>>>>
>>>>> >>>>>
>>>>> >>>>>
>>>>> >>>>
>>>>> >>>>
>>>>> >>>
>>>>> >>>
>>>>> >>
>>>>> >>
>>>>> >
>>>>> >
>>>>>
>>>>>
>>>>
>>>>
>>> <GAMG_kspview.txt><ML_kspview.txt><HYPRE_kspview.txt>
>>>
>>>
>>>
>> <GAMG_kspview.txt>
>>
>>
>>
>
>
-------------- next part --------------
An HTML attachment was scrubbed...
URL: <http://lists.mcs.anl.gov/pipermail/petsc-users/attachments/20120320/47ea59e9/attachment-0001.htm>
-------------- next part --------------
	[0]PCSetUp_GAMG level 0 N=46330, n data rows=1, n data cols=1, nnz/row (ave)=1, np=4
	[0]scaleFilterGraph 75.4421% nnz after filtering, with threshold 0.05, 6.96664 nnz ave.
	[0]maxIndSetAgg removed 0 of 10552 vertices.
		[0]PCGAMGprolongator_AGG New grid 5903 nodes
			PCGAMGoptprol_AGG smooth P0: max eigen=1.934105e+00 min=3.878260e-02 PC=jacobi
		[0]PCSetUp_GAMG 1) N=5903, n data cols=1, nnz/row (ave)=13, 4 active pes
	[0]scaleFilterGraph 50.3194% nnz after filtering, with threshold 0.05, 13.7456 nnz ave.
	[0]maxIndSetAgg removed 0 of 1321 vertices.
		[0]PCGAMGprolongator_AGG New grid 610 nodes
			PCGAMGoptprol_AGG smooth P0: max eigen=1.594176e+00 min=2.021619e-02 PC=jacobi
		[0]PCSetUp_GAMG 2) N=610, n data cols=1, nnz/row (ave)=21, 4 active pes
	[0]scaleFilterGraph 22.9069% nnz after filtering, with threshold 0.05, 21.3876 nnz ave.
	[0]maxIndSetAgg removed 0 of 129 vertices.
		[0]PCGAMGprolongator_AGG New grid 96 nodes
			PCGAMGoptprol_AGG smooth P0: max eigen=9.698899e+00 min=1.546704e-01 PC=jacobi
	[0]createLevel aggregate processors: npe: 4 --> 1, neq=96
		[0]PCSetUp_GAMG 3) N=96, n data cols=1, nnz/row (ave)=39, 1 active pes
	[0]scaleFilterGraph 10.4645% nnz after filtering, with threshold 0.05, 39.0208 nnz ave.
	[0]maxIndSetAgg removed 0 of 96 vertices.
		[0]PCGAMGprolongator_AGG New grid 19 nodes
			PCGAMGoptprol_AGG smooth P0: max eigen=2.744061e+00 min=3.561007e-02 PC=jacobi
		[0]PCSetUp_GAMG 4) N=19, n data cols=1, nnz/row (ave)=18, 1 active pes
	[0]scaleFilterGraph 9.45559% nnz after filtering, with threshold 0.05, 18.3684 nnz ave.
	[0]maxIndSetAgg removed 7 of 19 vertices.
		[0]PCGAMGprolongator_AGG New grid 5 nodes
			PCGAMGoptprol_AGG smooth P0: max eigen=2.463197e+00 min=1.316806e-01 PC=jacobi
		[0]PCSetUp_GAMG 5) N=5, n data cols=1, nnz/row (ave)=5, 1 active pes
	[0]PCSetUp_GAMG 6 levels, grid compexity = 1.34058
  Residual norms for pres_ solve.
  0 KSP preconditioned resid norm 3.612110338948e+05 true resid norm 1.310674055116e+03 ||r(i)||/||b|| 1.000000000000e+00
  2 KSP preconditioned resid norm 2.687590175950e+08 true resid norm 3.313319530843e+07 ||r(i)||/||b|| 2.527950803566e+04
  4 KSP preconditioned resid norm 1.718513684798e+05 true resid norm 2.068416025165e+04 ||r(i)||/||b|| 1.578131509578e+01
  6 KSP preconditioned resid norm 1.711727556016e+05 true resid norm 1.448181412902e+04 ||r(i)||/||b|| 1.104913465899e+01
  8 KSP preconditioned resid norm 7.680280259767e+04 true resid norm 3.841577666956e+03 ||r(i)||/||b|| 2.930993904977e+00
 10 KSP preconditioned resid norm 7.284099753086e+04 true resid norm 2.280215579888e+03 ||r(i)||/||b|| 1.739727410478e+00
 12 KSP preconditioned resid norm 7.802756964719e+04 true resid norm 3.407495334944e+03 ||r(i)||/||b|| 2.599803758718e+00
 14 KSP preconditioned resid norm 7.160374210384e+04 true resid norm 3.172235297295e+03 ||r(i)||/||b|| 2.420308302368e+00
 16 KSP preconditioned resid norm 8.637141413866e+04 true resid norm 3.670932784518e+03 ||r(i)||/||b|| 2.800797627900e+00
 18 KSP preconditioned resid norm 8.606984257347e+04 true resid norm 3.584264866912e+03 ||r(i)||/||b|| 2.734672936358e+00
 20 KSP preconditioned resid norm 9.533640175279e+04 true resid norm 6.402375095182e+03 ||r(i)||/||b|| 4.884795781371e+00
 22 KSP preconditioned resid norm 8.215290019906e+04 true resid norm 4.696169451039e+03 ||r(i)||/||b|| 3.583018548898e+00
 24 KSP preconditioned resid norm 8.043855900983e+04 true resid norm 4.084316108581e+03 ||r(i)||/||b|| 3.116195130772e+00
 26 KSP preconditioned resid norm 7.030803769831e+04 true resid norm 3.310652743124e+03 ||r(i)||/||b|| 2.525916134680e+00
 28 KSP preconditioned resid norm 4.112954031889e+04 true resid norm 3.170745816926e+03 ||r(i)||/||b|| 2.419171879194e+00
 30 KSP preconditioned resid norm 8.472322642800e+04 true resid norm 3.462065578656e+03 ||r(i)||/||b|| 2.641439010060e+00
 32 KSP preconditioned resid norm 7.166398327286e+04 true resid norm 4.853626644992e+03 ||r(i)||/||b|| 3.703153065438e+00
 34 KSP preconditioned resid norm 6.306754157168e+04 true resid norm 3.310461332692e+03 ||r(i)||/||b|| 2.525770094991e+00
 36 KSP preconditioned resid norm 6.309721154408e+04 true resid norm 3.325407554352e+03 ||r(i)||/||b|| 2.537173556898e+00
 38 KSP preconditioned resid norm 2.708710273084e+04 true resid norm 1.351570554381e+03 ||r(i)||/||b|| 1.031202646536e+00
 40 KSP preconditioned resid norm 1.556004637642e+04 true resid norm 1.027186285216e+03 ||r(i)||/||b|| 7.837084141603e-01
 42 KSP preconditioned resid norm 9.165999428820e+03 true resid norm 3.565338720300e+02 ||r(i)||/||b|| 2.720232926244e-01
 44 KSP preconditioned resid norm 4.960846975829e+03 true resid norm 2.748395120845e+02 ||r(i)||/||b|| 2.096932574592e-01
 46 KSP preconditioned resid norm 3.112191236107e+03 true resid norm 1.762355295070e+02 ||r(i)||/||b|| 1.344617518132e-01
 48 KSP preconditioned resid norm 2.543443891823e+03 true resid norm 1.070094485030e+02 ||r(i)||/||b|| 8.164459202145e-02
 50 KSP preconditioned resid norm 8.420615408330e+02 true resid norm 9.643382609945e+01 ||r(i)||/||b|| 7.357574960994e-02
 52 KSP preconditioned resid norm 5.236007088398e+02 true resid norm 3.159819451051e+01 ||r(i)||/||b|| 2.410835431370e-02
 54 KSP preconditioned resid norm 5.040203463563e+02 true resid norm 1.896920617172e+01 ||r(i)||/||b|| 1.447286310252e-02
 56 KSP preconditioned resid norm 2.633181310275e+02 true resid norm 1.011352036822e+01 ||r(i)||/||b|| 7.716274178731e-03
 58 KSP preconditioned resid norm 2.466280371039e+02 true resid norm 9.227453336468e+00 ||r(i)||/||b|| 7.040234984779e-03
 60 KSP preconditioned resid norm 2.312633390333e+02 true resid norm 1.197301878110e+01 ||r(i)||/||b|| 9.135008612070e-03
 62 KSP preconditioned resid norm 2.360698749045e+02 true resid norm 5.863557739326e+00 ||r(i)||/||b|| 4.473696352224e-03
 64 KSP preconditioned resid norm 2.228010266419e+02 true resid norm 5.855056953673e+00 ||r(i)||/||b|| 4.467210540119e-03
 66 KSP preconditioned resid norm 2.122377720607e+02 true resid norm 4.957796602145e+00 ||r(i)||/||b|| 3.782631221541e-03
 68 KSP preconditioned resid norm 2.045503230399e+02 true resid norm 4.887322884286e+00 ||r(i)||/||b|| 3.728862157002e-03
 70 KSP preconditioned resid norm 2.997956905450e+02 true resid norm 7.050792714872e+00 ||r(i)||/||b|| 5.379516507061e-03
 72 KSP preconditioned resid norm 2.111369460493e+01 true resid norm 9.129783421612e-01 ||r(i)||/||b|| 6.965716141230e-04
 74 KSP preconditioned resid norm 1.261967389115e+01 true resid norm 4.965472453812e-01 ||r(i)||/||b|| 3.788487636900e-04
 76 KSP preconditioned resid norm 1.289050806041e+01 true resid norm 6.218083277440e-01 ||r(i)||/||b|| 4.744187353957e-04
 78 KSP preconditioned resid norm 1.083352610697e+01 true resid norm 4.398776101309e-01 ||r(i)||/||b|| 3.356117475691e-04
 80 KSP preconditioned resid norm 2.274409904236e+01 true resid norm 1.215038053296e+00 ||r(i)||/||b|| 9.270329633470e-04
 82 KSP preconditioned resid norm 2.847352576438e+01 true resid norm 1.220115820373e+00 ||r(i)||/||b|| 9.309071279853e-04
 84 KSP preconditioned resid norm 7.250797645802e+00 true resid norm 3.906201125100e-01 ||r(i)||/||b|| 2.980299419107e-04
 86 KSP preconditioned resid norm 7.048473788478e+00 true resid norm 3.936854723961e-01 ||r(i)||/||b|| 3.003687078870e-04
 88 KSP preconditioned resid norm 1.098249410053e+01 true resid norm 6.062928999480e-01 ||r(i)||/||b|| 4.625809884475e-04
 90 KSP preconditioned resid norm 1.062480789565e+00 true resid norm 4.724208767154e-02 ||r(i)||/||b|| 3.604411599294e-05
 92 KSP preconditioned resid norm 9.552895552568e-01 true resid norm 4.451250942715e-02 ||r(i)||/||b|| 3.396154005903e-05
 94 KSP preconditioned resid norm 5.719134548913e-01 true resid norm 3.152141258463e-02 ||r(i)||/||b|| 2.404977229968e-05
 96 KSP preconditioned resid norm 9.675788485492e-01 true resid norm 5.651537251153e-02 ||r(i)||/||b|| 4.311931886570e-05
 98 KSP preconditioned resid norm 9.664671699486e-02 true resid norm 4.520511717286e-03 ||r(i)||/||b|| 3.448997635714e-06
100 KSP preconditioned resid norm 9.130467777174e-03 true resid norm 3.299763651766e-04 ||r(i)||/||b|| 2.517608126053e-07
102 KSP preconditioned resid norm 1.126791794400e-02 true resid norm 6.788892804581e-04 ||r(i)||/||b|| 5.179695728379e-07
104 KSP preconditioned resid norm 9.838420281303e-03 true resid norm 5.065570335783e-04 ||r(i)||/||b|| 3.864858937286e-07
106 KSP preconditioned resid norm 1.084444455419e-02 true resid norm 4.770227150710e-04 ||r(i)||/||b|| 3.639522070412e-07
108 KSP preconditioned resid norm 5.720579076324e-02 true resid norm 2.844060861586e-03 ||r(i)||/||b|| 2.169922301037e-06
110 KSP preconditioned resid norm 3.556058070390e-02 true resid norm 1.603587024377e-03 ||r(i)||/||b|| 1.223482694357e-06
112 KSP preconditioned resid norm 1.336438885062e-03 true resid norm 6.132214983120e-05 ||r(i)||/||b|| 4.678672747954e-08
114 KSP preconditioned resid norm 1.644242123526e-04 true resid norm 2.454816318596e-05 ||r(i)||/||b|| 1.872941872172e-08
116 KSP preconditioned resid norm 2.077302118590e-05 true resid norm 1.814016140734e-05 ||r(i)||/||b|| 1.384032997108e-08
118 KSP preconditioned resid norm 2.062148780542e-05 true resid norm 1.814203749554e-05 ||r(i)||/||b|| 1.384176136296e-08
120 KSP preconditioned resid norm 3.987467373484e-05 true resid norm 1.847262282651e-05 ||r(i)||/||b|| 1.409398679589e-08
122 KSP preconditioned resid norm 1.577748457132e-05 true resid norm 1.821983976764e-05 ||r(i)||/||b|| 1.390112186666e-08
124 KSP preconditioned resid norm 1.408767972144e-05 true resid norm 1.819870889010e-05 ||r(i)||/||b|| 1.388499972138e-08
126 KSP preconditioned resid norm 1.408271904199e-05 true resid norm 1.820121027523e-05 ||r(i)||/||b|| 1.388690819368e-08
128 KSP preconditioned resid norm 1.404851203992e-05 true resid norm 1.820287394307e-05 ||r(i)||/||b|| 1.388817751600e-08
130 KSP preconditioned resid norm 1.405039492404e-05 true resid norm 1.820273914085e-05 ||r(i)||/||b|| 1.388807466646e-08
132 KSP preconditioned resid norm 1.401867587595e-05 true resid norm 1.819712041489e-05 ||r(i)||/||b|| 1.388378776849e-08
134 KSP preconditioned resid norm 1.401302217409e-05 true resid norm 1.819932172647e-05 ||r(i)||/||b|| 1.388546729481e-08
136 KSP preconditioned resid norm 1.401277226860e-05 true resid norm 1.819913560733e-05 ||r(i)||/||b|| 1.388532529220e-08
138 KSP preconditioned resid norm 1.401269117590e-05 true resid norm 1.819912527486e-05 ||r(i)||/||b|| 1.388531740887e-08
140 KSP preconditioned resid norm 1.401269566176e-05 true resid norm 1.819927213240e-05 ||r(i)||/||b|| 1.388542945622e-08
142 KSP preconditioned resid norm 1.401278503672e-05 true resid norm 1.819939545249e-05 ||r(i)||/||b|| 1.388552354527e-08
144 KSP preconditioned resid norm 1.401278982467e-05 true resid norm 1.819941480329e-05 ||r(i)||/||b|| 1.388553830928e-08
146 KSP preconditioned resid norm 1.401293263197e-05 true resid norm 1.819944180498e-05 ||r(i)||/||b|| 1.388555891066e-08
148 KSP preconditioned resid norm 1.401282452159e-05 true resid norm 1.819933079847e-05 ||r(i)||/||b|| 1.388547421644e-08
150 KSP preconditioned resid norm 1.401257583064e-05 true resid norm 1.819907987066e-05 ||r(i)||/||b|| 1.388528276700e-08
152 KSP preconditioned resid norm 1.401260524504e-05 true resid norm 1.819908631586e-05 ||r(i)||/||b|| 1.388528768447e-08
154 KSP preconditioned resid norm 1.401507585649e-05 true resid norm 1.819925585968e-05 ||r(i)||/||b|| 1.388541704068e-08
156 KSP preconditioned resid norm 1.401252030737e-05 true resid norm 1.819910061311e-05 ||r(i)||/||b|| 1.388529859279e-08
158 KSP preconditioned resid norm 1.401252841472e-05 true resid norm 1.819914630889e-05 ||r(i)||/||b|| 1.388533345712e-08
160 KSP preconditioned resid norm 1.401235849762e-05 true resid norm 1.819914148389e-05 ||r(i)||/||b|| 1.388532977581e-08
162 KSP preconditioned resid norm 1.401233765711e-05 true resid norm 1.819915840374e-05 ||r(i)||/||b|| 1.388534268509e-08
164 KSP preconditioned resid norm 1.401234398567e-05 true resid norm 1.819916534902e-05 ||r(i)||/||b|| 1.388534798410e-08
166 KSP preconditioned resid norm 1.401231028718e-05 true resid norm 1.819913969356e-05 ||r(i)||/||b|| 1.388532840986e-08
168 KSP preconditioned resid norm 1.401234331067e-05 true resid norm 1.819916846357e-05 ||r(i)||/||b|| 1.388535036040e-08
170 KSP preconditioned resid norm 1.401235885972e-05 true resid norm 1.819917751038e-05 ||r(i)||/||b|| 1.388535726281e-08
172 KSP preconditioned resid norm 1.401233900388e-05 true resid norm 1.819923941500e-05 ||r(i)||/||b|| 1.388540449394e-08
174 KSP preconditioned resid norm 1.401225082189e-05 true resid norm 1.819918916295e-05 ||r(i)||/||b|| 1.388536615333e-08
176 KSP preconditioned resid norm 1.401226552751e-05 true resid norm 1.819915213085e-05 ||r(i)||/||b|| 1.388533789909e-08
178 KSP preconditioned resid norm 1.401219943890e-05 true resid norm 1.819913939571e-05 ||r(i)||/||b|| 1.388532818261e-08
180 KSP preconditioned resid norm 1.401199263035e-05 true resid norm 1.819910733407e-05 ||r(i)||/||b|| 1.388530372065e-08
182 KSP preconditioned resid norm 1.401287854824e-05 true resid norm 1.819930416585e-05 ||r(i)||/||b|| 1.388545389665e-08
184 KSP preconditioned resid norm 1.401167159645e-05 true resid norm 1.819872545239e-05 ||r(i)||/||b|| 1.388501235785e-08
186 KSP preconditioned resid norm 1.401103238265e-05 true resid norm 1.819860547689e-05 ||r(i)||/||b|| 1.388492082059e-08
188 KSP preconditioned resid norm 1.401323897340e-05 true resid norm 1.819922279518e-05 ||r(i)||/||b|| 1.388539181359e-08
190 KSP preconditioned resid norm 1.401226979551e-05 true resid norm 1.819904247531e-05 ||r(i)||/||b|| 1.388525423562e-08
192 KSP preconditioned resid norm 1.401256483397e-05 true resid norm 1.819910162959e-05 ||r(i)||/||b|| 1.388529936833e-08
194 KSP preconditioned resid norm 1.401189092748e-05 true resid norm 1.819899255266e-05 ||r(i)||/||b|| 1.388521614632e-08
196 KSP preconditioned resid norm 1.401269823835e-05 true resid norm 1.819928036837e-05 ||r(i)||/||b|| 1.388543573998e-08
198 KSP preconditioned resid norm 1.401223408377e-05 true resid norm 1.819904630195e-05 ||r(i)||/||b|| 1.388525715521e-08
200 KSP preconditioned resid norm 1.401252572765e-05 true resid norm 1.819908365033e-05 ||r(i)||/||b|| 1.388528565076e-08
202 KSP preconditioned resid norm 1.401235007102e-05 true resid norm 1.819914581432e-05 ||r(i)||/||b|| 1.388533307979e-08
204 KSP preconditioned resid norm 1.401348753852e-05 true resid norm 1.819829709741e-05 ||r(i)||/||b|| 1.388468553747e-08
206 KSP preconditioned resid norm 1.401258540428e-05 true resid norm 1.819916724139e-05 ||r(i)||/||b|| 1.388534942792e-08
208 KSP preconditioned resid norm 1.401263706129e-05 true resid norm 1.819919858881e-05 ||r(i)||/||b|| 1.388537334494e-08
210 KSP preconditioned resid norm 1.401238565223e-05 true resid norm 1.819905505425e-05 ||r(i)||/||b|| 1.388526383292e-08
212 KSP preconditioned resid norm 1.401208932589e-05 true resid norm 1.819902354098e-05 ||r(i)||/||b|| 1.388523978936e-08
214 KSP preconditioned resid norm 1.538450958191e-05 true resid norm 1.819523499266e-05 ||r(i)||/||b|| 1.388234925506e-08
216 KSP preconditioned resid norm 1.401335550976e-05 true resid norm 1.819931191443e-05 ||r(i)||/||b|| 1.388545980855e-08
218 KSP preconditioned resid norm 1.401199672215e-05 true resid norm 1.819921984869e-05 ||r(i)||/||b|| 1.388538956551e-08
220 KSP preconditioned resid norm 1.401176169548e-05 true resid norm 1.819913798571e-05 ||r(i)||/||b|| 1.388532710682e-08
222 KSP preconditioned resid norm 1.401290941148e-05 true resid norm 1.819933634161e-05 ||r(i)||/||b|| 1.388547844567e-08
224 KSP preconditioned resid norm 1.401220439981e-05 true resid norm 1.81990505
-------------- next part --------------
	[0]PCSetUp_GAMG level 0 N=46330, n data rows=1, n data cols=1, nnz/row (ave)=1, np=4
	[0]scaleFilterGraph 75.4421% nnz after filtering, with threshold 0.05, 6.96664 nnz ave.
	[0]maxIndSetAgg removed 0 of 10552 vertices.
		[0]PCGAMGprolongator_AGG New grid 5903 nodes
		[0]PCSetUp_GAMG 1) N=5903, n data cols=1, nnz/row (ave)=6, 4 active pes
	[0]scaleFilterGraph 91.3687% nnz after filtering, with threshold 0.05, 6.49886 nnz ave.
	[0]maxIndSetAgg removed 0 of 1321 vertices.
		[0]PCGAMGprolongator_AGG New grid 718 nodes
		[0]PCSetUp_GAMG 2) N=718, n data cols=1, nnz/row (ave)=5, 4 active pes
	[0]scaleFilterGraph 90.3509% nnz after filtering, with threshold 0.05, 5.11538 nnz ave.
	[0]maxIndSetAgg removed 0 of 156 vertices.
		[0]PCGAMGprolongator_AGG New grid 127 nodes
	[0]createLevel aggregate processors: npe: 4 --> 1, neq=127
		[0]PCSetUp_GAMG 3) N=127, n data cols=1, nnz/row (ave)=4, 1 active pes
	[0]scaleFilterGraph 86.4013% nnz after filtering, with threshold 0.05, 4.74803 nnz ave.
	[0]maxIndSetAgg removed 0 of 127 vertices.
		[0]PCGAMGprolongator_AGG New grid 25 nodes
		[0]PCSetUp_GAMG 4) N=25, n data cols=1, nnz/row (ave)=4, 1 active pes
	[0]scaleFilterGraph 98.0583% nnz after filtering, with threshold 0.05, 4.12 nnz ave.
	[0]maxIndSetAgg removed 0 of 25 vertices.
		[0]PCGAMGprolongator_AGG New grid 5 nodes
		[0]PCSetUp_GAMG 5) N=5, n data cols=1, nnz/row (ave)=2, 1 active pes
	[0]PCSetUp_GAMG 6 levels, grid compexity = 1.13742
			PCSetUp_GAMG PC setup max eigen=1.693353e+00 min=1.205252e-01
			PCSetUp_GAMG PC setup max eigen=1.999649e+00 min=5.459423e-02
			PCSetUp_GAMG PC setup max eigen=1.844191e+00 min=3.600443e-02
			PCSetUp_GAMG PC setup max eigen=1.768003e+00 min=2.083195e-02
			PCSetUp_GAMG PC setup max eigen=1.934105e+00 min=3.878260e-02
  Residual norms for pres_ solve.
  0 KSP preconditioned resid norm 1.663347231219e+05 true resid norm 1.310674055116e+03 ||r(i)||/||b|| 1.000000000000e+00
  2 KSP preconditioned resid norm 6.567796713567e+04 true resid norm 2.752296371149e+04 ||r(i)||/||b|| 2.099909096702e+01
  4 KSP preconditioned resid norm 5.466106023057e+05 true resid norm 1.980240237000e+05 ||r(i)||/||b|| 1.510856363770e+02
  6 KSP preconditioned resid norm 3.269775589446e+05 true resid norm 1.589713021070e+05 ||r(i)||/||b|| 1.212897298810e+02
  8 KSP preconditioned resid norm 3.203649214780e+04 true resid norm 1.156144810931e+04 ||r(i)||/||b|| 8.820994101611e+00
 10 KSP preconditioned resid norm 8.667598714391e+04 true resid norm 2.478167249197e+04 ||r(i)||/||b|| 1.890757842901e+01
 12 KSP preconditioned resid norm 1.769725563561e+04 true resid norm 4.147840907249e+03 ||r(i)||/||b|| 3.164662404859e+00
 14 KSP preconditioned resid norm 1.312323526170e+04 true resid norm 1.948461028455e+03 ||r(i)||/||b|| 1.486609901867e+00
 16 KSP preconditioned resid norm 1.156457361259e+04 true resid norm 1.266774145072e+03 ||r(i)||/||b|| 9.665058525630e-01
 18 KSP preconditioned resid norm 1.027678853385e+04 true resid norm 1.488971189709e+03 ||r(i)||/||b|| 1.136034686807e+00
 20 KSP preconditioned resid norm 1.039522693159e+04 true resid norm 1.455905421918e+03 ||r(i)||/||b|| 1.110806623687e+00
 22 KSP preconditioned resid norm 9.852763686063e+03 true resid norm 1.429220248656e+03 ||r(i)||/||b|| 1.090446738514e+00
 24 KSP preconditioned resid norm 8.767670423772e+03 true resid norm 1.274497701051e+03 ||r(i)||/||b|| 9.723986646997e-01
 26 KSP preconditioned resid norm 8.328695373033e+03 true resid norm 8.258935539966e+02 ||r(i)||/||b|| 6.301288644366e-01
 28 KSP preconditioned resid norm 8.016139977502e+03 true resid norm 1.227648373812e+03 ||r(i)||/||b|| 9.366542116403e-01
 30 KSP preconditioned resid norm 7.918495667087e+03 true resid norm 8.305221324851e+02 ||r(i)||/||b|| 6.336603133658e-01
 32 KSP preconditioned resid norm 7.990512819579e+03 true resid norm 7.548039142022e+02 ||r(i)||/||b|| 5.758898722807e-01
 34 KSP preconditioned resid norm 7.999257819915e+03 true resid norm 1.004252641256e+03 ||r(i)||/||b|| 7.662108190335e-01
 36 KSP preconditioned resid norm 7.835545253091e+03 true resid norm 1.444231992624e+03 ||r(i)||/||b|| 1.101900191727e+00
 38 KSP preconditioned resid norm 7.670995008661e+03 true resid norm 8.083283362773e+02 ||r(i)||/||b|| 6.167271970649e-01
 40 KSP preconditioned resid norm 7.577687720138e+03 true resid norm 1.016051521051e+03 ||r(i)||/||b|| 7.752129654855e-01
 42 KSP preconditioned resid norm 7.909824866411e+03 true resid norm 1.358212988013e+03 ||r(i)||/||b|| 1.036270598866e+00
 44 KSP preconditioned resid norm 8.773425010803e+03 true resid norm 1.002009994050e+03 ||r(i)||/||b|| 7.644997550220e-01
 46 KSP preconditioned resid norm 7.954187546293e+03 true resid norm 2.698635503179e+03 ||r(i)||/||b|| 2.058967668312e+00
 48 KSP preconditioned resid norm 7.643168470330e+03 true resid norm 1.607019669270e+03 ||r(i)||/||b|| 1.226101686378e+00
 50 KSP preconditioned resid norm 7.467053286167e+03 true resid norm 1.238908135793e+03 ||r(i)||/||b|| 9.452450294239e-01
 52 KSP preconditioned resid norm 7.504066288874e+03 true resid norm 1.065449375972e+03 ||r(i)||/||b|| 8.129018590196e-01
 54 KSP preconditioned resid norm 7.961829184352e+03 true resid norm 1.705190760618e+03 ||r(i)||/||b|| 1.301002910649e+00
 56 KSP preconditioned resid norm 5.280109275365e+03 true resid norm 1.230007549400e+03 ||r(i)||/||b|| 9.384541828682e-01
 58 KSP preconditioned resid norm 7.285589173580e+03 true resid norm 1.248789115263e+03 ||r(i)||/||b|| 9.527838827573e-01
 60 KSP preconditioned resid norm 5.372930205337e+03 true resid norm 2.055209806116e+03 ||r(i)||/||b|| 1.568055610847e+00
 62 KSP preconditioned resid norm 5.317455508650e+03 true resid norm 1.569883420506e+03 ||r(i)||/||b|| 1.197767983869e+00
 64 KSP preconditioned resid norm 4.651478346787e+03 true resid norm 1.125464473759e+03 ||r(i)||/||b|| 8.586913499711e-01
 66 KSP preconditioned resid norm 5.029458030703e+03 true resid norm 1.283911390936e+03 ||r(i)||/||b|| 9.795809918756e-01
 68 KSP preconditioned resid norm 3.359247179976e+03 true resid norm 7.487032294139e+02 ||r(i)||/||b|| 5.712352560055e-01
 70 KSP preconditioned resid norm 2.298226566553e+03 true resid norm 4.810633996817e+02 ||r(i)||/||b|| 3.670351128139e-01
 72 KSP preconditioned resid norm 2.437279220201e+03 true resid norm 3.451338187828e+02 ||r(i)||/||b|| 2.633254373470e-01
 74 KSP preconditioned resid norm 1.121862058899e+03 true resid norm 3.739958480903e+02 ||r(i)||/||b|| 2.853461901001e-01
 76 KSP preconditioned resid norm 5.764976452342e+02 true resid norm 1.296514348922e+02 ||r(i)||/||b|| 9.891966228073e-02
 78 KSP preconditioned resid norm 2.959527805479e+02 true resid norm 3.850107180615e+01 ||r(i)||/||b|| 2.937501635580e-02
 80 KSP preconditioned resid norm 2.767666324669e+02 true resid norm 3.598111843300e+01 ||r(i)||/||b|| 2.745237711280e-02
 82 KSP preconditioned resid norm 2.017812198522e+02 true resid norm 2.553182349442e+01 ||r(i)||/||b|| 1.947991828690e-02
 84 KSP preconditioned resid norm 1.420504762647e+02 true resid norm 2.316682808482e+01 ||r(i)||/||b|| 1.767550673212e-02
 86 KSP preconditioned resid norm 2.161763577525e+02 true resid norm 3.055059796487e+01 ||r(i)||/||b|| 2.330907356075e-02
 88 KSP preconditioned resid norm 8.797736673019e+01 true resid norm 1.775948996075e+01 ||r(i)||/||b|| 1.354989052498e-02
 90 KSP preconditioned resid norm 5.212224911849e+01 true resid norm 9.037670663578e+00 ||r(i)||/||b|| 6.895437220491e-03
 92 KSP preconditioned resid norm 2.582485513792e+01 true resid norm 3.695016858770e+00 ||r(i)||/||b|| 2.819172962452e-03
 94 KSP preconditioned resid norm 2.511753395563e+01 true resid norm 4.331444191820e+00 ||r(i)||/||b|| 3.304745504737e-03
 96 KSP preconditioned resid norm 1.340286627338e+01 true resid norm 2.043360937970e+00 ||r(i)||/||b|| 1.559015324973e-03
 98 KSP preconditioned resid norm 7.788283769267e+00 true resid norm 1.365025541649e+00 ||r(i)||/||b|| 1.041468347009e-03
100 KSP preconditioned resid norm 2.330399915648e+00 true resid norm 5.473386771246e-01 ||r(i)||/||b|| 4.176009092331e-04
102 KSP preconditioned resid norm 1.841162449845e+00 true resid norm 5.640944100940e-01 ||r(i)||/||b|| 4.303849671031e-04
104 KSP preconditioned resid norm 9.849647493643e-01 true resid norm 2.556801524986e-01 ||r(i)||/||b|| 1.950753137293e-04
106 KSP preconditioned resid norm 8.669422296393e-01 true resid norm 1.344088995700e-01 ||r(i)||/||b|| 1.025494470157e-04
108 KSP preconditioned resid norm 8.980014218288e-01 true resid norm 1.374441239490e-01 ||r(i)||/||b|| 1.048652206187e-04
110 KSP preconditioned resid norm 2.748683080221e-01 true resid norm 4.397420547304e-02 ||r(i)||/||b|| 3.355083233806e-05
112 KSP preconditioned resid norm 1.605746404788e-01 true resid norm 1.718733424203e-02 ||r(i)||/||b|| 1.311335505189e-05
114 KSP preconditioned resid norm 1.065880847345e-01 true resid norm 1.394296024957e-02 ||r(i)||/||b|| 1.063800736358e-05
116 KSP preconditioned resid norm 5.089068176336e-02 true resid norm 1.010497577591e-02 ||r(i)||/||b|| 7.709754943628e-06
118 KSP preconditioned resid norm 3.131857220882e-02 true resid norm 3.323217069673e-03 ||r(i)||/||b|| 2.535502291132e-06
120 KSP preconditioned resid norm 2.965821428510e-02 true resid norm 3.276233382478e-03 ||r(i)||/||b|| 2.499655325968e-06
122 KSP preconditioned resid norm 1.597891045514e-02 true resid norm 4.759139650005e-03 ||r(i)||/||b|| 3.631062682159e-06
124 KSP preconditioned resid norm 9.680012737053e-03 true resid norm 1.054103556414e-03 ||r(i)||/||b|| 8.042453822137e-07
126 KSP preconditioned resid norm 6.153122965798e-03 true resid norm 1.604398742466e-03 ||r(i)||/||b|| 1.224102007821e-06
128 KSP preconditioned resid norm 3.954214764783e-03 true resid norm 4.156609639169e-04 ||r(i)||/||b|| 3.171352650909e-07
130 KSP preconditioned resid norm 2.562330445863e-03 true resid norm 4.095016203896e-04 ||r(i)||/||b|| 3.124358941807e-07
132 KSP preconditioned resid norm 2.112111566426e-03 true resid norm 2.387672371692e-04 ||r(i)||/||b|| 1.821713310317e-07
134 KSP preconditioned resid norm 1.080595713577e-03 true resid norm 9.445872749660e-05 ||r(i)||/||b|| 7.206881613923e-08
136 KSP preconditioned resid norm 9.019488537597e-04 true resid norm 2.261853037116e-04 ||r(i)||/||b|| 1.725717411043e-07
138 KSP preconditioned resid norm 1.655643753743e-03 true resid norm 6.326769898827e-04 ||r(i)||/||b|| 4.827111572196e-07
140 KSP preconditioned resid norm 3.354786964176e-04 true resid norm 4.665899166324e-05 ||r(i)||/||b|| 3.559923344872e-08
142 KSP preconditioned resid norm 1.955417849395e-03 true resid norm 4.173899603468e-04 ||r(i)||/||b|| 3.184544309225e-07
144 KSP preconditioned resid norm 2.157529609788e-04 true resid norm 2.953353419131e-05 ||r(i)||/||b|| 2.253308828082e-08
146 KSP preconditioned resid norm 1.486973480783e-04 true resid norm 1.855777018380e-05 ||r(i)||/||b|| 1.415895135130e-08
148 KSP preconditioned resid norm 1.055226071274e-04 true resid norm 2.066226516026e-05 ||r(i)||/||b|| 1.576460988116e-08
150 KSP preconditioned resid norm 8.947908647545e-05 true resid norm 9.528537251226e-06 ||r(i)||/||b|| 7.269951834351e-09
152 KSP preconditioned resid norm 4.953708167034e-05 true resid norm 8.318389913741e-06 ||r(i)||/||b|| 6.346650321850e-09
154 KSP preconditioned resid norm 2.410529397250e-05 true resid norm 2.433007111899e-06 ||r(i)||/||b|| 1.856302184668e-09
156 KSP preconditioned resid norm 1.431008972002e-05 true resid norm 3.007953192313e-06 ||r(i)||/||b|| 2.294966609412e-09
158 KSP preconditioned resid norm 8.344138040342e-06 true resid norm 8.950909955055e-07 ||r(i)||/||b|| 6.829241732617e-10
160 KSP preconditioned resid norm 5.305429174321e-06 true resid norm 8.751180974573e-07 ||r(i)||/||b|| 6.676855271847e-10
162 KSP preconditioned resid norm 3.407936113633e-06 true resid norm 5.080913148796e-07 ||r(i)||/||b|| 3.876564984989e-10
164 KSP preconditioned resid norm 3.307812191488e-06 true resid norm 5.928124531795e-07 ||r(i)||/||b|| 4.522958632359e-10
166 KSP preconditioned resid norm 1.279802768847e-06 true resid norm 5.915416474155e-07 ||r(i)||/||b|| 4.513262813943e-10
168 KSP preconditioned resid norm 5.578434397034e-07 true resid norm 4.219723792327e-07 ||r(i)||/||b|| 3.219506616353e-10
170 KSP preconditioned resid norm 4.050142686203e-07 true resid norm 4.209005270951e-07 ||r(i)||/||b|| 3.211328746856e-10
172 KSP preconditioned resid norm 1.279720451106e-07 true resid norm 4.065801879654e-07 ||r(i)||/||b|| 3.102069399928e-10
KSP Object:(pres_) 4 MPI processes
  type: bcgsl
    BCGSL: Ell = 2
    BCGSL: Delta = 0
  maximum iterations=5000
  tolerances:  relative=1e-12, absolute=1e-50, divergence=10000
  left preconditioning
  diagonally scaled system
  has attached null space
  using nonzero initial guess
  using PRECONDITIONED norm type for convergence test
PC Object:(pres_) 4 MPI processes
  type: gamg
    MG: type is MULTIPLICATIVE, levels=6 cycles=v
      Cycles per PCApply=1
      Using Galerkin computed coarse grid matrices
  Coarse grid solver -- level -------------------------------
    KSP Object:    (pres_mg_coarse_)     4 MPI processes
      type: preonly
      maximum iterations=1, initial guess is zero
      tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
      left preconditioning
      using NONE norm type for convergence test
    PC Object:    (pres_mg_coarse_)     4 MPI processes
      type: sor
        SOR: type = local_symmetric, iterations = 8, local iterations = 1, omega = 1
      linear system matrix = precond matrix:
      Matrix Object:       4 MPI processes
        type: mpiaij
        rows=5, cols=5
        total: nonzeros=13, allocated nonzeros=13
        total number of mallocs used during MatSetValues calls =0
          not using I-node (on process 0) routines
  Down solver (pre-smoother) on level 1 -------------------------------
    KSP Object:    (pres_mg_levels_1_)     4 MPI processes
      type: chebychev
        Chebychev: eigenvalue estimates:  min = 0.338671, max = 1.77802
      maximum iterations=1
      tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
      left preconditioning
      using nonzero initial guess
      using NONE norm type for convergence test
    PC Object:    (pres_mg_levels_1_)     4 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       4 MPI processes
        type: mpiaij
        rows=25, cols=25
        total: nonzeros=103, allocated nonzeros=103
        total number of mallocs used during MatSetValues calls =0
          not using I-node (on process 0) routines
  Up solver (post-smoother) same as down solver (pre-smoother)
  Down solver (pre-smoother) on level 2 -------------------------------
    KSP Object:    (pres_mg_levels_2_)     4 MPI processes
      type: chebychev
        Chebychev: eigenvalue estimates:  min = 0.393632, max = 2.09963
      maximum iterations=1
      tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
      left preconditioning
      using nonzero initial guess
      using NONE norm type for convergence test
    PC Object:    (pres_mg_levels_2_)     4 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       4 MPI processes
        type: mpiaij
        rows=127, cols=127
        total: nonzeros=603, allocated nonzeros=603
        total number of mallocs used during MatSetValues calls =0
          not using I-node (on process 0) routines
  Up solver (post-smoother) same as down solver (pre-smoother)
  Down solver (pre-smoother) on level 3 -------------------------------
    KSP Object:    (pres_mg_levels_3_)     4 MPI processes
      type: chebychev
        Chebychev: eigenvalue estimates:  min = 0.326201, max = 1.9364
      maximum iterations=1
      tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
      left preconditioning
      using nonzero initial guess
      using NONE norm type for convergence test
    PC Object:    (pres_mg_levels_3_)     4 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       4 MPI processes
        type: mpiaij
        rows=718, cols=718
        total: nonzeros=3765, allocated nonzeros=3765
        total number of mallocs used during MatSetValues calls =0
          not using I-node (on process 0) routines
  Up solver (post-smoother) same as down solver (pre-smoother)
  Down solver (pre-smoother) on level 4 -------------------------------
    KSP Object:    (pres_mg_levels_4_)     4 MPI processes
      type: chebychev
        Chebychev: eigenvalue estimates:  min = 0.215048, max = 1.8564
      maximum iterations=1
      tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
      left preconditioning
      using nonzero initial guess
      using NONE norm type for convergence test
    PC Object:    (pres_mg_levels_4_)     4 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       4 MPI processes
        type: mpiaij
        rows=5903, cols=5903
        total: nonzeros=38087, allocated nonzeros=38087
        total number of mallocs used during MatSetValues calls =0
          not using I-node (on process 0) routines
  Up solver (post-smoother) same as down solver (pre-smoother)
  Down solver (pre-smoother) on level 5 -------------------------------
    KSP Object:    (pres_mg_levels_5_)     4 MPI processes
      type: chebychev
        Chebychev: eigenvalue estimates:  min = 0.246428, max = 2.03081
      maximum iterations=1
      tolerances:  relative=1e-05, absolute=1e-50, divergence=10000
      left preconditioning
      has attached null space
      using nonzero initial guess
      using NONE norm type for convergence test
    PC Object:    (pres_mg_levels_5_)     4 MPI processes
      type: jacobi
      linear system matrix = precond matrix:
      Matrix Object:       4 MPI processes
        type: mpiaij
        rows=46330, cols=46330
        total: nonzeros=322437, allocated nonzeros=615417
        total number of mallocs used during MatSetValues calls =0
          not using I-node (on process 0) routines
  Up solver (post-smoother) same as down solver (pre-smoother)
  linear system matrix = precond matrix:
  Matrix Object:   4 MPI processes
    type: mpiaij
    rows=46330, cols=46330
    total: nonzeros=322437, allocated nonzeros=615417
    total number of mallocs used during MatSetValues calls =0
      not using I-node (on process 0) routines


More information about the petsc-users mailing list