[petsc-users] Various Questions Regarding PETSC

Mohammed Mostafa mo7ammedmostafa at gmail.com
Sat Jul 13 09:55:59 CDT 2019


Hello Matt,

I revised my code and changed the way I create the rhs vector,
previosly I was using vecCreateGhost just in case I need the ghost values,
but for now I changed that to
vecCreateMPI(.......)
So maybe that was the cause of the scatter
I am attaching with this email a new log output
Also regarding how I fill my petsc matrix,
In my code I fill a temp CSR format matrix becasue otherwise I would need
"MatSetValue" to fill the petsc mat element by element
which is not recommmeded in the petsc manual and probably very expensive
due to function call overhead
*So after I create my matrix in CSR format, I fill the PETSC mat A as
follows*

> for (i = 0; i < nMatRows; i++) {
>  cffset = CSR_iptr[i];
> row_index = row_gIndex[i];
> nj = Eqn_nj[i];
> MatSetValues(PhiEqnSolver.A, 1, &row_index, nj, CSR_jptr + offset,
> CSR_vptr +  offset, INSERT_VALUES);
> }
>
*After That*

> VecAssemblyBegin(RHS);
> VecAssemblyEnd(RHS);
>
> MatAssemblyBegin(A, MAT_FINAL_ASSEMBLY);
> MatAssemblyEnd(A, MAT_FINAL_ASSEMBLY);
>

*I don't believe , I am doing anything special, if possible I would like to
set the whole csr matrix at once in one command.*
*I took a look at the code for MatSetValues, if I am understanding it
correctly(hopefully) I think I could do it, maybe modify it or create a new
routine entirely for this pupose.*

*i.e. MatSetValuesFromCSR(.....)*
*Or is there a particular reason why it has to be this way*

I also tried ksp ex3 but I slightly tweaked it to add a logging stage
around the assembly and MatSetValues and I am attaching the modified
example here as well.
Although in this example the matrix stash is not empty ( means
off-processor values are being set ) but the timing values for roughly the
same matrix size , the command I used is
mpirun -np 6 ./mod_ksp_ex3 -m 1000 -log_view -info


Regards,
Kamra

On Sat, Jul 13, 2019 at 1:43 PM Matthew Knepley <knepley at gmail.com> wrote:

> On Fri, Jul 12, 2019 at 10:51 PM Mohammed Mostafa <
> mo7ammedmostafa at gmail.com> wrote:
>
>> Hello Matt,
>> Attached is the dumped entire log output using -log_view and -info.
>>
>
> In matrix construction, it looks like you have a mixture of load imbalance
> (see the imbalance in the Begin events)
> and lots of Scatter messages in your assembly. We turn off MatSetValues()
> logging by default since it is usually
> called many times, but you can explicitly turn it back on if you want. I
> don't think that is the problem here. Its easy
> to see from examples (say SNES ex5) that it is not the major time sink.
> What is the Scatter doing?
>
>   Thanks,
>
>      Matt
>
>
>> Thanks,
>> Kamra
>>
>> On Fri, Jul 12, 2019 at 9:23 PM Matthew Knepley <knepley at gmail.com>
>> wrote:
>>
>>> On Fri, Jul 12, 2019 at 5:19 AM Mohammed Mostafa via petsc-users <
>>> petsc-users at mcs.anl.gov> wrote:
>>>
>>>> Hello all,
>>>> I have a few question regarding Petsc,
>>>>
>>>
>>> Please send the entire output of a run with all the logging turned on,
>>> using -log_view and -info.
>>>
>>>   Thanks,
>>>
>>>     Matt
>>>
>>>
>>>> Question 1:
>>>> For the profiling , is it possible to only show the user defined log
>>>> events in the breakdown of each stage in Log-view.
>>>> I tried deactivating all ClassIDs, MAT,VEC, PC, KSP,PC,
>>>>  PetscLogEventExcludeClass(MAT_CLASSID);
>>>> PetscLogEventExcludeClass(VEC_CLASSID);
>>>> PetscLogEventExcludeClass(KSP_CLASSID);
>>>> PetscLogEventExcludeClass(PC_CLASSID);
>>>> which should "Deactivates event logging for a PETSc object class in
>>>> every stage" according to the manual.
>>>> however I still see them in the stage breakdown
>>>> --- Event Stage 1: Matrix Construction
>>>>
>>>> BuildTwoSidedF         4 1.0 2.7364e-02 2.4 0.00e+00 0.0 0.0e+00
>>>> 0.0e+00 0.0e+00  0  0  0  0  0  18  0  0  0  0     0
>>>> VecSet                 1 1.0 4.5300e-06 2.4 0.00e+00 0.0 0.0e+00
>>>> 0.0e+00 0.0e+00  0  0  0  0  0   0  0  0  0  0     0
>>>> VecAssemblyBegin       2 1.0 2.7344e-02 2.4 0.00e+00 0.0 0.0e+00
>>>> 0.0e+00 0.0e+00  0  0  0  0  0  18  0  0  0  0     0
>>>> VecAssemblyEnd         2 1.0 8.3447e-06 1.5 0.00e+00 0.0 0.0e+00
>>>> 0.0e+00 0.0e+00  0  0  0  0  0   0  0  0  0  0     0
>>>> VecScatterBegin        2 1.0 7.5102e-05 1.7 0.00e+00 0.0 3.6e+01
>>>> 2.1e+03 0.0e+00  0  0  3  0  0   0  0 50 80  0     0
>>>> VecScatterEnd          2 1.0 3.5286e-05 2.2 0.00e+00 0.0 0.0e+00
>>>> 0.0e+00 0.0e+00  0  0  0  0  0   0  0  0  0  0     0
>>>> MatAssemblyBegin       2 1.0 8.8930e-05 1.9 0.00e+00 0.0 0.0e+00
>>>> 0.0e+00 0.0e+00  0  0  0  0  0   0  0  0  0  0     0
>>>> MatAssemblyEnd         2 1.0 1.3566e-02 1.1 0.00e+00 0.0 3.6e+01
>>>> 5.3e+02 8.0e+00  0  0  3  0  6  10  0 50 20100     0
>>>> AssembleMats           2 1.0 3.9774e-02 1.7 0.00e+00 0.0 7.2e+01
>>>> 1.3e+03 8.0e+00  0  0  7  0  6  28  0100100100     0  # USER EVENT
>>>> myMatSetValues         2 1.0 2.6931e-02 1.2 0.00e+00 0.0 0.0e+00
>>>> 0.0e+00 0.0e+00  0  0  0  0  0  19  0  0  0  0     0   # USER EVENT
>>>> setNativeMat           1 1.0 3.5613e-02 1.3 0.00e+00 0.0 0.0e+00
>>>> 0.0e+00 0.0e+00  0  0  0  0  0  24  0  0  0  0     0   # USER EVENT
>>>> setNativeMatII         1 1.0 4.7023e-02 1.5 0.00e+00 0.0 0.0e+00
>>>> 0.0e+00 0.0e+00  0  0  0  0  0  28  0  0  0  0     0   # USER EVENT
>>>> callScheme             1 1.0 2.2333e-03 1.2 0.00e+00 0.0 0.0e+00
>>>> 0.0e+00 0.0e+00  0  0  0  0  0   2  0  0  0  0     0   # USER EVENT
>>>>
>>>> Also is possible to clear the logs so that I can write a  separate
>>>> profiling output file for each timestep ( since I am solving a transient
>>>> problem and I want to know the change in performance as time goes by )
>>>>
>>>> ----------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------
>>>> Question 2:
>>>> Regarding MatSetValues
>>>> Right now, I writing a finite volume code, due to algorithm requirement
>>>> I have to write the matrix into local native format ( array of arrays) and
>>>> then loop through rows and use MatSetValues to set the elements in "Mat A"
>>>> MatSetValues(A, 1, &row, nj, j_index, coefvalues, INSERT_VALUES);
>>>> but it is very slow and it is killing my performance
>>>> although the matrix was properly set using
>>>> MatCreateAIJ(PETSC_COMM_WORLD, this->local_size, this->local_size,
>>>> PETSC_DETERMINE,
>>>> PETSC_DETERMINE, -1, d_nnz, -1, o_nnz, &A);
>>>> with d_nnz,and  o_nnz properly assigned so no mallocs occur during
>>>> matsetvalues and all inserted values are local so no off-processor values
>>>> So my question is it possible to set multiple rows at once hopefully
>>>> all, I checked the manual and MatSetValues can only set dense matrix block
>>>> because it seems that row by row is expensive
>>>> Or perhaps is it possible to copy all rows to the underlying matrix
>>>> data, as I mentioned all values are local and no off-processor values (
>>>> stash is 0 )
>>>> [0] VecAssemblyBegin_MPI_BTS(): Stash has 0 entries, uses 0 mallocs.
>>>> [0] VecAssemblyBegin_MPI_BTS(): Block-Stash has 0 entries, uses 0
>>>> mallocs.
>>>> [0] MatAssemblyBegin_MPIAIJ(): Stash has 0 entries, uses 0 mallocs.
>>>> [1] MatAssemblyBegin_MPIAIJ(): Stash has 0 entries, uses 0 mallocs.
>>>> [2] MatAssemblyBegin_MPIAIJ(): Stash has 0 entries, uses 0 mallocs.
>>>> [3] MatAssemblyBegin_MPIAIJ(): Stash has 0 entries, uses 0 mallocs.
>>>> [4] MatAssemblyBegin_MPIAIJ(): Stash has 0 entries, uses 0 mallocs.
>>>> [5] MatAssemblyBegin_MPIAIJ(): Stash has 0 entries, uses 0 mallocs.
>>>> [2] MatAssemblyEnd_SeqAIJ(): Matrix size: 186064 X 186064; storage
>>>> space: 0 unneeded,743028 used
>>>> [1] MatAssemblyEnd_SeqAIJ(): Matrix size: 186062 X 186062; storage
>>>> space: 0 unneeded,742972 used
>>>> [1] MatAssemblyEnd_SeqAIJ(): Number of mallocs during MatSetValues() is
>>>> 0
>>>> [1] MatAssemblyEnd_SeqAIJ(): Maximum nonzeros in any row is 4
>>>> [1] MatCheckCompressedRow(): Found the ratio (num_zerorows
>>>> 0)/(num_localrows 186062) < 0.6. Do not use CompressedRow routines.
>>>> [2] MatAssemblyEnd_SeqAIJ(): Number of mallocs during MatSetValues() is
>>>> 0
>>>> [2] MatAssemblyEnd_SeqAIJ(): Maximum nonzeros in any row is 4
>>>> [2] MatCheckCompressedRow(): Found the ratio (num_zerorows
>>>> 0)/(num_localrows 186064) < 0.6. Do not use CompressedRow routines.
>>>> [4] MatAssemblyEnd_SeqAIJ(): Matrix size: 186063 X 186063; storage
>>>> space: 0 unneeded,743093 used
>>>> [0] MatAssemblyEnd_SeqAIJ(): Matrix size: 186062 X 186062; storage
>>>> space: 0 unneeded,743036 used
>>>> [4] MatAssemblyEnd_SeqAIJ(): Number of mallocs during MatSetValues() is
>>>> 0
>>>> [4] MatAssemblyEnd_SeqAIJ(): Maximum nonzeros in any row is 4
>>>> [4] MatCheckCompressedRow(): Found the ratio (num_zerorows
>>>> 0)/(num_localrows 186063) < 0.6. Do not use CompressedRow routines.
>>>> [0] MatAssemblyEnd_SeqAIJ(): Number of mallocs during MatSetValues() is
>>>> 0
>>>> [5] MatAssemblyEnd_SeqAIJ(): Matrix size: 186062 X 186062; storage
>>>> space: 0 unneeded,742938 used
>>>> [5] MatAssemblyEnd_SeqAIJ(): Number of mallocs during MatSetValues() is
>>>> 0
>>>> [5] MatAssemblyEnd_SeqAIJ(): Maximum nonzeros in any row is 4
>>>> [5] MatCheckCompressedRow(): Found the ratio (num_zerorows
>>>> 0)/(num_localrows 186062) < 0.6. Do not use CompressedRow routines.
>>>> [0] MatAssemblyEnd_SeqAIJ(): Maximum nonzeros in any row is 4
>>>> [0] MatCheckCompressedRow(): Found the ratio (num_zerorows
>>>> 0)/(num_localrows 186062) < 0.6. Do not use CompressedRow routines.
>>>> [3] MatAssemblyEnd_SeqAIJ(): Matrix size: 186063 X 186063; storage
>>>> space: 0 unneeded,743049 used
>>>> [3] MatAssemblyEnd_SeqAIJ(): Number of mallocs during MatSetValues() is
>>>> 0
>>>> [3] MatAssemblyEnd_SeqAIJ(): Maximum nonzeros in any row is 4
>>>> [3] MatCheckCompressedRow(): Found the ratio (num_zerorows
>>>> 0)/(num_localrows 186063) < 0.6. Do not use CompressedRow routines.
>>>> [2] MatAssemblyEnd_SeqAIJ(): Matrix size: 186064 X 685; storage space:
>>>> 0 unneeded,685 used
>>>> [4] MatAssemblyEnd_SeqAIJ(): Matrix size: 186063 X 649; storage space:
>>>> 0 unneeded,649 used
>>>> [4] MatAssemblyEnd_SeqAIJ(): Number of mallocs during MatSetValues() is
>>>> 0
>>>> [4] MatAssemblyEnd_SeqAIJ(): Maximum nonzeros in any row is 1
>>>> [4] MatCheckCompressedRow(): Found the ratio (num_zerorows
>>>> 185414)/(num_localrows 186063) > 0.6. Use CompressedRow routines.
>>>> [2] MatAssemblyEnd_SeqAIJ(): Number of mallocs during MatSetValues() is
>>>> 0
>>>> [2] MatAssemblyEnd_SeqAIJ(): Maximum nonzeros in any row is 1
>>>> [2] MatCheckCompressedRow(): Found the ratio (num_zerorows
>>>> 185379)/(num_localrows 186064) > 0.6. Use CompressedRow routines.
>>>> [1] MatAssemblyEnd_SeqAIJ(): Matrix size: 186062 X 1011; storage space:
>>>> 0 unneeded,1011 used
>>>> [5] MatAssemblyEnd_SeqAIJ(): Matrix size: 186062 X 1137; storage space:
>>>> 0 unneeded,1137 used
>>>> [5] MatAssemblyEnd_SeqAIJ(): Number of mallocs during MatSetValues() is
>>>> 0
>>>> [5] MatAssemblyEnd_SeqAIJ(): Maximum nonzeros in any row is 1
>>>> [5] MatCheckCompressedRow(): Found the ratio (num_zerorows
>>>> 184925)/(num_localrows 186062) > 0.6. Use CompressedRow routines.
>>>> [1] MatAssemblyEnd_SeqAIJ(): Number of mallocs during MatSetValues() is
>>>> 0
>>>> [1] MatAssemblyEnd_SeqAIJ(): Maximum nonzeros in any row is 1
>>>> [3] MatAssemblyEnd_SeqAIJ(): Matrix size: 186063 X 658; storage space:
>>>> 0 unneeded,658 used
>>>> [0] MatAssemblyEnd_SeqAIJ(): Matrix size: 186062 X 648; storage space:
>>>> 0 unneeded,648 used
>>>> [1] MatCheckCompressedRow(): Found the ratio (num_zerorows
>>>> 185051)/(num_localrows 186062) > 0.6. Use CompressedRow routines.
>>>> [0] MatAssemblyEnd_SeqAIJ(): Number of mallocs during MatSetValues() is
>>>> 0
>>>> [0] MatAssemblyEnd_SeqAIJ(): Maximum nonzeros in any row is 1
>>>> [0] MatCheckCompressedRow(): Found the ratio (num_zerorows
>>>> 185414)/(num_localrows 186062) > 0.6. Use CompressedRow routines.
>>>> [3] MatAssemblyEnd_SeqAIJ(): Number of mallocs during MatSetValues() is
>>>> 0
>>>> [3] MatAssemblyEnd_SeqAIJ(): Maximum nonzeros in any row is 1
>>>> [3] MatCheckCompressedRow(): Found the ratio (num_zerorows
>>>> 185405)/(num_localrows 186063) > 0.6. Use CompressedRow routines.
>>>>
>>>>
>>>> ----------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------
>>>> Question 3:
>>>> If all matrix and vector inserted data are local, what part of the
>>>> vec/mat assembly consumes time because matsetvalues and matassembly consume
>>>> more time than matrix builder
>>>> Also this is not just for the first time MAT_FINAL_ASSEMBLY
>>>>
>>>>
>>>> For context the matrix in the above is nearly 1Mx1M partitioned over
>>>> six processes and it was NOT built using DM
>>>>
>>>> Finally the configure options are:
>>>>
>>>> Configure options:
>>>> PETSC_ARCH=release3 -with-debugging=0 COPTFLAGS="-O3 -march=native
>>>> -mtune=native" CXXOPTFLAGS="-O3 -march=native -mtune=native" FOPTFLAGS="-O3
>>>> -march=native -mtune=native" --with-cc=mpicc --with-cxx=mpicxx
>>>> --with-fc=mpif90 --download-metis --download-hypre
>>>>
>>>> Sorry for such long question and thanks in advance
>>>> Thanks
>>>> M. Kamra
>>>>
>>>
>>>
>>> --
>>> 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
>>>
>>> https://www.cse.buffalo.edu/~knepley/
>>> <http://www.cse.buffalo.edu/~knepley/>
>>>
>>
>
> --
> 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
>
> https://www.cse.buffalo.edu/~knepley/
> <http://www.cse.buffalo.edu/~knepley/>
>
-------------- next part --------------
An HTML attachment was scrubbed...
URL: <http://lists.mcs.anl.gov/pipermail/petsc-users/attachments/20190713/3b162551/attachment-0001.html>
-------------- next part --------------
[0] PetscInitialize(): PETSc successfully started: number of processors = 6
[0] PetscGetHostName(): Rejecting domainname, likely is NIS mohamedkamra-DAIV-DQZ520.(none)
[0] PetscInitialize(): Running on machine: mohamedkamra-DAIV-DQZ520
[1] PetscInitialize(): PETSc successfully started: number of processors = 6
[1] PetscGetHostName(): Rejecting domainname, likely is NIS mohamedkamra-DAIV-DQZ520.(none)
[1] PetscInitialize(): Running on machine: mohamedkamra-DAIV-DQZ520
[2] PetscInitialize(): PETSc successfully started: number of processors = 6
[2] PetscGetHostName(): Rejecting domainname, likely is NIS mohamedkamra-DAIV-DQZ520.(none)
[2] PetscInitialize(): Running on machine: mohamedkamra-DAIV-DQZ520
[3] PetscInitialize(): PETSc successfully started: number of processors = 6
[3] PetscGetHostName(): Rejecting domainname, likely is NIS mohamedkamra-DAIV-DQZ520.(none)
[3] PetscInitialize(): Running on machine: mohamedkamra-DAIV-DQZ520
[4] PetscInitialize(): PETSc successfully started: number of processors = 6
[4] PetscGetHostName(): Rejecting domainname, likely is NIS mohamedkamra-DAIV-DQZ520.(none)
[4] PetscInitialize(): Running on machine: mohamedkamra-DAIV-DQZ520
[5] PetscInitialize(): PETSc successfully started: number of processors = 6
[5] PetscGetHostName(): Rejecting domainname, likely is NIS mohamedkamra-DAIV-DQZ520.(none)
[5] PetscInitialize(): Running on machine: mohamedkamra-DAIV-DQZ520
Processor: 0/6
Set Matrix Start
[0] VecAssemblyBegin_MPI_BTS(): Stash has 0 entries, uses 0 mallocs.
[0] VecAssemblyBegin_MPI_BTS(): Block-Stash has 0 entries, uses 0 mallocs.
[0] MatAssemblyBegin_MPIAIJ(): Stash has 0 entries, uses 0 mallocs.
[4] MatAssemblyBegin_MPIAIJ(): Stash has 0 entries, uses 0 mallocs.
[5] MatAssemblyBegin_MPIAIJ(): Stash has 0 entries, uses 0 mallocs.
[1] MatAssemblyBegin_MPIAIJ(): Stash has 0 entries, uses 0 mallocs.
[2] MatAssemblyBegin_MPIAIJ(): Stash has 0 entries, uses 0 mallocs.
[3] MatAssemblyBegin_MPIAIJ(): Stash has 0 entries, uses 0 mallocs.
[4] MatAssemblyEnd_SeqAIJ(): Matrix size: 186063 X 186063; storage space: 0 unneeded,743093 used
[5] MatAssemblyEnd_SeqAIJ(): Matrix size: 186062 X 186062; storage space: 0 unneeded,742938 used
[5] MatAssemblyEnd_SeqAIJ(): Number of mallocs during MatSetValues() is 0
[5] MatAssemblyEnd_SeqAIJ(): Maximum nonzeros in any row is 4
[4] MatAssemblyEnd_SeqAIJ(): Number of mallocs during MatSetValues() is 0
[4] MatAssemblyEnd_SeqAIJ(): Maximum nonzeros in any row is 4
[5] MatCheckCompressedRow(): Found the ratio (num_zerorows 0)/(num_localrows 186062) < 0.6. Do not use CompressedRow routines.
[4] MatCheckCompressedRow(): Found the ratio (num_zerorows 0)/(num_localrows 186063) < 0.6. Do not use CompressedRow routines.
[0] MatAssemblyEnd_SeqAIJ(): Matrix size: 186062 X 186062; storage space: 0 unneeded,743036 used
[0] MatAssemblyEnd_SeqAIJ(): Number of mallocs during MatSetValues() is 0
[0] MatAssemblyEnd_SeqAIJ(): Maximum nonzeros in any row is 4
[0] MatCheckCompressedRow(): Found the ratio (num_zerorows 0)/(num_localrows 186062) < 0.6. Do not use CompressedRow routines.
[1] MatAssemblyEnd_SeqAIJ(): Matrix size: 186062 X 186062; storage space: 0 unneeded,742972 used
[3] MatAssemblyEnd_SeqAIJ(): Matrix size: 186063 X 186063; storage space: 0 unneeded,743049 used
[3] MatAssemblyEnd_SeqAIJ(): Number of mallocs during MatSetValues() is 0
[3] MatAssemblyEnd_SeqAIJ(): Maximum nonzeros in any row is 4
[3] MatCheckCompressedRow(): Found the ratio (num_zerorows 0)/(num_localrows 186063) < 0.6. Do not use CompressedRow routines.
[2] MatAssemblyEnd_SeqAIJ(): Matrix size: 186064 X 186064; storage space: 0 unneeded,743028 used
[2] MatAssemblyEnd_SeqAIJ(): Number of mallocs during MatSetValues() is 0
[2] MatAssemblyEnd_SeqAIJ(): Maximum nonzeros in any row is 4
[1] MatAssemblyEnd_SeqAIJ(): Number of mallocs during MatSetValues() is 0
[1] MatAssemblyEnd_SeqAIJ(): Maximum nonzeros in any row is 4
[2] MatCheckCompressedRow(): Found the ratio (num_zerorows 0)/(num_localrows 186064) < 0.6. Do not use CompressedRow routines.
[1] MatCheckCompressedRow(): Found the ratio (num_zerorows 0)/(num_localrows 186062) < 0.6. Do not use CompressedRow routines.
[4] MatSeqAIJCheckInode(): Found 186063 nodes out of 186063 rows. Not using Inode routines
[5] MatSeqAIJCheckInode(): Found 186062 nodes out of 186062 rows. Not using Inode routines
[0] MatSeqAIJCheckInode(): Found 186062 nodes out of 186062 rows. Not using Inode routines
[5] PetscCommDuplicate(): Using internal PETSc communicator 1140850689 -2080374780
[0] PetscCommDuplicate(): Using internal PETSc communicator 1140850689 -2080374777
[4] PetscCommDuplicate(): Using internal PETSc communicator 1140850689 -2080374780
[3] MatSeqAIJCheckInode(): Found 186063 nodes out of 186063 rows. Not using Inode routines
[1] MatSeqAIJCheckInode(): Found 186062 nodes out of 186062 rows. Not using Inode routines
[2] MatSeqAIJCheckInode(): Found 186064 nodes out of 186064 rows. Not using Inode routines
[3] PetscCommDuplicate(): Using internal PETSc communicator 1140850689 -2080374780
[1] PetscCommDuplicate(): Using internal PETSc communicator 1140850689 -2080374780
[2] PetscCommDuplicate(): Using internal PETSc communicator 1140850689 -2080374780
[0] PetscCommDuplicate(): Using internal PETSc communicator 1140850689 -2080374777
[1] PetscCommDuplicate(): Using internal PETSc communicator 1140850689 -2080374780
[2] PetscCommDuplicate(): Using internal PETSc communicator 1140850689 -2080374780
[3] PetscCommDuplicate(): Using internal PETSc communicator 1140850689 -2080374780
[4] PetscCommDuplicate(): Using internal PETSc communicator 1140850689 -2080374780
[5] PetscCommDuplicate(): Using internal PETSc communicator 1140850689 -2080374780
[0] VecScatterCreate_MPI1(): Using MPI1 for vector scatter
[0] VecScatterCreateCommon_PtoS_MPI1(): Using blocksize 1 scatter
[0] VecScatterCreate_PtoS(): General case: MPI to Seq
[4] MatAssemblyEnd_SeqAIJ(): Matrix size: 186063 X 649; storage space: 0 unneeded,649 used
[4] MatAssemblyEnd_SeqAIJ(): Number of mallocs during MatSetValues() is 0
[4] MatAssemblyEnd_SeqAIJ(): Maximum nonzeros in any row is 1
[4] MatCheckCompressedRow(): Found the ratio (num_zerorows 185414)/(num_localrows 186063) > 0.6. Use CompressedRow routines.
[5] MatAssemblyEnd_SeqAIJ(): Matrix size: 186062 X 1137; storage space: 0 unneeded,1137 used
[5] MatAssemblyEnd_SeqAIJ(): Number of mallocs during MatSetValues() is 0
[0] MatAssemblyEnd_SeqAIJ(): Matrix size: 186062 X 648; storage space: 0 unneeded,648 used
[5] MatAssemblyEnd_SeqAIJ(): Maximum nonzeros in any row is 1
[0] MatAssemblyEnd_SeqAIJ(): Number of mallocs during MatSetValues() is 0
[0] MatAssemblyEnd_SeqAIJ(): Maximum nonzeros in any row is 1
[0] MatCheckCompressedRow(): Found the ratio (num_zerorows 185414)/(num_localrows 186062) > 0.6. Use CompressedRow routines.
[5] MatCheckCompressedRow(): Found the ratio (num_zerorows 184925)/(num_localrows 186062) > 0.6. Use CompressedRow routines.
[1] MatAssemblyEnd_SeqAIJ(): Matrix size: 186062 X 1011; storage space: 0 unneeded,1011 used
[2] MatAssemblyEnd_SeqAIJ(): Matrix size: 186064 X 685; storage space: 0 unneeded,685 used
[2] MatAssemblyEnd_SeqAIJ(): Number of mallocs during MatSetValues() is 0
[2] MatAssemblyEnd_SeqAIJ(): Maximum nonzeros in any row is 1
[2] MatCheckCompressedRow(): Found the ratio (num_zerorows 185379)/(num_localrows 186064) > 0.6. Use CompressedRow routines.
[3] MatAssemblyEnd_SeqAIJ(): Matrix size: 186063 X 658; storage space: 0 unneeded,658 used
[3] MatAssemblyEnd_SeqAIJ(): Number of mallocs during MatSetValues() is 0
[3] MatAssemblyEnd_SeqAIJ(): Maximum nonzeros in any row is 1
[3] MatCheckCompressedRow(): Found the ratio (num_zerorows 185405)/(num_localrows 186063) > 0.6. Use CompressedRow routines.
[1] MatAssemblyEnd_SeqAIJ(): Number of mallocs during MatSetValues() is 0
[1] MatAssemblyEnd_SeqAIJ(): Maximum nonzeros in any row is 1
[1] MatCheckCompressedRow(): Found the ratio (num_zerorows 185051)/(num_localrows 186062) > 0.6. Use CompressedRow routines.

 Time to Setup (III): 0.0844824, count = 1
[1] PetscFinalize(): PetscFinalize() called
[1] PetscCommDuplicate(): Using internal PETSc communicator 1140850688 -2080374782
[4] PetscFinalize(): PetscFinalize() called
[4] PetscCommDuplicate(): Using internal PETSc communicator 1140850688 -2080374782
[5] PetscFinalize(): PetscFinalize() called
[5] PetscCommDuplicate(): Using internal PETSc communicator 1140850688 -2080374782
[2] PetscFinalize(): PetscFinalize() called
[2] PetscCommDuplicate(): Using internal PETSc communicator 1140850688 -2080374782
[3] PetscFinalize(): PetscFinalize() called
[3] PetscCommDuplicate(): Using internal PETSc communicator 1140850688 -2080374782


[0] PetscFinalize(): PetscFinalize() called
[1] PetscGetHostName(): Rejecting domainname, likely is NIS mohamedkamra-DAIV-DQZ520.(none)
[2] PetscGetHostName(): Rejecting domainname, likely is NIS mohamedkamra-DAIV-DQZ520.(none)
[4] PetscGetHostName(): Rejecting domainname, likely is NIS mohamedkamra-DAIV-DQZ520.(none)
[5] PetscGetHostName(): Rejecting domainname, likely is NIS mohamedkamra-DAIV-DQZ520.(none)
[0] PetscCommDuplicate(): Using internal PETSc communicator 1140850688 -2080374780
[3] PetscGetHostName(): Rejecting domainname, likely is NIS mohamedkamra-DAIV-DQZ520.(none)
[0] PetscGetHostName(): Rejecting domainname, likely is NIS mohamedkamra-DAIV-DQZ520.(none)
[3] PetscGetHostName(): Rejecting domainname, likely is NIS mohamedkamra-DAIV-DQZ520.(none)
[2] PetscGetHostName(): Rejecting domainname, likely is NIS mohamedkamra-DAIV-DQZ520.(none)
[4] PetscGetHostName(): Rejecting domainname, likely is NIS mohamedkamra-DAIV-DQZ520.(none)
[5] PetscGetHostName(): Rejecting domainname, likely is NIS mohamedkamra-DAIV-DQZ520.(none)
[1] PetscGetHostName(): Rejecting domainname, likely is NIS mohamedkamra-DAIV-DQZ520.(none)
************************************************************************************************************************
***             WIDEN YOUR WINDOW TO 120 CHARACTERS.  Use 'enscript -r -fCourier9' to print this document            ***
************************************************************************************************************************

---------------------------------------------- PETSc Performance Summary: ----------------------------------------------

[0] PetscGetHostName(): Rejecting domainname, likely is NIS mohamedkamra-DAIV-DQZ520.(none)
./OpenAqua300 on a release3 named mohamedkamra-DAIV-DQZ520 with 6 processors, by mohamedkamra Sat Jul 13 22:45:02 2019
Using Petsc Release Version 3.11.2, May, 18, 2019 

                         Max       Max/Min     Avg       Total 
Time (sec):           5.860e+00     1.000   5.860e+00
Objects:              5.300e+01     1.000   5.300e+01
Flop:                 0.000e+00     0.000   0.000e+00  0.000e+00
Flop/sec:             0.000e+00     0.000   0.000e+00  0.000e+00
MPI Messages:         1.150e+02     2.500   6.900e+01  4.140e+02
MPI Message Lengths:  1.684e+05     1.755   1.713e+03  7.091e+05
MPI Reductions:       7.100e+01     1.000

Flop counting convention: 1 flop = 1 real number operation of type (multiply/divide/add/subtract)
                            e.g., VecAXPY() for real vectors of length N --> 2N flop
                            and VecAXPY() for complex vectors of length N --> 8N flop

Summary of Stages:   ----- Time ------  ----- Flop ------  --- Messages ---  -- Message Lengths --  -- Reductions --
                        Avg     %Total     Avg     %Total    Count   %Total     Avg         %Total    Count   %Total 
 0:      Main Stage: 5.7764e+00  98.6%  0.0000e+00   0.0%  3.780e+02  91.3%  1.825e+03       97.3%  5.600e+01  78.9% 
 1: Matrix Construction: 8.3482e-02   1.4%  0.0000e+00   0.0%  3.600e+01   8.7%  5.340e+02        2.7%  8.000e+00  11.3% 

------------------------------------------------------------------------------------------------------------------------
See the 'Profiling' chapter of the users' manual for details on interpreting output.
Phase summary info:
   Count: number of times phase was executed
   Time and Flop: Max - maximum over all processors
                  Ratio - ratio of maximum to minimum over all processors
   Mess: number of messages sent
   AvgLen: average message length (bytes)
   Reduct: number of global reductions
   Global: entire computation
   Stage: stages of a computation. Set stages with PetscLogStagePush() and PetscLogStagePop().
      %T - percent time in this phase         %F - percent flop in this phase
      %M - percent messages in this phase     %L - percent message lengths in this phase
      %R - percent reductions in this phase
   Total Mflop/s: 10e-6 * (sum of flop over all processors)/(max time over all processors)
------------------------------------------------------------------------------------------------------------------------
Event                Count      Time (sec)     Flop                              --- Global ---  --- Stage ----  Total
                   Max Ratio  Max     Ratio   Max  Ratio  Mess   AvgLen  Reduct  %T %F %M %L %R  %T %F %M %L %R Mflop/s
------------------------------------------------------------------------------------------------------------------------

--- Event Stage 0: Main Stage

BuildTwoSidedF         9 1.0 7.4974e-0261.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00  1  0  0  0  0   1  0  0  0  0     0
VecSet                17 1.0 4.9084e-02 1.2 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00  1  0  0  0  0   1  0  0  0  0     0
VecAssemblyBegin      18 1.0 7.5064e-0256.4 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00  1  0  0  0  0   1  0  0  0  0     0
VecAssemblyEnd        18 1.0 4.4107e-05 1.1 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00  0  0  0  0  0   0  0  0  0  0     0
VecScatterBegin        9 1.0 4.0770e-04 1.5 0.00e+00 0.0 1.6e+02 3.5e+03 0.0e+00  0  0 39 81  0   0  0 43 83  0     0
VecScatterEnd          9 1.0 6.4468e-04 6.2 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00  0  0  0  0  0   0  0  0  0  0     0

--- Event Stage 1: Matrix Construction

BuildTwoSidedF         2 1.0 2.2705e-02244.2 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00  0  0  0  0  0  15  0  0  0  0     0
VecSet                 1 1.0 3.5763e-06 1.9 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00  0  0  0  0  0   0  0  0  0  0     0
VecAssemblyBegin       1 1.0 2.2648e-02730.7 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00  0  0  0  0  0  15  0  0  0  0     0
VecAssemblyEnd         1 1.0 4.5300e-06 1.7 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00  0  0  0  0  0   0  0  0  0  0     0
MatAssemblyBegin       1 1.0 1.0395e-04 1.6 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00  0  0  0  0  0   0  0  0  0  0     0
MatAssemblyEnd         1 1.0 8.8344e-03 1.0 0.00e+00 0.0 3.6e+01 5.3e+02 8.0e+00  0  0  9  3 11  11  0100100100     0
AssembleMats           1 1.0 3.1597e-02 3.5 0.00e+00 0.0 3.6e+01 5.3e+02 8.0e+00  0  0  9  3 11  26  0100100100     0
myMatSetValues         1 1.0 2.2590e-02 1.4 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00  0  0  0  0  0  24  0  0  0  0     0
setNativeMat           1 1.0 4.7478e-02 1.7 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00  1  0  0  0  0  45  0  0  0  0     0
callScheme             1 1.0 7.2021e-03 6.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00  0  0  0  0  0   4  0  0  0  0     0

--- Event Stage 2: Unknown


--- Event Stage 3: Unknown

------------------------------------------------------------------------------------------------------------------------

Memory usage is given in bytes:

Object Type          Creations   Destructions     Memory  Descendants' Mem.
Reports information only for process 0.

--- Event Stage 0: Main Stage

              Vector    19              0            0     0.
           Index Set    12             12        25056     0.
   IS L to G Mapping     6              0            0     0.
         Vec Scatter     6              0            0     0.
              Matrix     3              0            0     0.
       Krylov Solver     1              0            0     0.
              Viewer     1              0            0     0.

--- Event Stage 1: Matrix Construction

              Vector     2              1         1664     0.
           Index Set     2              2         4176     0.
         Vec Scatter     1              0            0     0.

--- Event Stage 2: Unknown


--- Event Stage 3: Unknown

========================================================================================================================
Average time to get PetscTime(): 7.62939e-07
Average time for MPI_Barrier(): 4.33922e-06
Average time for zero size MPI_Send(): 1.3113e-06
[4] Petsc_DelViewer(): Removing viewer data attribute in an MPI_Comm -2080374782
[1] Petsc_DelViewer(): Removing viewer data attribute in an MPI_Comm -2080374782
[2] Petsc_DelViewer(): Removing viewer data attribute in an MPI_Comm -2080374782
[3] Petsc_DelViewer(): Removing viewer data attribute in an MPI_Comm -2080374782
[5] Petsc_DelViewer(): Removing viewer data attribute in an MPI_Comm -2080374782
#PETSc Option Table entries:
-info
-log_view
#End of PETSc Option Table entries
Compiled without FORTRAN kernels
Compiled with full precision matrices (default)
sizeof(short) 2 sizeof(int) 4 sizeof(long) 8 sizeof(void*) 8 sizeof(PetscScalar) 8 sizeof(PetscInt) 4
Configure options: PETSC_ARCH=release3 -with-debugging=0 COPTFLAGS="-O3 -march=native -mtune=native" CXXOPTFLAGS="-O3 -march=native -mtune=native" FOPTFLAGS="-O3 -march=native -mtune=native" --with-cc=mpicc --with-cxx=mpicxx --with-fc=mpif90 --download-metis --download-hypre
-----------------------------------------
Libraries compiled on 2019-07-03 09:57:26 on mohamedkamra-DAIV-DQZ520 
Machine characteristics: Linux-4.18.0-25-generic-x86_64-with-Ubuntu-18.04-bionic
Using PETSc directory: /home/mohamedkamra/Downloads/petsc-3.11.2
Using PETSc arch: release3
-----------------------------------------

Using C compiler: mpicc  -fPIC -Wall -Wwrite-strings -Wno-strict-aliasing -Wno-unknown-pragmas -fstack-protector -fvisibility=hidden -O3 -march=native -mtune=native  
Using Fortran compiler: mpif90  -fPIC -Wall -ffree-line-length-0 -Wno-unused-dummy-argument -O3 -march=native -mtune=native    
-----------------------------------------

Using include paths: -I/home/mohamedkamra/Downloads/petsc-3.11.2/include -I/home/mohamedkamra/Downloads/petsc-3.11.2/release3/include
-----------------------------------------

Using C linker: mpicc
Using Fortran linker: mpif90
Using libraries: -Wl,-rpath,/home/mohamedkamra/Downloads/petsc-3.11.2/release3/lib -L/home/mohamedkamra/Downloads/petsc-3.11.2/release3/lib -lpetsc -Wl,-rpath,/home/mohamedkamra/Downloads/petsc-3.11.2/release3/lib -L/home/mohamedkamra/Downloads/petsc-3.11.2/release3/lib -Wl,-rpath,/usr/lib/x86_64-linux-gnu -L/usr/lib/x86_64-linux-gnu -Wl,-rpath,/usr/lib/gcc/x86_64-linux-gnu/7 -L/usr/lib/gcc/x86_64-linux-gnu/7 -Wl,-rpath,/lib/x86_64-linux-gnu -L/lib/x86_64-linux-gnu -lHYPRE -llapack -lblas -lmetis -lm -lX11 -lpthread -lstdc++ -ldl -lmpichfort -lmpich -lgfortran -lm -lgfortran -lm -lgcc_s -lquadmath -lstdc++ -ldl
-----------------------------------------

[0] Petsc_DelViewer(): Removing viewer data attribute in an MPI_Comm -2080374780
-------------- next part --------------
[0] PetscInitialize(): PETSc successfully started: number of processors = 6
[0] PetscGetHostName(): Rejecting domainname, likely is NIS mohamedkamra-DAIV-DQZ520.(none)
[0] PetscInitialize(): Running on machine: mohamedkamra-DAIV-DQZ520
[1] PetscInitialize(): PETSc successfully started: number of processors = 6
[1] PetscGetHostName(): Rejecting domainname, likely is NIS mohamedkamra-DAIV-DQZ520.(none)
[1] PetscInitialize(): Running on machine: mohamedkamra-DAIV-DQZ520
[2] PetscInitialize(): PETSc successfully started: number of processors = 6
[2] PetscGetHostName(): Rejecting domainname, likely is NIS mohamedkamra-DAIV-DQZ520.(none)
[2] PetscInitialize(): Running on machine: mohamedkamra-DAIV-DQZ520
[3] PetscInitialize(): PETSc successfully started: number of processors = 6
[3] PetscGetHostName(): Rejecting domainname, likely is NIS mohamedkamra-DAIV-DQZ520.(none)
[3] PetscInitialize(): Running on machine: mohamedkamra-DAIV-DQZ520
[4] PetscInitialize(): PETSc successfully started: number of processors = 6
[4] PetscGetHostName(): Rejecting domainname, likely is NIS mohamedkamra-DAIV-DQZ520.(none)
[4] PetscInitialize(): Running on machine: mohamedkamra-DAIV-DQZ520
[5] PetscInitialize(): PETSc successfully started: number of processors = 6
[5] PetscGetHostName(): Rejecting domainname, likely is NIS mohamedkamra-DAIV-DQZ520.(none)
[5] PetscInitialize(): Running on machine: mohamedkamra-DAIV-DQZ520
[0] PetscCommDuplicate(): Duplicating a communicator 1140850688 -2080374780 max tags = 268435455
[1] PetscCommDuplicate(): Duplicating a communicator 1140850688 -2080374782 max tags = 268435455
[2] PetscCommDuplicate(): Duplicating a communicator 1140850688 -2080374782 max tags = 268435455
[3] PetscCommDuplicate(): Duplicating a communicator 1140850688 -2080374782 max tags = 268435455
[4] PetscCommDuplicate(): Duplicating a communicator 1140850688 -2080374782 max tags = 268435455
[5] PetscCommDuplicate(): Duplicating a communicator 1140850688 -2080374782 max tags = 268435455
[0] PetscCommDuplicate(): Duplicating a communicator 1140850689 -2080374777 max tags = 268435455
[1] PetscCommDuplicate(): Duplicating a communicator 1140850689 -2080374780 max tags = 268435455
[1] PetscCommDuplicate(): Using internal PETSc communicator 1140850689 -2080374780
[2] PetscCommDuplicate(): Duplicating a communicator 1140850689 -2080374780 max tags = 268435455
[2] PetscCommDuplicate(): Using internal PETSc communicator 1140850689 -2080374780
[3] PetscCommDuplicate(): Duplicating a communicator 1140850689 -2080374780 max tags = 268435455
[3] PetscCommDuplicate(): Using internal PETSc communicator 1140850689 -2080374780
[4] PetscCommDuplicate(): Duplicating a communicator 1140850689 -2080374780 max tags = 268435455
[4] PetscCommDuplicate(): Using internal PETSc communicator 1140850689 -2080374780
[5] PetscCommDuplicate(): Duplicating a communicator 1140850689 -2080374780 max tags = 268435455
[0] PetscCommDuplicate(): Using internal PETSc communicator 1140850689 -2080374777
[5] PetscCommDuplicate(): Using internal PETSc communicator 1140850689 -2080374780
[0] MatAssemblyBegin_MPIAIJ(): Stash has 6660 entries, uses 0 mallocs.
[2] MatAssemblyBegin_MPIAIJ(): Stash has 6672 entries, uses 0 mallocs.
[4] MatAssemblyBegin_MPIAIJ(): Stash has 6664 entries, uses 0 mallocs.
[5] MatAssemblyBegin_MPIAIJ(): Stash has 6660 entries, uses 0 mallocs.
[1] MatAssemblyBegin_MPIAIJ(): Stash has 6672 entries, uses 0 mallocs.
[3] MatAssemblyBegin_MPIAIJ(): Stash has 6672 entries, uses 0 mallocs.
[4] MatAssemblyEnd_SeqAIJ(): Matrix size: 167000 X 167000; storage space: 7006 unneeded,1495994 used
[4] MatAssemblyEnd_SeqAIJ(): Number of mallocs during MatSetValues() is 0
[4] MatAssemblyEnd_SeqAIJ(): Maximum nonzeros in any row is 9
[4] MatCheckCompressedRow(): Found the ratio (num_zerorows 0)/(num_localrows 167000) < 0.6. Do not use CompressedRow routines.
[2] MatAssemblyEnd_SeqAIJ(): Matrix size: 167000 X 167000; storage space: 7006 unneeded,1495994 used
[2] MatAssemblyEnd_SeqAIJ(): Number of mallocs during MatSetValues() is 0
[2] MatAssemblyEnd_SeqAIJ(): Maximum nonzeros in any row is 9
[2] MatCheckCompressedRow(): Found the ratio (num_zerorows 0)/(num_localrows 167000) < 0.6. Do not use CompressedRow routines.
[3] MatAssemblyEnd_SeqAIJ(): Matrix size: 167000 X 167000; storage space: 7006 unneeded,1495994 used
[3] MatAssemblyEnd_SeqAIJ(): Number of mallocs during MatSetValues() is 0
[3] MatAssemblyEnd_SeqAIJ(): Maximum nonzeros in any row is 9
[3] MatCheckCompressedRow(): Found the ratio (num_zerorows 0)/(num_localrows 167000) < 0.6. Do not use CompressedRow routines.
[1] MatAssemblyEnd_SeqAIJ(): Matrix size: 167000 X 167000; storage space: 7006 unneeded,1495994 used
[1] MatAssemblyEnd_SeqAIJ(): Number of mallocs during MatSetValues() is 0
[1] MatAssemblyEnd_SeqAIJ(): Maximum nonzeros in any row is 9
[1] MatCheckCompressedRow(): Found the ratio (num_zerorows 0)/(num_localrows 167000) < 0.6. Do not use CompressedRow routines.
[5] MatAssemblyEnd_SeqAIJ(): Matrix size: 167000 X 167000; storage space: 7002 unneeded,1495998 used
[5] MatAssemblyEnd_SeqAIJ(): Number of mallocs during MatSetValues() is 0
[5] MatAssemblyEnd_SeqAIJ(): Maximum nonzeros in any row is 9
[5] MatCheckCompressedRow(): Found the ratio (num_zerorows 0)/(num_localrows 167000) < 0.6. Do not use CompressedRow routines.
[0] MatAssemblyEnd_SeqAIJ(): Matrix size: 167001 X 167001; storage space: 7002 unneeded,1496007 used
[0] MatAssemblyEnd_SeqAIJ(): Number of mallocs during MatSetValues() is 0
[0] MatAssemblyEnd_SeqAIJ(): Maximum nonzeros in any row is 9
[0] MatCheckCompressedRow(): Found the ratio (num_zerorows 0)/(num_localrows 167001) < 0.6. Do not use CompressedRow routines.
[4] MatSeqAIJCheckInode(): Found 167000 nodes out of 167000 rows. Not using Inode routines
[2] MatSeqAIJCheckInode(): Found 167000 nodes out of 167000 rows. Not using Inode routines
[3] MatSeqAIJCheckInode(): Found 167000 nodes out of 167000 rows. Not using Inode routines
[4] PetscCommDuplicate(): Using internal PETSc communicator 1140850689 -2080374780
[0] MatSeqAIJCheckInode(): Found 167001 nodes out of 167001 rows. Not using Inode routines
[1] MatSeqAIJCheckInode(): Found 167000 nodes out of 167000 rows. Not using Inode routines
[2] PetscCommDuplicate(): Using internal PETSc communicator 1140850689 -2080374780
[3] PetscCommDuplicate(): Using internal PETSc communicator 1140850689 -2080374780
[5] MatSeqAIJCheckInode(): Found 167000 nodes out of 167000 rows. Not using Inode routines
[0] PetscCommDuplicate(): Using internal PETSc communicator 1140850689 -2080374777
[1] PetscCommDuplicate(): Using internal PETSc communicator 1140850689 -2080374780
[5] PetscCommDuplicate(): Using internal PETSc communicator 1140850689 -2080374780
[0] PetscCommDuplicate(): Using internal PETSc communicator 1140850689 -2080374777
[5] PetscCommDuplicate(): Using internal PETSc communicator 1140850689 -2080374780
[1] PetscCommDuplicate(): Using internal PETSc communicator 1140850689 -2080374780
[2] PetscCommDuplicate(): Using internal PETSc communicator 1140850689 -2080374780
[3] PetscCommDuplicate(): Using internal PETSc communicator 1140850689 -2080374780
[4] PetscCommDuplicate(): Using internal PETSc communicator 1140850689 -2080374780
[0] VecScatterCreate_MPI1(): Using MPI1 for vector scatter
[0] VecScatterCreateCommon_PtoS_MPI1(): Using blocksize 1 scatter
[0] VecScatterCreate_PtoS(): General case: MPI to Seq
[2] MatAssemblyEnd_SeqAIJ(): Matrix size: 167000 X 2004; storage space: 1329996 unneeded,6004 used
[2] MatAssemblyEnd_SeqAIJ(): Number of mallocs during MatSetValues() is 0
[2] MatAssemblyEnd_SeqAIJ(): Maximum nonzeros in any row is 4
[2] MatCheckCompressedRow(): Found the ratio (num_zerorows 164996)/(num_localrows 167000) > 0.6. Use CompressedRow routines.
[1] MatAssemblyEnd_SeqAIJ(): Matrix size: 167000 X 2004; storage space: 1329996 unneeded,6004 used
[1] MatAssemblyEnd_SeqAIJ(): Number of mallocs during MatSetValues() is 0
[1] MatAssemblyEnd_SeqAIJ(): Maximum nonzeros in any row is 4
[1] MatCheckCompressedRow(): Found the ratio (num_zerorows 164996)/(num_localrows 167000) > 0.6. Use CompressedRow routines.
[4] MatAssemblyEnd_SeqAIJ(): Matrix size: 167000 X 2004; storage space: 1329996 unneeded,6004 used
[4] MatAssemblyEnd_SeqAIJ(): Number of mallocs during MatSetValues() is 0
[4] MatAssemblyEnd_SeqAIJ(): Maximum nonzeros in any row is 4
[4] MatCheckCompressedRow(): Found the ratio (num_zerorows 164996)/(num_localrows 167000) > 0.6. Use CompressedRow routines.
[5] MatAssemblyEnd_SeqAIJ(): Matrix size: 167000 X 1002; storage space: 1332998 unneeded,3002 used
[5] MatAssemblyEnd_SeqAIJ(): Number of mallocs during MatSetValues() is 0
[5] MatAssemblyEnd_SeqAIJ(): Maximum nonzeros in any row is 4
[5] MatCheckCompressedRow(): Found the ratio (num_zerorows 165998)/(num_localrows 167000) > 0.6. Use CompressedRow routines.
[3] MatAssemblyEnd_SeqAIJ(): Matrix size: 167000 X 2004; storage space: 1329996 unneeded,6004 used
[3] MatAssemblyEnd_SeqAIJ(): Number of mallocs during MatSetValues() is 0
[3] MatAssemblyEnd_SeqAIJ(): Maximum nonzeros in any row is 4
[3] MatCheckCompressedRow(): Found the ratio (num_zerorows 164996)/(num_localrows 167000) > 0.6. Use CompressedRow routines.
[0] MatAssemblyEnd_SeqAIJ(): Matrix size: 167001 X 1002; storage space: 1333006 unneeded,3002 used
[0] MatAssemblyEnd_SeqAIJ(): Number of mallocs during MatSetValues() is 0
[0] MatAssemblyEnd_SeqAIJ(): Maximum nonzeros in any row is 4
[0] MatCheckCompressedRow(): Found the ratio (num_zerorows 165999)/(num_localrows 167001) > 0.6. Use CompressedRow routines.
[0] PetscCommDuplicate(): Using internal PETSc communicator 1140850688 -2080374780
[1] PetscCommDuplicate(): Using internal PETSc communicator 1140850688 -2080374782
[2] PetscCommDuplicate(): Using internal PETSc communicator 1140850688 -2080374782
[4] PetscCommDuplicate(): Using internal PETSc communicator 1140850688 -2080374782
[5] PetscCommDuplicate(): Using internal PETSc communicator 1140850688 -2080374782
[3] PetscCommDuplicate(): Using internal PETSc communicator 1140850688 -2080374782
[0] VecAssemblyBegin_MPI_BTS(): Stash has 834 entries, uses 5 mallocs.
[0] VecAssemblyBegin_MPI_BTS(): Block-Stash has 0 entries, uses 0 mallocs.
[0] MatAssemblyEnd_SeqAIJ(): Matrix size: 167001 X 167001; storage space: 6652 unneeded,1489355 used
[0] MatAssemblyEnd_SeqAIJ(): Number of mallocs during MatSetValues() is 0
[0] MatAssemblyEnd_SeqAIJ(): Maximum nonzeros in any row is 9
[0] MatCheckCompressedRow(): Found the ratio (num_zerorows 0)/(num_localrows 167001) < 0.6. Do not use CompressedRow routines.
[2] MatAssemblyEnd_SeqAIJ(): Matrix size: 167000 X 167000; storage space: 1662 unneeded,1494332 used
[2] MatAssemblyEnd_SeqAIJ(): Number of mallocs during MatSetValues() is 0
[2] MatAssemblyEnd_SeqAIJ(): Maximum nonzeros in any row is 9
[2] MatCheckCompressedRow(): Found the ratio (num_zerorows 0)/(num_localrows 167000) < 0.6. Do not use CompressedRow routines.
[4] MatAssemblyEnd_SeqAIJ(): Matrix size: 167000 X 167000; storage space: 1662 unneeded,1494332 used
[4] MatAssemblyEnd_SeqAIJ(): Number of mallocs during MatSetValues() is 0
[4] MatAssemblyEnd_SeqAIJ(): Maximum nonzeros in any row is 9
[4] MatCheckCompressedRow(): Found the ratio (num_zerorows 0)/(num_localrows 167000) < 0.6. Do not use CompressedRow routines.
[3] MatAssemblyEnd_SeqAIJ(): Matrix size: 167000 X 167000; storage space: 1662 unneeded,1494332 used
[3] MatAssemblyEnd_SeqAIJ(): Number of mallocs during MatSetValues() is 0
[3] MatAssemblyEnd_SeqAIJ(): Maximum nonzeros in any row is 9
[3] MatCheckCompressedRow(): Found the ratio (num_zerorows 0)/(num_localrows 167000) < 0.6. Do not use CompressedRow routines.
[0] MatAssemblyEnd_SeqAIJ(): Matrix size: 167001 X 1002; storage space: 4 unneeded,2998 used
[0] MatAssemblyEnd_SeqAIJ(): Number of mallocs during MatSetValues() is 0
[0] MatAssemblyEnd_SeqAIJ(): Maximum nonzeros in any row is 4
[0] MatCheckCompressedRow(): Found the ratio (num_zerorows 166001)/(num_localrows 167001) > 0.6. Use CompressedRow routines.
[2] MatAssemblyEnd_SeqAIJ(): Matrix size: 167000 X 2004; storage space: 8 unneeded,5996 used
[2] MatAssemblyEnd_SeqAIJ(): Number of mallocs during MatSetValues() is 0
[2] MatAssemblyEnd_SeqAIJ(): Maximum nonzeros in any row is 4
[2] MatCheckCompressedRow(): Found the ratio (num_zerorows 165000)/(num_localrows 167000) > 0.6. Use CompressedRow routines.
[4] MatAssemblyEnd_SeqAIJ(): Matrix size: 167000 X 2004; storage space: 8 unneeded,5996 used
[4] MatAssemblyEnd_SeqAIJ(): Number of mallocs during MatSetValues() is 0
[4] MatAssemblyEnd_SeqAIJ(): Maximum nonzeros in any row is 4
[4] MatCheckCompressedRow(): Found the ratio (num_zerorows 165000)/(num_localrows 167000) > 0.6. Use CompressedRow routines.
[3] MatAssemblyEnd_SeqAIJ(): Matrix size: 167000 X 2004; storage space: 8 unneeded,5996 used
[3] MatAssemblyEnd_SeqAIJ(): Number of mallocs during MatSetValues() is 0
[3] MatAssemblyEnd_SeqAIJ(): Maximum nonzeros in any row is 4
[3] MatCheckCompressedRow(): Found the ratio (num_zerorows 165000)/(num_localrows 167000) > 0.6. Use CompressedRow routines.
[1] MatAssemblyEnd_SeqAIJ(): Matrix size: 167000 X 167000; storage space: 1662 unneeded,1494332 used
[1] MatAssemblyEnd_SeqAIJ(): Number of mallocs during MatSetValues() is 0
[1] MatAssemblyEnd_SeqAIJ(): Maximum nonzeros in any row is 9
[1] MatCheckCompressedRow(): Found the ratio (num_zerorows 0)/(num_localrows 167000) < 0.6. Do not use CompressedRow routines.
[5] MatAssemblyEnd_SeqAIJ(): Matrix size: 167000 X 167000; storage space: 6652 unneeded,1489346 used
[5] MatAssemblyEnd_SeqAIJ(): Number of mallocs during MatSetValues() is 0
[5] MatAssemblyEnd_SeqAIJ(): Maximum nonzeros in any row is 9
[5] MatCheckCompressedRow(): Found the ratio (num_zerorows 0)/(num_localrows 167000) < 0.6. Do not use CompressedRow routines.
[1] MatAssemblyEnd_SeqAIJ(): Matrix size: 167000 X 2004; storage space: 8 unneeded,5996 used
[1] MatAssemblyEnd_SeqAIJ(): Number of mallocs during MatSetValues() is 0
[1] MatAssemblyEnd_SeqAIJ(): Maximum nonzeros in any row is 4
[1] MatCheckCompressedRow(): Found the ratio (num_zerorows 165000)/(num_localrows 167000) > 0.6. Use CompressedRow routines.
[5] MatAssemblyEnd_SeqAIJ(): Matrix size: 167000 X 1002; storage space: 4 unneeded,2998 used
[5] MatAssemblyEnd_SeqAIJ(): Number of mallocs during MatSetValues() is 0
[5] MatAssemblyEnd_SeqAIJ(): Maximum nonzeros in any row is 4
[5] MatCheckCompressedRow(): Found the ratio (num_zerorows 166000)/(num_localrows 167000) > 0.6. Use CompressedRow routines.
[0] MatAssemblyBegin_MPIAIJ(): Stash has 0 entries, uses 0 mallocs.
[1] MatAssemblyBegin_MPIAIJ(): Stash has 0 entries, uses 0 mallocs.
[2] MatAssemblyBegin_MPIAIJ(): Stash has 0 entries, uses 0 mallocs.
[3] MatAssemblyBegin_MPIAIJ(): Stash has 0 entries, uses 0 mallocs.
[4] MatAssemblyBegin_MPIAIJ(): Stash has 0 entries, uses 0 mallocs.
[5] MatAssemblyBegin_MPIAIJ(): Stash has 0 entries, uses 0 mallocs.
[0] MatAssemblyEnd_SeqAIJ(): Matrix size: 167001 X 167001; storage space: 0 unneeded,1489355 used
[0] MatAssemblyEnd_SeqAIJ(): Number of mallocs during MatSetValues() is 0
[0] MatAssemblyEnd_SeqAIJ(): Maximum nonzeros in any row is 9
[0] MatCheckCompressedRow(): Found the ratio (num_zerorows 0)/(num_localrows 167001) < 0.6. Do not use CompressedRow routines.
[4] MatAssemblyEnd_SeqAIJ(): Matrix size: 167000 X 167000; storage space: 0 unneeded,1494332 used
[4] MatAssemblyEnd_SeqAIJ(): Number of mallocs during MatSetValues() is 0
[4] MatAssemblyEnd_SeqAIJ(): Maximum nonzeros in any row is 9
[4] MatCheckCompressedRow(): Found the ratio (num_zerorows 0)/(num_localrows 167000) < 0.6. Do not use CompressedRow routines.
[2] MatAssemblyEnd_SeqAIJ(): Matrix size: 167000 X 167000; storage space: 0 unneeded,1494332 used
[2] MatAssemblyEnd_SeqAIJ(): Number of mallocs during MatSetValues() is 0
[2] MatAssemblyEnd_SeqAIJ(): Maximum nonzeros in any row is 9
[2] MatCheckCompressedRow(): Found the ratio (num_zerorows 0)/(num_localrows 167000) < 0.6. Do not use CompressedRow routines.
[3] MatAssemblyEnd_SeqAIJ(): Matrix size: 167000 X 167000; storage space: 0 unneeded,1494332 used
[3] MatAssemblyEnd_SeqAIJ(): Number of mallocs during MatSetValues() is 0
[3] MatAssemblyEnd_SeqAIJ(): Maximum nonzeros in any row is 9
[3] MatCheckCompressedRow(): Found the ratio (num_zerorows 0)/(num_localrows 167000) < 0.6. Do not use CompressedRow routines.
[1] MatAssemblyEnd_SeqAIJ(): Matrix size: 167000 X 167000; storage space: 0 unneeded,1494332 used
[1] MatAssemblyEnd_SeqAIJ(): Number of mallocs during MatSetValues() is 0
[1] MatAssemblyEnd_SeqAIJ(): Maximum nonzeros in any row is 9
[1] MatCheckCompressedRow(): Found the ratio (num_zerorows 0)/(num_localrows 167000) < 0.6. Do not use CompressedRow routines.
[0] MatAssemblyEnd_SeqAIJ(): Matrix size: 167001 X 1002; storage space: 0 unneeded,2998 used
[0] MatAssemblyEnd_SeqAIJ(): Number of mallocs during MatSetValues() is 0
[0] MatAssemblyEnd_SeqAIJ(): Maximum nonzeros in any row is 4
[4] MatAssemblyEnd_SeqAIJ(): Matrix size: 167000 X 2004; storage space: 0 unneeded,5996 used
[4] MatAssemblyEnd_SeqAIJ(): Number of mallocs during MatSetValues() is 0
[4] MatAssemblyEnd_SeqAIJ(): Maximum nonzeros in any row is 4
[4] MatCheckCompressedRow(): Found the ratio (num_zerorows 165000)/(num_localrows 167000) > 0.6. Use CompressedRow routines.
[5] MatAssemblyEnd_SeqAIJ(): Matrix size: 167000 X 167000; storage space: 0 unneeded,1489346 used
[0] MatCheckCompressedRow(): Found the ratio (num_zerorows 166001)/(num_localrows 167001) > 0.6. Use CompressedRow routines.
[2] MatAssemblyEnd_SeqAIJ(): Matrix size: 167000 X 2004; storage space: 0 unneeded,5996 used
[2] MatAssemblyEnd_SeqAIJ(): Number of mallocs during MatSetValues() is 0
[2] MatAssemblyEnd_SeqAIJ(): Maximum nonzeros in any row is 4
[2] MatCheckCompressedRow(): Found the ratio (num_zerorows 165000)/(num_localrows 167000) > 0.6. Use CompressedRow routines.
[5] MatAssemblyEnd_SeqAIJ(): Number of mallocs during MatSetValues() is 0
[5] MatAssemblyEnd_SeqAIJ(): Maximum nonzeros in any row is 9
[5] MatCheckCompressedRow(): Found the ratio (num_zerorows 0)/(num_localrows 167000) < 0.6. Do not use CompressedRow routines.
[3] MatAssemblyEnd_SeqAIJ(): Matrix size: 167000 X 2004; storage space: 0 unneeded,5996 used
[3] MatAssemblyEnd_SeqAIJ(): Number of mallocs during MatSetValues() is 0
[3] MatAssemblyEnd_SeqAIJ(): Maximum nonzeros in any row is 4
[3] MatCheckCompressedRow(): Found the ratio (num_zerorows 165000)/(num_localrows 167000) > 0.6. Use CompressedRow routines.
[1] MatAssemblyEnd_SeqAIJ(): Matrix size: 167000 X 2004; storage space: 0 unneeded,5996 used
[1] MatAssemblyEnd_SeqAIJ(): Number of mallocs during MatSetValues() is 0
[1] MatAssemblyEnd_SeqAIJ(): Maximum nonzeros in any row is 4
[1] MatCheckCompressedRow(): Found the ratio (num_zerorows 165000)/(num_localrows 167000) > 0.6. Use CompressedRow routines.
[5] MatAssemblyEnd_SeqAIJ(): Matrix size: 167000 X 1002; storage space: 0 unneeded,2998 used
[5] MatAssemblyEnd_SeqAIJ(): Number of mallocs during MatSetValues() is 0
[5] MatAssemblyEnd_SeqAIJ(): Maximum nonzeros in any row is 4
[5] MatCheckCompressedRow(): Found the ratio (num_zerorows 166000)/(num_localrows 167000) > 0.6. Use CompressedRow routines.
[0] VecAssemblyBegin_MPI_BTS(): Stash has 2668 entries, uses 5 mallocs.
[0] VecAssemblyBegin_MPI_BTS(): Block-Stash has 0 entries, uses 0 mallocs.
[0] VecAssemblyBegin_MPI_BTS(): Stash has 2668 entries, uses 2 mallocs.
[0] VecAssemblyBegin_MPI_BTS(): Block-Stash has 0 entries, uses 0 mallocs.
[0] PetscCommDuplicate(): Using internal PETSc communicator 1140850688 -2080374780
[2] PetscCommDuplicate(): Using internal PETSc communicator 1140850688 -2080374782
[4] PetscCommDuplicate(): Using internal PETSc communicator 1140850688 -2080374782
[3] PetscCommDuplicate(): Using internal PETSc communicator 1140850688 -2080374782
[1] PetscCommDuplicate(): Using internal PETSc communicator 1140850688 -2080374782
[5] PetscCommDuplicate(): Using internal PETSc communicator 1140850688 -2080374782
[0] PCSetUp(): Setting up PC for first time
[0] PetscCommDuplicate(): Using internal PETSc communicator 1140850689 -2080374777
[0] PetscCommDuplicate(): Using internal PETSc communicator 1140850689 -2080374777
[0] PetscCommDuplicate(): Using internal PETSc communicator 1140850689 -2080374777
[2] PetscCommDuplicate(): Using internal PETSc communicator 1140850689 -2080374780
[2] PetscCommDuplicate(): Using internal PETSc communicator 1140850689 -2080374780
[2] PetscCommDuplicate(): Using internal PETSc communicator 1140850689 -2080374780
[4] PetscCommDuplicate(): Using internal PETSc communicator 1140850689 -2080374780
[4] PetscCommDuplicate(): Using internal PETSc communicator 1140850689 -2080374780
[4] PetscCommDuplicate(): Using internal PETSc communicator 1140850689 -2080374780
[4] PCSetUp(): Setting up PC for first time
[0] PCSetUp(): Setting up PC for first time
[2] PCSetUp(): Setting up PC for first time
[3] PetscCommDuplicate(): Using internal PETSc communicator 1140850689 -2080374780
[3] PetscCommDuplicate(): Using internal PETSc communicator 1140850689 -2080374780
[3] PetscCommDuplicate(): Using internal PETSc communicator 1140850689 -2080374780
[0] PetscCommDuplicate(): Using internal PETSc communicator 1140850689 -2080374777
[2] PetscCommDuplicate(): Using internal PETSc communicator 1140850689 -2080374780
[3] PCSetUp(): Setting up PC for first time
[4] PetscCommDuplicate(): Using internal PETSc communicator 1140850689 -2080374780
[3] PetscCommDuplicate(): Using internal PETSc communicator 1140850689 -2080374780
[0] PetscCommDuplicate(): Using internal PETSc communicator 1140850689 -2080374777
[2] PetscCommDuplicate(): Using internal PETSc communicator 1140850689 -2080374780
[4] PetscCommDuplicate(): Using internal PETSc communicator 1140850689 -2080374780
[1] PetscCommDuplicate(): Using internal PETSc communicator 1140850689 -2080374780
[3] PetscCommDuplicate(): Using internal PETSc communicator 1140850689 -2080374780
[1] PetscCommDuplicate(): Using internal PETSc communicator 1140850689 -2080374780
[1] PetscCommDuplicate(): Using internal PETSc communicator 1140850689 -2080374780
[1] PCSetUp(): Setting up PC for first time
[1] PetscCommDuplicate(): Using internal PETSc communicator 1140850689 -2080374780
[5] PetscCommDuplicate(): Using internal PETSc communicator 1140850689 -2080374780
[5] PetscCommDuplicate(): Using internal PETSc communicator 1140850689 -2080374780
[5] PetscCommDuplicate(): Using internal PETSc communicator 1140850689 -2080374780
[5] PCSetUp(): Setting up PC for first time
[5] PetscCommDuplicate(): Using internal PETSc communicator 1140850689 -2080374780
[1] PetscCommDuplicate(): Using internal PETSc communicator 1140850689 -2080374780
[5] PetscCommDuplicate(): Using internal PETSc communicator 1140850689 -2080374780
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] KSPConvergedDefault(): user has provided nonzero initial guess, computing 2-norm of preconditioned RHS
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[5] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[1] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[2] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[4] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[3] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged
[0] KSPConvergedDefault(): Linear solver has converged. Residual norm 5.834635436978e-04 is less than relative tolerance 1.000000000000e-05 times initial right hand side norm 5.841577009637e+01 at iteration 955
[0] VecAssemblyBegin_MPI_BTS(): Stash has 0 entries, uses 0 mallocs.
[0] VecAssemblyBegin_MPI_BTS(): Block-Stash has 0 entries, uses 0 mallocs.
Norm of error 0.00480768 Iterations 955
[5] Petsc_DelComm_Inner(): Removing reference to PETSc communicator embedded in a user MPI_Comm -2080374780
[0] Petsc_DelComm_Inner(): Removing reference to PETSc communicator embedded in a user MPI_Comm -2080374777
[0] Petsc_DelComm_Outer(): User MPI_Comm 1140850689 is being freed after removing reference from inner PETSc comm to this outer comm
[0] PetscCommDestroy(): Deleting PETSc MPI_Comm -2080374777
[0] Petsc_DelCounter(): Deleting counter data in an MPI_Comm -2080374777
[0] Petsc_DelComm_Inner(): Removing reference to PETSc communicator embedded in a user MPI_Comm -2080374780
[0] Petsc_DelComm_Outer(): User MPI_Comm 1140850688 is being freed after removing reference from inner PETSc comm to this outer comm
[0] PetscCommDestroy(): Deleting PETSc MPI_Comm -2080374780
[0] Petsc_DelCounter(): Deleting counter data in an MPI_Comm -2080374780
[0] PetscFinalize(): PetscFinalize() called
[5] Petsc_DelComm_Outer(): User MPI_Comm 1140850689 is being freed after removing reference from inner PETSc comm to this outer comm
[5] PetscCommDestroy(): Deleting PETSc MPI_Comm -2080374780
[5] Petsc_DelCounter(): Deleting counter data in an MPI_Comm -2080374780
[2] Petsc_DelComm_Inner(): Removing reference to PETSc communicator embedded in a user MPI_Comm -2080374780
[5] Petsc_DelComm_Inner(): Removing reference to PETSc communicator embedded in a user MPI_Comm -2080374782
[5] Petsc_DelComm_Outer(): User MPI_Comm 1140850688 is being freed after removing reference from inner PETSc comm to this outer comm
[5] PetscCommDestroy(): Deleting PETSc MPI_Comm -2080374782
[5] Petsc_DelCounter(): Deleting counter data in an MPI_Comm -2080374782
[5] PetscFinalize(): PetscFinalize() called
[2] Petsc_DelComm_Outer(): User MPI_Comm 1140850689 is being freed after removing reference from inner PETSc comm to this outer comm
[2] PetscCommDestroy(): Deleting PETSc MPI_Comm -2080374780
[2] Petsc_DelCounter(): Deleting counter data in an MPI_Comm -2080374780
[2] Petsc_DelComm_Inner(): Removing reference to PETSc communicator embedded in a user MPI_Comm -2080374782
[2] Petsc_DelComm_Outer(): User MPI_Comm 1140850688 is being freed after removing reference from inner PETSc comm to this outer comm
[4] Petsc_DelComm_Inner(): Removing reference to PETSc communicator embedded in a user MPI_Comm -2080374780
[4] Petsc_DelComm_Outer(): User MPI_Comm 1140850689 is being freed after removing reference from inner PETSc comm to this outer comm
[4] PetscCommDestroy(): Deleting PETSc MPI_Comm -2080374780
[4] Petsc_DelCounter(): Deleting counter data in an MPI_Comm -2080374780
[2] PetscCommDestroy(): Deleting PETSc MPI_Comm -2080374782
[4] Petsc_DelComm_Inner(): Removing reference to PETSc communicator embedded in a user MPI_Comm -2080374782
[4] Petsc_DelComm_Outer(): User MPI_Comm 1140850688 is being freed after removing reference from inner PETSc comm to this outer comm
[4] PetscCommDestroy(): Deleting PETSc MPI_Comm -2080374782
[4] Petsc_DelCounter(): Deleting counter data in an MPI_Comm -2080374782
[4] PetscFinalize(): PetscFinalize() called
[2] Petsc_DelCounter(): Deleting counter data in an MPI_Comm -2080374782
[2] PetscFinalize(): PetscFinalize() called
[3] Petsc_DelComm_Inner(): Removing reference to PETSc communicator embedded in a user MPI_Comm -2080374780
[1] Petsc_DelComm_Inner(): Removing reference to PETSc communicator embedded in a user MPI_Comm -2080374780
[3] Petsc_DelComm_Outer(): User MPI_Comm 1140850689 is being freed after removing reference from inner PETSc comm to this outer comm
[3] PetscCommDestroy(): Deleting PETSc MPI_Comm -2080374780
[3] Petsc_DelCounter(): Deleting counter data in an MPI_Comm -2080374780
[1] Petsc_DelComm_Outer(): User MPI_Comm 1140850689 is being freed after removing reference from inner PETSc comm to this outer comm
[1] PetscCommDestroy(): Deleting PETSc MPI_Comm -2080374780
[1] Petsc_DelCounter(): Deleting counter data in an MPI_Comm -2080374780
[3] Petsc_DelComm_Inner(): Removing reference to PETSc communicator embedded in a user MPI_Comm -2080374782
[1] Petsc_DelComm_Inner(): Removing reference to PETSc communicator embedded in a user MPI_Comm -2080374782
[3] Petsc_DelComm_Outer(): User MPI_Comm 1140850688 is being freed after removing reference from inner PETSc comm to this outer comm
[3] PetscCommDestroy(): Deleting PETSc MPI_Comm -2080374782
[3] Petsc_DelCounter(): Deleting counter data in an MPI_Comm -2080374782
[1] Petsc_DelComm_Outer(): User MPI_Comm 1140850688 is being freed after removing reference from inner PETSc comm to this outer comm
[3] PetscFinalize(): PetscFinalize() called
[1] PetscCommDestroy(): Deleting PETSc MPI_Comm -2080374782
[1] Petsc_DelCounter(): Deleting counter data in an MPI_Comm -2080374782
[1] PetscFinalize(): PetscFinalize() called
[0] PetscCommDuplicate(): Duplicating a communicator 1140850688 -2080374780 max tags = 268435455
[1] PetscCommDuplicate(): Duplicating a communicator 1140850688 -2080374782 max tags = 268435455
[2] PetscCommDuplicate(): Duplicating a communicator 1140850688 -2080374782 max tags = 268435455
[3] PetscCommDuplicate(): Duplicating a communicator 1140850688 -2080374782 max tags = 268435455
[4] PetscCommDuplicate(): Duplicating a communicator 1140850688 -2080374782 max tags = 268435455
[5] PetscCommDuplicate(): Duplicating a communicator 1140850688 -2080374782 max tags = 268435455
[0] PetscGetHostName(): Rejecting domainname, likely is NIS mohamedkamra-DAIV-DQZ520.(none)
[2] PetscGetHostName(): Rejecting domainname, likely is NIS mohamedkamra-DAIV-DQZ520.(none)
[4] PetscGetHostName(): Rejecting domainname, likely is NIS mohamedkamra-DAIV-DQZ520.(none)
[5] PetscGetHostName(): Rejecting domainname, likely is NIS mohamedkamra-DAIV-DQZ520.(none)
[3] PetscGetHostName(): Rejecting domainname, likely is NIS mohamedkamra-DAIV-DQZ520.(none)
************************************************************************************************************************
***             WIDEN YOUR WINDOW TO 120 CHARACTERS.  Use 'enscript -r -fCourier9' to print this document            ***
************************************************************************************************************************

---------------------------------------------- PETSc Performance Summary: ----------------------------------------------

[1] PetscGetHostName(): Rejecting domainname, likely is NIS mohamedkamra-DAIV-DQZ520.(none)
[4] PetscGetHostName(): Rejecting domainname, likely is NIS mohamedkamra-DAIV-DQZ520.(none)
[5] PetscGetHostName(): Rejecting domainname, likely is NIS mohamedkamra-DAIV-DQZ520.(none)
[0] PetscGetHostName(): Rejecting domainname, likely is NIS mohamedkamra-DAIV-DQZ520.(none)
[1] PetscGetHostName(): Rejecting domainname, likely is NIS mohamedkamra-DAIV-DQZ520.(none)
./OpenAqua300 on a release3 named mohamedkamra-DAIV-DQZ520 with 6 processors, by mohamedkamra Sat Jul 13 23:38:54 2019
Using Petsc Release Version 3.11.2, May, 18, 2019 
[2] PetscGetHostName(): Rejecting domainname, likely is NIS mohamedkamra-DAIV-DQZ520.(none)
[3] PetscGetHostName(): Rejecting domainname, likely is NIS mohamedkamra-DAIV-DQZ520.(none)

                         Max       Max/Min     Avg       Total 
Time (sec):           2.362e+01     1.000   2.362e+01
Objects:              5.800e+01     1.000   5.800e+01
Flop:                 1.627e+10     1.002   1.626e+10  9.759e+10
Flop/sec:             6.889e+08     1.002   6.886e+08  4.131e+09
MPI Messages:         2.024e+03     1.964   1.692e+03  1.016e+04
MPI Message Lengths:  1.603e+07     1.974   7.911e+03  8.034e+07
MPI Reductions:       1.965e+03     1.000

Flop counting convention: 1 flop = 1 real number operation of type (multiply/divide/add/subtract)
                            e.g., VecAXPY() for real vectors of length N --> 2N flop
                            and VecAXPY() for complex vectors of length N --> 8N flop

Summary of Stages:   ----- Time ------  ----- Flop ------  --- Messages ---  -- Message Lengths --  -- Reductions --
                        Avg     %Total     Avg     %Total    Count   %Total     Avg         %Total    Count   %Total 
 0:      Main Stage: 2.3531e+01  99.6%  9.7586e+10 100.0%  1.012e+04  99.7%  7.887e+03       99.4%  1.950e+03  99.2% 
 1:    CreateMatrix: 5.2341e-02   0.2%  0.0000e+00   0.0%  0.000e+00   0.0%  0.000e+00        0.0%  0.000e+00   0.0% 
 2:  AssembleMatrix: 3.7130e-02   0.2%  0.0000e+00   0.0%  3.500e+01   0.3%  1.487e+04        0.6%  8.000e+00   0.4% 

------------------------------------------------------------------------------------------------------------------------
See the 'Profiling' chapter of the users' manual for details on interpreting output.
Phase summary info:
   Count: number of times phase was executed
   Time and Flop: Max - maximum over all processors
                  Ratio - ratio of maximum to minimum over all processors
   Mess: number of messages sent
   AvgLen: average message length (bytes)
   Reduct: number of global reductions
   Global: entire computation
   Stage: stages of a computation. Set stages with PetscLogStagePush() and PetscLogStagePop().
      %T - percent time in this phase         %F - percent flop in this phase
      %M - percent messages in this phase     %L - percent message lengths in this phase
      %R - percent reductions in this phase
   Total Mflop/s: 10e-6 * (sum of flop over all processors)/(max time over all processors)
------------------------------------------------------------------------------------------------------------------------
Event                Count      Time (sec)     Flop                              --- Global ---  --- Stage ----  Total
                   Max Ratio  Max     Ratio   Max  Ratio  Mess   AvgLen  Reduct  %T %F %M %L %R  %T %F %M %L %R Mflop/s
------------------------------------------------------------------------------------------------------------------------

--- Event Stage 0: Main Stage

BuildTwoSided          1 1.0 3.0565e-04 5.9 0.00e+00 0.0 1.5e+01 4.0e+00 0.0e+00  0  0  0  0  0   0  0  0  0  0     0
BuildTwoSidedF         5 1.0 5.7135e-03 6.0 0.00e+00 0.0 1.8e+02 3.1e+03 0.0e+00  0  0  2  1  0   0  0  2  1  0     0
MatMult              987 1.0 5.3681e+00 1.0 2.80e+09 1.0 9.9e+03 8.0e+03 0.0e+00 22 17 97 98  0  22 17 98 99  0  3120
MatSolve             988 1.0 5.6464e+00 1.0 2.79e+09 1.0 0.0e+00 0.0e+00 0.0e+00 24 17  0  0  0  24 17  0  0  0  2959
MatLUFactorNum         1 1.0 1.0801e-02 1.1 6.13e+06 1.0 0.0e+00 0.0e+00 0.0e+00  0  0  0  0  0   0  0  0  0  0  3399
MatILUFactorSym        1 1.0 1.4261e-02 1.5 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00  0  0  0  0  0   0  0  0  0  0     0
MatAssemblyBegin       1 1.0 1.9233e-0322.6 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00  0  0  0  0  0   0  0  0  0  0     0
MatAssemblyEnd         1 1.0 4.6010e-03 1.3 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00  0  0  0  0  0   0  0  0  0  0     0
MatGetRowIJ            1 1.0 6.9141e-06 5.8 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00  0  0  0  0  0   0  0  0  0  0     0
MatGetOrdering         1 1.0 1.5485e-03 2.2 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00  0  0  0  0  0   0  0  0  0  0     0
VecMDot              955 1.0 5.4459e+00 1.1 4.92e+09 1.0 0.0e+00 0.0e+00 9.6e+02 22 30  0  0 49  22 30  0  0 49  5424
VecNorm              989 1.0 7.8345e-01 1.3 3.30e+08 1.0 0.0e+00 0.0e+00 9.9e+02  3  2  0  0 50   3  2  0  0 51  2530
VecScale             987 1.0 2.8213e-01 1.0 1.65e+08 1.0 0.0e+00 0.0e+00 0.0e+00  1  1  0  0  0   1  1  0  0  0  3505
VecCopy               32 1.0 1.2547e-02 1.1 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00  0  0  0  0  0   0  0  0  0  0     0
VecSet              1022 1.0 3.6945e-01 1.1 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00  2  0  0  0  0   2  0  0  0  0     0
VecAXPY               65 1.0 4.8391e-02 1.2 2.17e+07 1.0 0.0e+00 0.0e+00 0.0e+00  0  0  0  0  0   0  0  0  0  0  2692
VecMAXPY             987 1.0 5.8750e+00 1.0 5.24e+09 1.0 0.0e+00 0.0e+00 0.0e+00 25 32  0  0  0  25 32  0  0  0  5354
VecAssemblyBegin       4 1.0 4.4274e-03 2.7 0.00e+00 0.0 1.8e+02 3.1e+03 0.0e+00  0  0  2  1  0   0  0  2  1  0     0
VecAssemblyEnd         4 1.0 2.1100e-04 4.9 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00  0  0  0  0  0   0  0  0  0  0     0
VecScatterBegin      987 1.0 1.6651e-02 1.5 0.00e+00 0.0 9.9e+03 8.0e+03 0.0e+00  0  0 97 98  0   0  0 98 99  0     0
VecScatterEnd        987 1.0 2.6902e-02 1.2 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00  0  0  0  0  0   0  0  0  0  0     0
VecNormalize         987 1.0 1.0784e+00 1.2 4.94e+08 1.0 0.0e+00 0.0e+00 9.9e+02  4  3  0  0 50   4  3  0  0 51  2751
SFSetGraph             1 1.0 1.6689e-06 1.8 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00  0  0  0  0  0   0  0  0  0  0     0
SFSetUp                1 1.0 4.0174e-04 2.0 0.00e+00 0.0 4.5e+01 1.8e+03 0.0e+00  0  0  0  0  0   0  0  0  0  0     0
SFReduceBegin          1 1.0 2.6464e-05 1.6 0.00e+00 0.0 3.0e+01 2.7e+03 0.0e+00  0  0  0  0  0   0  0  0  0  0     0
SFReduceEnd            1 1.0 2.9325e-05 1.4 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00  0  0  0  0  0   0  0  0  0  0     0
KSPSetUp               2 1.0 2.9552e-03 1.6 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00  0  0  0  0  0   0  0  0  0  0     0
KSPSolve               1 1.0 2.3490e+01 1.0 1.63e+10 1.0 9.9e+03 8.0e+03 1.9e+03 99100 97 98 99 100100 98 99100  4154
KSPGMRESOrthog       955 1.0 1.0968e+01 1.0 9.85e+09 1.0 0.0e+00 0.0e+00 9.6e+02 46 61  0  0 49  46 61  0  0 49  5386
PCSetUp                2 1.0 2.5425e-02 1.2 6.13e+06 1.0 0.0e+00 0.0e+00 0.0e+00  0  0  0  0  0   0  0  0  0  0  1444
PCSetUpOnBlocks        1 1.0 2.5289e-02 1.2 6.13e+06 1.0 0.0e+00 0.0e+00 0.0e+00  0  0  0  0  0   0  0  0  0  0  1452
PCApply              988 1.0 6.0802e+00 1.0 2.79e+09 1.0 0.0e+00 0.0e+00 0.0e+00 25 17  0  0  0  25 17  0  0  0  2748

--- Event Stage 1: CreateMatrix


--- Event Stage 2: AssembleMatrix

BuildTwoSidedF         1 1.0 2.3713e-0252.5 0.00e+00 0.0 1.5e+01 3.2e+04 0.0e+00  0  0  0  1  0  34  0 43 92  0     0
MatAssemblyBegin       1 1.0 2.4225e-0220.5 0.00e+00 0.0 1.5e+01 3.2e+04 0.0e+00  0  0  0  1  0  35  0 43 92  0     0
MatAssemblyEnd         1 1.0 2.4207e-02 1.0 0.00e+00 0.0 2.0e+01 2.0e+03 8.0e+00  0  0  0  0  0  65  0 57  8100     0
VecSet                 1 1.0 5.2452e-06 2.4 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00  0  0  0  0  0   0  0  0  0  0     0
------------------------------------------------------------------------------------------------------------------------

Memory usage is given in bytes:

Object Type          Creations   Destructions     Memory  Descendants' Mem.
Reports information only for process 0.

--- Event Stage 0: Main Stage

              Matrix     4              4     61309196     0.
              Vector    40             41     50844160     0.
           Index Set     3              3      2006388     0.
         Vec Scatter     0              1         1392     0.
   Star Forest Graph     1              1          888     0.
       Krylov Solver     2              2        20040     0.
      Preconditioner     2              2         1912     0.
              Viewer     1              0            0     0.

--- Event Stage 1: CreateMatrix


--- Event Stage 2: AssembleMatrix

              Vector     2              1         1664     0.
           Index Set     2              2         5592     0.
         Vec Scatter     1              0            0     0.
========================================================================================================================
Average time to get PetscTime(): 0.
Average time for MPI_Barrier(): 4.76837e-08
Average time for zero size MPI_Send(): 0.
#PETSc Option Table entries:
-info
-log_view
-m 1000
#End of PETSc Option Table entries
Compiled without FORTRAN kernels
[1] Petsc_DelViewer(): Removing viewer data attribute in an MPI_Comm -2080374782
[2] Petsc_DelViewer(): Removing viewer data attribute in an MPI_Comm -2080374782
[2] Petsc_DelComm_Inner(): Removing reference to PETSc communicator embedded in a user MPI_Comm -2080374782
[2] Petsc_DelComm_Outer(): User MPI_Comm 1140850688 is being freed after removing reference from inner PETSc comm to this outer comm
[2] PetscCommDestroy(): Deleting PETSc MPI_Comm -2080374782
[2] Petsc_DelCounter(): Deleting counter data in an MPI_Comm -2080374782
[3] Petsc_DelViewer(): Removing viewer data attribute in an MPI_Comm -2080374782
[3] Petsc_DelComm_Inner(): Removing reference to PETSc communicator embedded in a user MPI_Comm -2080374782
[3] Petsc_DelComm_Outer(): User MPI_Comm 1140850688 is being freed after removing reference from inner PETSc comm to this outer comm
[3] PetscCommDestroy(): Deleting PETSc MPI_Comm -2080374782
[3] Petsc_DelCounter(): Deleting counter data in an MPI_Comm -2080374782
[4] Petsc_DelViewer(): Removing viewer data attribute in an MPI_Comm -2080374782
[4] Petsc_DelComm_Inner(): Removing reference to PETSc communicator embedded in a user MPI_Comm -2080374782
[4] Petsc_DelComm_Outer(): User MPI_Comm 1140850688 is being freed after removing reference from inner PETSc comm to this outer comm
[4] PetscCommDestroy(): Deleting PETSc MPI_Comm -2080374782
[4] Petsc_DelCounter(): Deleting counter data in an MPI_Comm -2080374782
[5] Petsc_DelViewer(): Removing viewer data attribute in an MPI_Comm -2080374782
[5] Petsc_DelComm_Inner(): Removing reference to PETSc communicator embedded in a user MPI_Comm -2080374782
[5] Petsc_DelComm_Outer(): User MPI_Comm 1140850688 is being freed after removing reference from inner PETSc comm to this outer comm
[5] PetscCommDestroy(): Deleting PETSc MPI_Comm -2080374782
[5] Petsc_DelCounter(): Deleting counter data in an MPI_Comm -2080374782
Compiled with full precision matrices (default)
sizeof(short) 2 sizeof(int) 4 sizeof(long) 8 sizeof(void*) 8 sizeof(PetscScalar) 8 sizeof(PetscInt) 4
Configure options: PETSC_ARCH=release3 -with-debugging=0 COPTFLAGS="-O3 -march=native -mtune=native" CXXOPTFLAGS="-O3 -march=native -mtune=native" FOPTFLAGS="-O3 -march=native -mtune=native" --with-cc=mpicc --with-cxx=mpicxx --with-fc=mpif90 --download-metis --download-hypre
-----------------------------------------
Libraries compiled on 2019-07-03 09:57:26 on mohamedkamra-DAIV-DQZ520 
Machine characteristics: Linux-4.18.0-25-generic-x86_64-with-Ubuntu-18.04-bionic
Using PETSc directory: /home/mohamedkamra/Downloads/petsc-3.11.2
Using PETSc arch: release3
-----------------------------------------

Using C compiler: mpicc  -fPIC -Wall -Wwrite-strings -Wno-strict-aliasing -Wno-unknown-pragmas -fstack-protector -fvisibility=hidden -O3 -march=native -mtune=native  
Using Fortran compiler: mpif90  -fPIC -Wall -ffree-line-length-0 -Wno-unused-dummy-argument -O3 -march=native -mtune=native    
-----------------------------------------

Using include paths: -I/home/mohamedkamra/Downloads/petsc-3.11.2/include -I/home/mohamedkamra/Downloads/petsc-3.11.2/release3/include
-----------------------------------------

Using C linker: mpicc
Using Fortran linker: mpif90
Using libraries: -Wl,-rpath,/home/mohamedkamra/Downloads/petsc-3.11.2/release3/lib -L/home/mohamedkamra/Downloads/petsc-3.11.2/release3/lib -lpetsc -Wl,-rpath,/home/mohamedkamra/Downloads/petsc-3.11.2/release3/lib -L/home/mohamedkamra/Downloads/petsc-3.11.2/release3/lib -Wl,-rpath,/usr/lib/x86_64-linux-gnu -L/usr/lib/x86_64-linux-gnu -Wl,-rpath,/usr/lib/gcc/x86_64-linux-gnu/7 -L/usr/lib/gcc/x86_64-linux-gnu/7 -Wl,-rpath,/lib/x86_64-linux-gnu -L/lib/x86_64-linux-gnu -lHYPRE -llapack -lblas -lmetis -lm -lX11 -lpthread -lstdc++ -ldl -lmpichfort -lmpich -lgfortran -lm -lgfortran -lm -lgcc_s -lquadmath -lstdc++ -ldl
-----------------------------------------

[0] Petsc_DelViewer(): Removing viewer data attribute in an MPI_Comm -2080374780
[0] Petsc_DelComm_Inner(): Removing reference to PETSc communicator embedded in a user MPI_Comm -2080374780
[0] Petsc_DelComm_Outer(): User MPI_Comm 1140850688 is being freed after removing reference from inner PETSc comm to this outer comm
[0] PetscCommDestroy(): Deleting PETSc MPI_Comm -2080374780
[0] Petsc_DelCounter(): Deleting counter data in an MPI_Comm -2080374780
[1] Petsc_DelComm_Inner(): Removing reference to PETSc communicator embedded in a user MPI_Comm -2080374782
[1] Petsc_DelComm_Outer(): User MPI_Comm 1140850688 is being freed after removing reference from inner PETSc comm to this outer comm
[1] PetscCommDestroy(): Deleting PETSc MPI_Comm -2080374782
[1] Petsc_DelCounter(): Deleting counter data in an MPI_Comm -2080374782
-------------- next part --------------
A non-text attachment was scrubbed...
Name: mod_ksp_ex3.c
Type: text/x-csrc
Size: 8625 bytes
Desc: not available
URL: <http://lists.mcs.anl.gov/pipermail/petsc-users/attachments/20190713/3b162551/attachment-0001.bin>


More information about the petsc-users mailing list