<html>
  <head>
    <meta content="text/html; charset=ISO-8859-1"
      http-equiv="Content-Type">
  </head>
  <body bgcolor="#FFFFFF" text="#000000">
    You can try the configure flags used by PETSc (3.2) that is
    pre-installed on Lonestar (configured with Hypre, MKL, Intel MPI
    etc.).<br>
    <br>
    $ module load petsc<br>
    <br>
    and then try any of the PETSc examples with bcgs hypre/none<br>
    <br>
    On 08/31/2012 07:46 PM, Mohammad Mirzadeh wrote:
    <blockquote
cite="mid:CAKsPKwkE4f7vn8v7R6FA8VwQYoFOuJJGZBWAv5byx=WdvjP--A@mail.gmail.com"
      type="cite">
      <div dir="ltr">Alright, just removed pthreadclasses and it did not
        help. The code still crashes.
        <div><br>
        </div>
        <div>Matt, I'm gonna try MKL now; However, don't you think its
          strange that the gcc version works even when I use MKL?<br>
          <br>
          <div class="gmail_quote">On Fri, Aug 31, 2012 at 5:12 PM,
            Matthew Knepley <span dir="ltr"><<a
                moz-do-not-send="true" href="mailto:knepley@gmail.com"
                target="_blank">knepley@gmail.com</a>></span> wrote:<br>
            <blockquote class="gmail_quote" style="margin:0 0 0
              .8ex;border-left:1px #ccc solid;padding-left:1ex">
              <div class="im">On Fri, Aug 31, 2012 at 6:51 PM, Jed Brown
                <span dir="ltr"><<a moz-do-not-send="true"
                    href="mailto:jedbrown@mcs.anl.gov" target="_blank">jedbrown@mcs.anl.gov</a>></span>
                wrote:<br>
              </div>
              <div class="gmail_quote">
                <div class="im">
                  <blockquote class="gmail_quote" style="margin:0 0 0
                    .8ex;border-left:1px #ccc solid;padding-left:1ex">
                    Can you remove pthreadclasses from your configure?
                    If the problem is still there, it looks a bit like a
                    misconfigured MPI. But get rid of the pthreadclasses
                    first.</blockquote>
                  <div><br>
                  </div>
                </div>
                <div>After that, I would get rid of MKL in favor of
                  --download-f-blas-lapack. My guess is that MKL is
                  doing something</div>
                <div>crazy in the compiler.</div>
                <div><br>
                </div>
                <div>    Matt</div>
                <div>
                  <div class="h5">
                    <div> </div>
                    <blockquote class="gmail_quote" style="margin:0 0 0
                      .8ex;border-left:1px #ccc solid;padding-left:1ex">
                      <div>
                        <div>
                          <div class="gmail_quote">
                            On Fri, Aug 31, 2012 at 6:38 PM, Mohammad
                            Mirzadeh <span dir="ltr"><<a
                                moz-do-not-send="true"
                                href="mailto:mirzadeh@gmail.com"
                                target="_blank">mirzadeh@gmail.com</a>></span>
                            wrote:<br>
                            <blockquote class="gmail_quote"
                              style="margin:0 0 0 .8ex;border-left:1px
                              #ccc solid;padding-left:1ex">
                              <div dir="ltr">hi guys,
                                <div><br>
                                </div>
                                <div>After doing many many tests across
                                  different machine (Linux box and a
                                  Mac) and clusters (Gordon and
                                  Lonestar) I'm able to reproduce a test
                                  in which my code crashes if I use a
                                  petsc version that is compiled with
                                  intel compiler. This does not happen
                                  if I use gcc. When I use BiCGSTAB
                                  solver along with hypre's BoomerAMG, I
                                  get the following error message:</div>
                                <div><br>
                                </div>
                                <div>
                                  <div>[0]PETSC ERROR:
                                    --------------------- Error Message
                                    ------------------------------------</div>
                                  <div>[0]PETSC ERROR: Error in external
                                    library!</div>
                                  <div>[0]PETSC ERROR: Error in HYPRE
                                    solver, error code 1!</div>
                                  <div>[0]PETSC ERROR:
                                    ------------------------------------------------------------------------</div>
                                  <div>[0]PETSC ERROR: Petsc Release
                                    Version 3.3.0, Patch 2, Fri Jul 13
                                    15:42:00 CDT 2012 </div>
                                  <div>[0]PETSC ERROR: See
                                    docs/changes/index.html for recent
                                    updates.</div>
                                  <div>[0]PETSC ERROR: See docs/faq.html
                                    for hints about trouble shooting.</div>
                                  <div>[0]PETSC ERROR: See
                                    docs/index.html for manual pages.</div>
                                  <div>[0]PETSC ERROR:
                                    ------------------------------------------------------------------------</div>
                                  <div>[0]PETSC ERROR: ./2D_cylinders on
                                    a arch-linu named <a
                                      moz-do-not-send="true"
                                      href="http://c341-116.ls4.tacc.utexas.edu"
                                      target="_blank">c341-116.ls4.tacc.utexas.edu</a>
                                    by mmirzade Fri Aug 31 18:13:15 2012</div>
                                  <div>[0]PETSC ERROR: Libraries linked
                                    from
                                    /work/02032/mmirzade/soft/petsc-3.3-p2/arch-linux-intel-debug/lib</div>
                                  <div>[0]PETSC ERROR: Configure run at
                                    Fri Aug 31 17:22:42 2012</div>
                                  <div>[0]PETSC ERROR: Configure options
                                    PETSC_ARCH=arch-linux-intel-debug
                                    --with-clanguage=cxx
                                    --with-pthreadclasses=1
                                    --with-mpi-dir=/opt/apps/intel11_1/mvapich2/1.6
                                    --with-blas-lapack-dir=/opt/apps/intel/11.1/mkl
                                    --download-hypre=1 --download-hdf5=1
                                    --download-metis=1
                                    --download-parmetis=1
                                    --download-superlu_dist=1</div>
                                  <div>[0]PETSC ERROR:
                                    ------------------------------------------------------------------------</div>
                                  <div>[0]PETSC ERROR: PCApply_HYPRE()
                                    line 160 in
                                    src/ksp/pc/impls/hypre/hypre.c</div>
                                  <div>[0]PETSC ERROR: PCApply() line
                                    384 in src/ksp/pc/interface/precon.c</div>
                                  <div>[0]PETSC ERROR:
                                    KSPInitialResidual() line 57 in
                                    src/ksp/ksp/interface/itres.c</div>
                                  <div>[0]PETSC ERROR: KSPSolve_BCGS()
                                    line 65 in
                                    src/ksp/ksp/impls/bcgs/bcgs.c</div>
                                  <div>[0]PETSC ERROR: KSPSolve() line
                                    446 in
                                    src/ksp/ksp/interface/itfunc.c</div>
                                  <div>[0]PETSC ERROR: solve() line 402
                                    in
"unknowndirectory/"/work/02032/mmirzade/codes/CASL/lib/algebra/petscLinearSolver.cpp</div>
                                  <div>[0]PETSC ERROR:
                                    --------------------- Error Message
                                    ------------------------------------</div>
                                  <div>[0]PETSC ERROR: Error in external
                                    library!</div>
                                  <div>[0]PETSC ERROR: Error in
                                    HYPRE_IJMatrixDestroy()!</div>
                                  <div>[0]PETSC ERROR:
                                    ------------------------------------------------------------------------</div>
                                  <div>[0]PETSC ERROR: Petsc Release
                                    Version 3.3.0, Patch 2, Fri Jul 13
                                    15:42:00 CDT 2012 </div>
                                  <div>[0]PETSC ERROR: See
                                    docs/changes/index.html for recent
                                    updates.</div>
                                  <div>[0]PETSC ERROR: See docs/faq.html
                                    for hints about trouble shooting.</div>
                                  <div>[0]PETSC ERROR: See
                                    docs/index.html for manual pages.</div>
                                  <div>
                                    [0]PETSC ERROR:
                                    ------------------------------------------------------------------------</div>
                                  <div>[0]PETSC ERROR: ./2D_cylinders on
                                    a arch-linu named <a
                                      moz-do-not-send="true"
                                      href="http://c341-116.ls4.tacc.utexas.edu"
                                      target="_blank">c341-116.ls4.tacc.utexas.edu</a>
                                    by mmirzade Fri Aug 31 18:13:15 2012</div>
                                  <div>[0]PETSC ERROR: Libraries linked
                                    from
                                    /work/02032/mmirzade/soft/petsc-3.3-p2/arch-linux-intel-debug/lib</div>
                                  <div>[0]PETSC ERROR: Configure run at
                                    Fri Aug 31 17:22:42 2012</div>
                                  <div>[0]PETSC ERROR: Configure options
                                    PETSC_ARCH=arch-linux-intel-debug
                                    --with-clanguage=cxx
                                    --with-pthreadclasses=1
                                    --with-mpi-dir=/opt/apps/intel11_1/mvapich2/1.6
                                    --with-blas-lapack-dir=/opt/apps/intel/11.1/mkl
                                    --download-hypre=1 --download-hdf5=1
                                    --download-metis=1
                                    --download-parmetis=1
                                    --download-superlu_dist=1</div>
                                  <div>[0]PETSC ERROR:
                                    ------------------------------------------------------------------------</div>
                                  <div>[0]PETSC ERROR: PCDestroy_HYPRE()
                                    line 178 in
                                    src/ksp/pc/impls/hypre/hypre.c</div>
                                  <div>[0]PETSC ERROR: PCDestroy() line
                                    119 in src/ksp/pc/interface/precon.c</div>
                                  <div>[0]PETSC ERROR: KSPDestroy() line
                                    786 in
                                    src/ksp/ksp/interface/itfunc.c</div>
                                  <div>[0]PETSC ERROR: clear() line 438
                                    in
"unknowndirectory/"/work/02032/mmirzade/codes/CASL/lib/algebra/petscLinearSolver.cpp</div>
                                  <div>[0]PETSC ERROR:
                                    ------------------------------------------------------------------------</div>
                                  <div>[0]PETSC ERROR: Caught signal
                                    number 11 SEGV: Segmentation
                                    Violation, probably memory access
                                    out of range</div>
                                  <div>
                                    [0]PETSC ERROR: Try option
                                    -start_in_debugger or
                                    -on_error_attach_debugger</div>
                                  <div>[0]PETSC ERROR: or see <a
                                      moz-do-not-send="true"
href="http://www.mcs.anl.gov/petsc/documentation/faq.html#valgrind[0]PETSC"
                                      target="_blank">http://www.mcs.anl.gov/petsc/documentation/faq.html#valgrind[0]PETSC</a>
                                    ERROR: or try <a
                                      moz-do-not-send="true"
                                      href="http://valgrind.org"
                                      target="_blank">http://valgrind.org</a>
                                    on GNU/linux and Apple Mac OS X to
                                    find memory corruption errors</div>
                                  <div>[0]PETSC ERROR: likely location
                                    of problem given in stack below</div>
                                  <div>[0]PETSC ERROR:
                                    ---------------------  Stack Frames
                                    ------------------------------------</div>
                                  <div>[0]PETSC ERROR: Note: The EXACT
                                    line numbers in the stack are not
                                    available,</div>
                                  <div>[0]PETSC ERROR:       INSTEAD the
                                    line number of the start of the
                                    function</div>
                                  <div>[0]PETSC ERROR:       is given.</div>
                                  <div>[0]PETSC ERROR: [0] VecDestroy
                                    line 574
                                    src/vec/vec/interface/vector.c</div>
                                  <div>[0]PETSC ERROR: [0] KSPReset_BCGS
                                    line 194
                                    src/ksp/ksp/impls/bcgs/bcgs.c</div>
                                  <div>[0]PETSC ERROR: [0] KSPReset line
                                    729 src/ksp/ksp/interface/itfunc.c</div>
                                  <div>[0]PETSC ERROR: [0] KSPDestroy
                                    line 768
                                    src/ksp/ksp/interface/itfunc.c</div>
                                  <div>[0]PETSC ERROR: [0] PetscError
                                    line 343 src/sys/error/err.c</div>
                                  <div>[0]PETSC ERROR: [0]
                                    HYPRE_IJMatrixDestroy line 0
                                    unknownunknown</div>
                                  <div>[0]PETSC ERROR: [0]
                                    PCDestroy_HYPRE line 177
                                    src/ksp/pc/impls/hypre/hypre.c</div>
                                  <div>[0]PETSC ERROR: [0] PCDestroy
                                    line 110
                                    src/ksp/pc/interface/precon.c</div>
                                  <div>[0]PETSC ERROR: [0] KSPDestroy
                                    line 768
                                    src/ksp/ksp/interface/itfunc.c</div>
                                  <div>[0]PETSC ERROR: [0] PetscError
                                    line 343 src/sys/error/err.c</div>
                                  <div>[0]PETSC ERROR: [0] PCApply_HYPRE
                                    line 149
                                    src/ksp/pc/impls/hypre/hypre.c</div>
                                  <div>[0]PETSC ERROR: [0] PCApply line
                                    373 src/ksp/pc/interface/precon.c</div>
                                  <div>[0]PETSC ERROR: [0]
                                    KSPInitialResidual line 45
                                    src/ksp/ksp/interface/itres.c</div>
                                  <div>[0]PETSC ERROR: [0] KSPSolve_BCGS
                                    line 54
                                    src/ksp/ksp/impls/bcgs/bcgs.c</div>
                                  <div>[0]PETSC ERROR: [0] KSPSolve line
                                    351 src/ksp/ksp/interface/itfunc.c</div>
                                  <div>[0]PETSC ERROR:
                                    --------------------- Error Message
                                    ------------------------------------</div>
                                  <div>[0]PETSC ERROR: Signal received!</div>
                                  <div>[0]PETSC ERROR:
                                    ------------------------------------------------------------------------</div>
                                  <div>[0]PETSC ERROR: Petsc Release
                                    Version 3.3.0, Patch 2, Fri Jul 13
                                    15:42:00 CDT 2012 </div>
                                  <div>[0]PETSC ERROR: See
                                    docs/changes/index.html for recent
                                    updates.</div>
                                  <div>[0]PETSC ERROR: See docs/faq.html
                                    for hints about trouble shooting.</div>
                                  <div>[0]PETSC ERROR: See
                                    docs/index.html for manual pages.</div>
                                  <div>[0]PETSC ERROR:
                                    ------------------------------------------------------------------------</div>
                                  <div>[0]PETSC ERROR: ./2D_cylinders on
                                    a arch-linu named <a
                                      moz-do-not-send="true"
                                      href="http://c341-116.ls4.tacc.utexas.edu"
                                      target="_blank">c341-116.ls4.tacc.utexas.edu</a>
                                    by mmirzade Fri Aug 31 18:13:15 2012</div>
                                  <div>[0]PETSC ERROR: Libraries linked
                                    from
                                    /work/02032/mmirzade/soft/petsc-3.3-p2/arch-linux-intel-debug/lib</div>
                                  <div>[0]PETSC ERROR: Configure run at
                                    Fri Aug 31 17:22:42 2012</div>
                                  <div>[0]PETSC ERROR: Configure options
                                    PETSC_ARCH=arch-linux-intel-debug
                                    --with-clanguage=cxx
                                    --with-pthreadclasses=1
                                    --with-mpi-dir=/opt/apps/intel11_1/mvapich2/1.6
                                    --with-blas-lapack-dir=/opt/apps/intel/11.1/mkl
                                    --download-hypre=1 --download-hdf5=1
                                    --download-metis=1
                                    --download-parmetis=1
                                    --download-superlu_dist=1</div>
                                  <div>[0]PETSC ERROR:
                                    ------------------------------------------------------------------------</div>
                                  <div>[0]PETSC ERROR: User provided
                                    function() line 0 in unknown
                                    directory unknown file</div>
                                  <div>application called
                                    MPI_Abort(MPI_COMM_WORLD, 59) -
                                    process 0</div>
                                </div>
                                <div><br>
                                </div>
                                <div><br>
                                </div>
                                <div>Initially I thought this is somehow
                                  related to hypre, but even when I run
                                  the code with -pc_type none I get:</div>
                                <div><br>
                                </div>
                                <div>
                                  <div>[0]PETSC ERROR:
                                    --------------------- Error Message
                                    ------------------------------------</div>
                                  <div>[0]PETSC ERROR: Floating point
                                    exception!</div>
                                  <div>[0]PETSC ERROR: Infinite or
                                    not-a-number generated in norm!</div>
                                  <div>[0]PETSC ERROR:
                                    ------------------------------------------------------------------------</div>
                                  <div>[0]PETSC ERROR: Petsc Release
                                    Version 3.3.0, Patch 2, Fri Jul 13
                                    15:42:00 CDT 2012 </div>
                                  <div>[0]PETSC ERROR: See
                                    docs/changes/index.html for recent
                                    updates.</div>
                                  <div>[0]PETSC ERROR: See docs/faq.html
                                    for hints about trouble shooting.</div>
                                  <div>[0]PETSC ERROR: See
                                    docs/index.html for manual pages.</div>
                                  <div>[0]PETSC ERROR:
                                    ------------------------------------------------------------------------</div>
                                  <div>[0]PETSC ERROR: ./2D_cylinders on
                                    a arch-linu named <a
                                      moz-do-not-send="true"
                                      href="http://c341-116.ls4.tacc.utexas.edu"
                                      target="_blank">c341-116.ls4.tacc.utexas.edu</a>
                                    by mmirzade Fri Aug 31 18:15:04 2012</div>
                                  <div>[0]PETSC ERROR: Libraries linked
                                    from
                                    /work/02032/mmirzade/soft/petsc-3.3-p2/arch-linux-intel-debug/lib</div>
                                  <div>[0]PETSC ERROR: Configure run at
                                    Fri Aug 31 17:22:42 2012</div>
                                  <div>[0]PETSC ERROR: Configure options
                                    PETSC_ARCH=arch-linux-intel-debug
                                    --with-clanguage=cxx
                                    --with-pthreadclasses=1
                                    --with-mpi-dir=/opt/apps/intel11_1/mvapich2/1.6
                                    --with-blas-lapack-dir=/opt/apps/intel/11.1/mkl
                                    --download-hypre=1 --download-hdf5=1
                                    --download-metis=1
                                    --download-parmetis=1
                                    --download-superlu_dist=1</div>
                                  <div>[0]PETSC ERROR:
                                    ------------------------------------------------------------------------</div>
                                  <div>[0]PETSC ERROR: VecNorm() line
                                    169 in
                                    src/vec/vec/interface/rvector.c</div>
                                  <div>[0]PETSC ERROR: KSPSolve_BCGS()
                                    line 78 in
                                    src/ksp/ksp/impls/bcgs/bcgs.c</div>
                                  <div>[0]PETSC ERROR: KSPSolve() line
                                    446 in
                                    src/ksp/ksp/interface/itfunc.c</div>
                                  <div>[0]PETSC ERROR: solve() line 402
                                    in
"unknowndirectory/"/work/02032/mmirzade/codes/CASL/lib/algebra/petscLinearSolver.cpp</div>
                                  <div>N5PETSc9ExceptionE</div>
                                </div>
                                <div><br>
                                </div>
                                <div><br>
                                </div>
                                <div>In both cases the solution to the
                                  linear system diverges. None of these
                                  issues happen when I build petsc with
                                  gcc. </div>
                                <div><br>
                                </div>
                                <div>Couple of points:</div>
                                <div><br>
                                </div>
                                <div>1) The gcc version is clean under
                                  valgrind (except the usual
                                  PetscInitialize errors ...) but the
                                  intel versions generates all sort of
                                  errors in valgrind. Please see blow
                                  (this is during one Poisson solve)</div>
                                <div>2) This is my petsc configure
                                  option:</div>
                                <div><br>
                                </div>
                                <div>
                                  <div>/configure
                                    PETSC_ARCH=arch-linux-gcc-debug
                                    --with-clanguage=cxx
                                    --with-pthreadclasses=1
                                    --with-mpi-dir=$MPICH_HOME
                                    --with-blas-lapack-dir=$TACC_MKL_DIR
                                    --download-hypre=1 --download-hdf5=1
                                    --download-metis=1
                                    --download-parmetis=1
                                    --download-superlu_dist=1</div>
                                </div>
                                <div><br>
                                </div>
                                <div>
                                  <div>./configure
                                    PETSC_ARCH=arch-linux-intel-debug
                                    --with-clanguage=cxx
                                    --with-pthreadclasses=1
                                    --with-mpi-dir=$MPICH_HOME
                                    --with-blas-lapack-dir=$TACC_MKL_DIR
                                    --download-hypre=1 --download-hdf5=1
                                    --download-metis=1
                                    --download-parmetis=1
                                    --download-superlu_dist=1</div>
                                </div>
                                <div><br>
                                </div>
                                <div><br>
                                </div>
                                <div>in both cases $TACC_MKL_DIR points
                                  to a mkl library compiled using intel
                                  compiler. I don't think if that has to
                                  do with any of this (looking at
                                  valgrind output) but then again that's
                                  the only version of mkl available on
                                  the cluster (Lonestar).</div>
                                <div><br>
                                </div>
                                <div>Do you think this is somehow a
                                  compiler bug(?) or something more like
                                  an undefined behavior in my own code?</div>
                                <div><br>
                                </div>
                                <div>
                                  <div>==8404== Conditional jump or move
                                    depends on uninitialised value(s)</div>
                                  <div>==8404==    at 0x74B236A: calloc
                                    (mvapich_malloc.c:3756)</div>
                                  <div>==8404==    by 0x747D79D:
                                    MPIU_Handle_obj_alloc_unsafe
                                    (handlemem.c:363)</div>
                                  <div>==8404==    by 0x747D665:
                                    MPIU_Handle_obj_alloc
                                    (handlemem.c:307)</div>
                                  <div>==8404==    by 0x744F596:
                                    MPIR_Comm_create (commutil.c:101)</div>
                                  <div>==8404==    by 0x744E84D:
                                    MPIR_Comm_copy (commutil.c:969)</div>
                                  <div>==8404==    by 0x7447F14:
                                    PMPI_Comm_dup (comm_dup.c:177)</div>
                                  <div>==8404==    by 0xB2292A:
                                    PCCreate_HYPRE (hypre.c:1018)</div>
                                  <div>==8404==    by 0xA64120:
                                    PCSetType(_p_PC*, char const*)
                                    (pcset.c:83)</div>
                                  <div>==8404==    by 0x46B3FE:
                                    PetscLinearSolver::setupSolver(MatStructure,
                                    char const*, char const*)
                                    (petscLinearSolver.cpp:331)</div>
                                  <div>==8404==    by 0x46E7D1:
                                    amr2D::fvm::pnpSolver::initialize()
                                    (pnpSolver_2d_FVM.cpp:46)</div>
                                  <div>==8404==    by 0x40D464: main
                                    (main_2D_cylinders.cpp:299)</div>
                                  <div>==8404== </div>
                                  <div>==8404== Conditional jump or move
                                    depends on uninitialised value(s)</div>
                                  <div>==8404==    at 0x74B21CD: calloc
                                    (mvapich_malloc.c:3825)</div>
                                  <div>==8404==    by 0x747D79D:
                                    MPIU_Handle_obj_alloc_unsafe
                                    (handlemem.c:363)</div>
                                  <div>==8404==    by 0x747D665:
                                    MPIU_Handle_obj_alloc
                                    (handlemem.c:307)</div>
                                  <div>==8404==    by 0x744F596:
                                    MPIR_Comm_create (commutil.c:101)</div>
                                  <div>==8404==    by 0x744E84D:
                                    MPIR_Comm_copy (commutil.c:969)</div>
                                  <div>==8404==    by 0x7447F14:
                                    PMPI_Comm_dup (comm_dup.c:177)</div>
                                  <div>==8404==    by 0xB2292A:
                                    PCCreate_HYPRE (hypre.c:1018)</div>
                                  <div>==8404==    by 0xA64120:
                                    PCSetType(_p_PC*, char const*)
                                    (pcset.c:83)</div>
                                  <div>==8404==    by 0x46B3FE:
                                    PetscLinearSolver::setupSolver(MatStructure,
                                    char const*, char const*)
                                    (petscLinearSolver.cpp:331)</div>
                                  <div>==8404==    by 0x46E7D1:
                                    amr2D::fvm::pnpSolver::initialize()
                                    (pnpSolver_2d_FVM.cpp:46)</div>
                                  <div>==8404==    by 0x40D464: main
                                    (main_2D_cylinders.cpp:299)</div>
                                  <div>==8404== </div>
                                  <div>==8404== Use of uninitialised
                                    value of size 8</div>
                                  <div>==8404==    at 0x8283154:
                                    __intel_new_memset (in
                                    /opt/apps/intel/11.1/lib/intel64/libirc.so)</div>
                                  <div>==8404==    by 0x8261535:
                                    _intel_fast_memset.J (in
                                    /opt/apps/intel/11.1/lib/intel64/libirc.so)</div>
                                  <div>==8404==    by 0x74B221A: calloc
                                    (mvapich_malloc.c:3826)</div>
                                  <div>==8404==    by 0x747D79D:
                                    MPIU_Handle_obj_alloc_unsafe
                                    (handlemem.c:363)</div>
                                  <div>==8404==    by 0x747D665:
                                    MPIU_Handle_obj_alloc
                                    (handlemem.c:307)</div>
                                  <div>==8404==    by 0x744F596:
                                    MPIR_Comm_create (commutil.c:101)</div>
                                  <div>==8404==    by 0x744E84D:
                                    MPIR_Comm_copy (commutil.c:969)</div>
                                  <div>==8404==    by 0x7447F14:
                                    PMPI_Comm_dup (comm_dup.c:177)</div>
                                  <div>==8404==    by 0xB2292A:
                                    PCCreate_HYPRE (hypre.c:1018)</div>
                                  <div>==8404==    by 0xA64120:
                                    PCSetType(_p_PC*, char const*)
                                    (pcset.c:83)</div>
                                  <div>==8404==    by 0x46B3FE:
                                    PetscLinearSolver::setupSolver(MatStructure,
                                    char const*, char const*)
                                    (petscLinearSolver.cpp:331)</div>
                                  <div>==8404==    by 0x46E7D1:
                                    amr2D::fvm::pnpSolver::initialize()
                                    (pnpSolver_2d_FVM.cpp:46)</div>
                                  <div>==8404== </div>
                                  <div>==8404== Conditional jump or move
                                    depends on uninitialised value(s)</div>
                                  <div>==8404==    at 0x74B236A: calloc
                                    (mvapich_malloc.c:3756)</div>
                                  <div>==8404==    by 0x747D714:
                                    MPIU_Handle_obj_alloc_unsafe
                                    (handlemem.c:363)</div>
                                  <div>==8404==    by 0x747D665:
                                    MPIU_Handle_obj_alloc
                                    (handlemem.c:307)</div>
                                  <div>==8404==    by 0x744F596:
                                    MPIR_Comm_create (commutil.c:101)</div>
                                  <div>==8404==    by 0x744E84D:
                                    MPIR_Comm_copy (commutil.c:969)</div>
                                  <div>==8404==    by 0x7447F14:
                                    PMPI_Comm_dup (comm_dup.c:177)</div>
                                  <div>==8404==    by 0xB2292A:
                                    PCCreate_HYPRE (hypre.c:1018)</div>
                                  <div>==8404==    by 0xA64120:
                                    PCSetType(_p_PC*, char const*)
                                    (pcset.c:83)</div>
                                  <div>==8404==    by 0x46B3FE:
                                    PetscLinearSolver::setupSolver(MatStructure,
                                    char const*, char const*)
                                    (petscLinearSolver.cpp:331)</div>
                                  <div>==8404==    by 0x46E7D1:
                                    amr2D::fvm::pnpSolver::initialize()
                                    (pnpSolver_2d_FVM.cpp:46)</div>
                                  <div>==8404==    by 0x40D464: main
                                    (main_2D_cylinders.cpp:299)</div>
                                  <div>==8404== </div>
                                  <div>==8404== Conditional jump or move
                                    depends on uninitialised value(s)</div>
                                  <div>==8404==    at 0x74B21CD: calloc
                                    (mvapich_malloc.c:3825)</div>
                                  <div>==8404==    by 0x747D714:
                                    MPIU_Handle_obj_alloc_unsafe
                                    (handlemem.c:363)</div>
                                  <div>==8404==    by 0x747D665:
                                    MPIU_Handle_obj_alloc
                                    (handlemem.c:307)</div>
                                  <div>==8404==    by 0x744F596:
                                    MPIR_Comm_create (commutil.c:101)</div>
                                  <div>==8404==    by 0x744E84D:
                                    MPIR_Comm_copy (commutil.c:969)</div>
                                  <div>==8404==    by 0x7447F14:
                                    PMPI_Comm_dup (comm_dup.c:177)</div>
                                  <div>==8404==    by 0xB2292A:
                                    PCCreate_HYPRE (hypre.c:1018)</div>
                                  <div>==8404==    by 0xA64120:
                                    PCSetType(_p_PC*, char const*)
                                    (pcset.c:83)</div>
                                  <div>==8404==    by 0x46B3FE:
                                    PetscLinearSolver::setupSolver(MatStructure,
                                    char const*, char const*)
                                    (petscLinearSolver.cpp:331)</div>
                                  <div>==8404==    by 0x46E7D1:
                                    amr2D::fvm::pnpSolver::initialize()
                                    (pnpSolver_2d_FVM.cpp:46)</div>
                                  <div>==8404==    by 0x40D464: main
                                    (main_2D_cylinders.cpp:299)</div>
                                  <div>==8404== </div>
                                  <div>==8404== Use of uninitialised
                                    value of size 8</div>
                                  <div>==8404==    at 0x8283136:
                                    __intel_new_memset (in
                                    /opt/apps/intel/11.1/lib/intel64/libirc.so)</div>
                                  <div>==8404==    by 0x8261535:
                                    _intel_fast_memset.J (in
                                    /opt/apps/intel/11.1/lib/intel64/libirc.so)</div>
                                  <div>==8404==    by 0x74B221A: calloc
                                    (mvapich_malloc.c:3826)</div>
                                  <div>==8404==    by 0x747D714:
                                    MPIU_Handle_obj_alloc_unsafe
                                    (handlemem.c:363)</div>
                                  <div>==8404==    by 0x747D665:
                                    MPIU_Handle_obj_alloc
                                    (handlemem.c:307)</div>
                                  <div>==8404==    by 0x744F596:
                                    MPIR_Comm_create (commutil.c:101)</div>
                                  <div>==8404==    by 0x744E84D:
                                    MPIR_Comm_copy (commutil.c:969)</div>
                                  <div>==8404==    by 0x7447F14:
                                    PMPI_Comm_dup (comm_dup.c:177)</div>
                                  <div>==8404==    by 0xB2292A:
                                    PCCreate_HYPRE (hypre.c:1018)</div>
                                  <div>==8404==    by 0xA64120:
                                    PCSetType(_p_PC*, char const*)
                                    (pcset.c:83)</div>
                                  <div>==8404==    by 0x46B3FE:
                                    PetscLinearSolver::setupSolver(MatStructure,
                                    char const*, char const*)
                                    (petscLinearSolver.cpp:331)</div>
                                  <div>==8404==    by 0x46E7D1:
                                    amr2D::fvm::pnpSolver::initialize()
                                    (pnpSolver_2d_FVM.cpp:46)</div>
                                  <div>==8404== </div>
                                  <div>==8404== Conditional jump or move
                                    depends on uninitialised value(s)</div>
                                  <div>==8404==    at 0x74B236A: calloc
                                    (mvapich_malloc.c:3756)</div>
                                  <div>==8404==    by 0x1623FF2:
                                    hypre_CAlloc (hypre_memory.c:121)</div>
                                  <div>==8404==    by 0x14E6385:
                                    hypre_BoomerAMGCreate
                                    (par_amg.c:203)</div>
                                  <div>==8404==    by 0x14E2E10:
                                    HYPRE_BoomerAMGCreate
                                    (HYPRE_parcsr_amg.c:31)</div>
                                  <div>==8404==    by 0xB1C33B:
                                    PCHYPRESetType_HYPRE (hypre.c:817)</div>
                                  <div>==8404==    by 0xB2117F:
                                    PCSetFromOptions_HYPRE(_p_PC*)
                                    (hypre.c:895)</div>
                                  <div>==8404==    by 0xA65705:
                                    PCSetFromOptions(_p_PC*)
                                    (pcset.c:196)</div>
                                  <div>==8404==    by 0x46B487:
                                    PetscLinearSolver::setupSolver(MatStructure,
                                    char const*, char const*)
                                    (petscLinearSolver.cpp:332)</div>
                                  <div>==8404==    by 0x46E7D1:
                                    amr2D::fvm::pnpSolver::initialize()
                                    (pnpSolver_2d_FVM.cpp:46)</div>
                                  <div>==8404==    by 0x40D464: main
                                    (main_2D_cylinders.cpp:299)</div>
                                  <div>==8404== </div>
                                  <div>Solving a nonlinear PB to get
                                    steady state solution ... </div>
                                  <div>==8404== Conditional jump or move
                                    depends on uninitialised value(s)</div>
                                  <div>==8404==    at 0x74B21CD: calloc
                                    (mvapich_malloc.c:3825)</div>
                                  <div>==8404==    by 0x1623FF2:
                                    hypre_CAlloc (hypre_memory.c:121)</div>
                                  <div>==8404==    by 0x14DB097:
                                    hypre_IJMatrixSetDiagOffdSizesParCSR
                                    (IJMatrix_parcsr.c:179)</div>
                                  <div>==8404==    by 0x14D97C9:
                                    HYPRE_IJMatrixSetDiagOffdSizes
                                    (HYPRE_IJMatrix.c:818)</div>
                                  <div>==8404==    by 0x11A2728:
                                    MatHYPRE_IJMatrixPreallocate(_p_Mat*,
                                    _p_Mat*, hypre_IJMatrix_struct*)
                                    (mhyp.c:48)</div>
                                  <div>==8404==    by 0x11A3E9C:
                                    MatHYPRE_IJMatrixCreate(_p_Mat*,
                                    hypre_IJMatrix_struct**) (mhyp.c:80)</div>
                                  <div>==8404==    by 0xAFDA92:
                                    PCSetUp_HYPRE(_p_PC*) (hypre.c:100)</div>
                                  <div>==8404==    by 0x12293CE:
                                    PCSetUp(_p_PC*) (precon.c:832)</div>
                                  <div>==8404==    by 0xC1D524:
                                    KSPSetUp(_p_KSP*) (itfunc.c:278)</div>
                                  <div>==8404==    by 0xC1EFD9:
                                    KSPSolve(_p_KSP*, _p_Vec*, _p_Vec*)
                                    (itfunc.c:402)</div>
                                  <div>==8404==    by 0x46C59F:
                                    PetscLinearSolver::solve(ArrayV<double>&,
                                    PetscBool)
                                    (petscLinearSolver.cpp:402)</div>
                                  <div>==8404==    by 0x472A92:
                                    amr2D::fvm::pbSolver::SolveNonLinearPB(double,
                                    int) (pbSolver_2d_FVM.cpp:148)</div>
                                  <div>==8404== </div>
                                  <div>==8404== Conditional jump or move
                                    depends on uninitialised value(s)</div>
                                  <div>==8404==    at 0x74AECA4:
                                    _int_malloc (mvapich_malloc.c:4332)</div>
                                  <div>==8404==    by 0x74AEE8D: malloc
                                    (mvapich_malloc.c:3409)</div>
                                  <div>==8404==    by 0x74AFB0F:
                                    memalign (mvapich_malloc.c:3626)</div>
                                  <div>==8404==    by 0x494BF3:
                                    PetscMallocAlign(unsigned long, int,
                                    char const*, char const*, char
                                    const*, void**) (mal.c:30)</div>
                                  <div>==8404==    by 0x496DFD:
                                    PetscTrMallocDefault(unsigned long,
                                    int, char const*, char const*, char
                                    const*, void**) (mtr.c:190)</div>
                                  <div>==8404==    by 0x5FA4BA:
                                    VecCreate_Seq (bvec3.c:40)</div>
                                  <div>==8404==    by 0x5B36DC:
                                    VecSetType(_p_Vec*, char const*)
                                    (vecreg.c:53)</div>
                                  <div>==8404==    by 0x614EA3:
                                    VecCreate_Standard (pbvec.c:264)</div>
                                  <div>==8404==    by 0x5B36DC:
                                    VecSetType(_p_Vec*, char const*)
                                    (vecreg.c:53)</div>
                                  <div>==8404==    by 0x703809:
                                    MatGetVecs(_p_Mat*, _p_Vec**,
                                    _p_Vec**) (matrix.c:8149)</div>
                                  <div>==8404==    by 0xAFDB5E:
                                    PCSetUp_HYPRE(_p_PC*) (hypre.c:104)</div>
                                  <div>==8404==    by 0x12293CE:
                                    PCSetUp(_p_PC*) (precon.c:832)</div>
                                  <div>==8404== </div>
                                  <div>==8404== Syscall param
                                    mmap(length) contains uninitialised
                                    byte(s)</div>
                                  <div>==8404==    at 0x3E3CED10EA: mmap
                                    (in /lib64/<a moz-do-not-send="true"
                                      href="http://libc-2.5.so"
                                      target="_blank">libc-2.5.so</a>)</div>
                                  <div>==8404==    by 0x74AECD1:
                                    _int_malloc (mvapich_malloc.c:4332)</div>
                                  <div>==8404==    by 0x74AEE8D: malloc
                                    (mvapich_malloc.c:3409)</div>
                                  <div>==8404==    by 0x74AFB0F:
                                    memalign (mvapich_malloc.c:3626)</div>
                                  <div>==8404==    by 0x494BF3:
                                    PetscMallocAlign(unsigned long, int,
                                    char const*, char const*, char
                                    const*, void**) (mal.c:30)</div>
                                  <div>==8404==    by 0x496DFD:
                                    PetscTrMallocDefault(unsigned long,
                                    int, char const*, char const*, char
                                    const*, void**) (mtr.c:190)</div>
                                  <div>==8404==    by 0x5FA4BA:
                                    VecCreate_Seq (bvec3.c:40)</div>
                                  <div>==8404==    by 0x5B36DC:
                                    VecSetType(_p_Vec*, char const*)
                                    (vecreg.c:53)</div>
                                  <div>==8404==    by 0x614EA3:
                                    VecCreate_Standard (pbvec.c:264)</div>
                                  <div>==8404==    by 0x5B36DC:
                                    VecSetType(_p_Vec*, char const*)
                                    (vecreg.c:53)</div>
                                  <div>==8404==    by 0x703809:
                                    MatGetVecs(_p_Mat*, _p_Vec**,
                                    _p_Vec**) (matrix.c:8149)</div>
                                  <div>==8404==    by 0xAFDB5E:
                                    PCSetUp_HYPRE(_p_PC*) (hypre.c:104)</div>
                                  <div>==8404== </div>
                                  <div>==8404== Conditional jump or move
                                    depends on uninitialised value(s)</div>
                                  <div>==8404==    at 0x74AEA3E:
                                    _int_malloc (mvapich_malloc.c:4332)</div>
                                  <div>==8404==    by 0x74AEE8D: malloc
                                    (mvapich_malloc.c:3409)</div>
                                  <div>==8404==    by 0x74AFB0F:
                                    memalign (mvapich_malloc.c:3626)</div>
                                  <div>==8404==    by 0x494BF3:
                                    PetscMallocAlign(unsigned long, int,
                                    char const*, char const*, char
                                    const*, void**) (mal.c:30)</div>
                                  <div>==8404==    by 0x496DFD:
                                    PetscTrMallocDefault(unsigned long,
                                    int, char const*, char const*, char
                                    const*, void**) (mtr.c:190)</div>
                                  <div>==8404==    by 0x5FA4BA:
                                    VecCreate_Seq (bvec3.c:40)</div>
                                  <div>==8404==    by 0x5B36DC:
                                    VecSetType(_p_Vec*, char const*)
                                    (vecreg.c:53)</div>
                                  <div>==8404==    by 0x614EA3:
                                    VecCreate_Standard (pbvec.c:264)</div>
                                  <div>==8404==    by 0x5B36DC:
                                    VecSetType(_p_Vec*, char const*)
                                    (vecreg.c:53)</div>
                                  <div>==8404==    by 0x703809:
                                    MatGetVecs(_p_Mat*, _p_Vec**,
                                    _p_Vec**) (matrix.c:8149)</div>
                                  <div>==8404==    by 0xAFDB5E:
                                    PCSetUp_HYPRE(_p_PC*) (hypre.c:104)</div>
                                  <div>==8404==    by 0x12293CE:
                                    PCSetUp(_p_PC*) (precon.c:832)</div>
                                  <div>==8404== </div>
                                  <div>==8404== Conditional jump or move
                                    depends on uninitialised value(s)</div>
                                  <div>==8404==    at 0x74AEA70:
                                    _int_malloc (mvapich_malloc.c:4332)</div>
                                  <div>==8404==    by 0x74AEE8D: malloc
                                    (mvapich_malloc.c:3409)</div>
                                  <div>==8404==    by 0x74AFB0F:
                                    memalign (mvapich_malloc.c:3626)</div>
                                  <div>==8404==    by 0x494BF3:
                                    PetscMallocAlign(unsigned long, int,
                                    char const*, char const*, char
                                    const*, void**) (mal.c:30)</div>
                                  <div>==8404==    by 0x496DFD:
                                    PetscTrMallocDefault(unsigned long,
                                    int, char const*, char const*, char
                                    const*, void**) (mtr.c:190)</div>
                                  <div>==8404==    by 0x5FA4BA:
                                    VecCreate_Seq (bvec3.c:40)</div>
                                  <div>==8404==    by 0x5B36DC:
                                    VecSetType(_p_Vec*, char const*)
                                    (vecreg.c:53)</div>
                                  <div>==8404==    by 0x614EA3:
                                    VecCreate_Standard (pbvec.c:264)</div>
                                  <div>==8404==    by 0x5B36DC:
                                    VecSetType(_p_Vec*, char const*)
                                    (vecreg.c:53)</div>
                                  <div>==8404==    by 0x703809:
                                    MatGetVecs(_p_Mat*, _p_Vec**,
                                    _p_Vec**) (matrix.c:8149)</div>
                                  <div>==8404==    by 0xAFDB5E:
                                    PCSetUp_HYPRE(_p_PC*) (hypre.c:104)</div>
                                  <div>==8404==    by 0x12293CE:
                                    PCSetUp(_p_PC*) (precon.c:832)</div>
                                  <div>==8404== </div>
                                  <div>==8404== Use of uninitialised
                                    value of size 8</div>
                                  <div>==8404==    at 0x74AEA8A:
                                    _int_malloc (mvapich_malloc.c:4332)</div>
                                  <div>==8404==    by 0x74AEE8D: malloc
                                    (mvapich_malloc.c:3409)</div>
                                  <div>==8404==    by 0x74AFB0F:
                                    memalign (mvapich_malloc.c:3626)</div>
                                  <div>==8404==    by 0x494BF3:
                                    PetscMallocAlign(unsigned long, int,
                                    char const*, char const*, char
                                    const*, void**) (mal.c:30)</div>
                                  <div>==8404==    by 0x496DFD:
                                    PetscTrMallocDefault(unsigned long,
                                    int, char const*, char const*, char
                                    const*, void**) (mtr.c:190)</div>
                                  <div>==8404==    by 0x5FA4BA:
                                    VecCreate_Seq (bvec3.c:40)</div>
                                  <div>==8404==    by 0x5B36DC:
                                    VecSetType(_p_Vec*, char const*)
                                    (vecreg.c:53)</div>
                                  <div>==8404==    by 0x614EA3:
                                    VecCreate_Standard (pbvec.c:264)</div>
                                  <div>==8404==    by 0x5B36DC:
                                    VecSetType(_p_Vec*, char const*)
                                    (vecreg.c:53)</div>
                                  <div>==8404==    by 0x703809:
                                    MatGetVecs(_p_Mat*, _p_Vec**,
                                    _p_Vec**) (matrix.c:8149)</div>
                                  <div>==8404==    by 0xAFDB5E:
                                    PCSetUp_HYPRE(_p_PC*) (hypre.c:104)</div>
                                  <div>==8404==    by 0x12293CE:
                                    PCSetUp(_p_PC*) (precon.c:832)</div>
                                  <div>==8404== </div>
                                  <div>==8404== Conditional jump or move
                                    depends on uninitialised value(s)</div>
                                  <div>==8404==    at 0x74AEA98:
                                    _int_malloc (mvapich_malloc.c:4332)</div>
                                  <div>==8404==    by 0x74AEE8D: malloc
                                    (mvapich_malloc.c:3409)</div>
                                  <div>==8404==    by 0x74AFB0F:
                                    memalign (mvapich_malloc.c:3626)</div>
                                  <div>==8404==    by 0x494BF3:
                                    PetscMallocAlign(unsigned long, int,
                                    char const*, char const*, char
                                    const*, void**) (mal.c:30)</div>
                                  <div>==8404==    by 0x496DFD:
                                    PetscTrMallocDefault(unsigned long,
                                    int, char const*, char const*, char
                                    const*, void**) (mtr.c:190)</div>
                                  <div>==8404==    by 0x5FA4BA:
                                    VecCreate_Seq (bvec3.c:40)</div>
                                  <div>==8404==    by 0x5B36DC:
                                    VecSetType(_p_Vec*, char const*)
                                    (vecreg.c:53)</div>
                                  <div>==8404==    by 0x614EA3:
                                    VecCreate_Standard (pbvec.c:264)</div>
                                  <div>==8404==    by 0x5B36DC:
                                    VecSetType(_p_Vec*, char const*)
                                    (vecreg.c:53)</div>
                                  <div>==8404==    by 0x703809:
                                    MatGetVecs(_p_Mat*, _p_Vec**,
                                    _p_Vec**) (matrix.c:8149)</div>
                                  <div>==8404==    by 0xAFDB5E:
                                    PCSetUp_HYPRE(_p_PC*) (hypre.c:104)</div>
                                  <div>==8404==    by 0x12293CE:
                                    PCSetUp(_p_PC*) (precon.c:832)</div>
                                  <div>==8404== </div>
                                  <div>==8404== Conditional jump or move
                                    depends on uninitialised value(s)</div>
                                  <div>==8404==    at 0x74AD6E6:
                                    _int_free (mvapich_malloc.c:4366)</div>
                                  <div>==8404==    by 0x74AEAA8:
                                    _int_malloc (mvapich_malloc.c:4332)</div>
                                  <div>==8404==    by 0x74AEE8D: malloc
                                    (mvapich_malloc.c:3409)</div>
                                  <div>==8404==    by 0x74AFB0F:
                                    memalign (mvapich_malloc.c:3626)</div>
                                  <div>==8404==    by 0x494BF3:
                                    PetscMallocAlign(unsigned long, int,
                                    char const*, char const*, char
                                    const*, void**) (mal.c:30)</div>
                                  <div>==8404==    by 0x496DFD:
                                    PetscTrMallocDefault(unsigned long,
                                    int, char const*, char const*, char
                                    const*, void**) (mtr.c:190)</div>
                                  <div>==8404==    by 0x5FA4BA:
                                    VecCreate_Seq (bvec3.c:40)</div>
                                  <div>==8404==    by 0x5B36DC:
                                    VecSetType(_p_Vec*, char const*)
                                    (vecreg.c:53)</div>
                                  <div>==8404==    by 0x614EA3:
                                    VecCreate_Standard (pbvec.c:264)</div>
                                  <div>==8404==    by 0x5B36DC:
                                    VecSetType(_p_Vec*, char const*)
                                    (vecreg.c:53)</div>
                                  <div>==8404==    by 0x703809:
                                    MatGetVecs(_p_Mat*, _p_Vec**,
                                    _p_Vec**) (matrix.c:8149)</div>
                                  <div>==8404==    by 0xAFDB5E:
                                    PCSetUp_HYPRE(_p_PC*) (hypre.c:104)</div>
                                  <div>==8404== </div>
                                  <div>==8404== Use of uninitialised
                                    value of size 8</div>
                                  <div>==8404==    at 0x74AD723:
                                    _int_free (mvapich_malloc.c:4389)</div>
                                  <div>==8404==    by 0x74AEAA8:
                                    _int_malloc (mvapich_malloc.c:4332)</div>
                                  <div>==8404==    by 0x74AEE8D: malloc
                                    (mvapich_malloc.c:3409)</div>
                                  <div>==8404==    by 0x74AFB0F:
                                    memalign (mvapich_malloc.c:3626)</div>
                                  <div>==8404==    by 0x494BF3:
                                    PetscMallocAlign(unsigned long, int,
                                    char const*, char const*, char
                                    const*, void**) (mal.c:30)</div>
                                  <div>==8404==    by 0x496DFD:
                                    PetscTrMallocDefault(unsigned long,
                                    int, char const*, char const*, char
                                    const*, void**) (mtr.c:190)</div>
                                  <div>==8404==    by 0x5FA4BA:
                                    VecCreate_Seq (bvec3.c:40)</div>
                                  <div>==8404==    by 0x5B36DC:
                                    VecSetType(_p_Vec*, char const*)
                                    (vecreg.c:53)</div>
                                  <div>==8404==    by 0x614EA3:
                                    VecCreate_Standard (pbvec.c:264)</div>
                                  <div>==8404==    by 0x5B36DC:
                                    VecSetType(_p_Vec*, char const*)
                                    (vecreg.c:53)</div>
                                  <div>==8404==    by 0x703809:
                                    MatGetVecs(_p_Mat*, _p_Vec**,
                                    _p_Vec**) (matrix.c:8149)</div>
                                  <div>==8404==    by 0xAFDB5E:
                                    PCSetUp_HYPRE(_p_PC*) (hypre.c:104)</div>
                                  <div>==8404== </div>
                                  <div>==8404== Conditional jump or move
                                    depends on uninitialised value(s)</div>
                                  <div>==8404==    at 0x74AD755:
                                    _int_free (mvapich_malloc.c:4400)</div>
                                  <div>==8404==    by 0x74AEAA8:
                                    _int_malloc (mvapich_malloc.c:4332)</div>
                                  <div>==8404==    by 0x74AEE8D: malloc
                                    (mvapich_malloc.c:3409)</div>
                                  <div>==8404==    by 0x74AFB0F:
                                    memalign (mvapich_malloc.c:3626)</div>
                                  <div>==8404==    by 0x494BF3:
                                    PetscMallocAlign(unsigned long, int,
                                    char const*, char const*, char
                                    const*, void**) (mal.c:30)</div>
                                  <div>==8404==    by 0x496DFD:
                                    PetscTrMallocDefault(unsigned long,
                                    int, char const*, char const*, char
                                    const*, void**) (mtr.c:190)</div>
                                  <div>==8404==    by 0x5FA4BA:
                                    VecCreate_Seq (bvec3.c:40)</div>
                                  <div>==8404==    by 0x5B36DC:
                                    VecSetType(_p_Vec*, char const*)
                                    (vecreg.c:53)</div>
                                  <div>==8404==    by 0x614EA3:
                                    VecCreate_Standard (pbvec.c:264)</div>
                                  <div>==8404==    by 0x5B36DC:
                                    VecSetType(_p_Vec*, char const*)
                                    (vecreg.c:53)</div>
                                  <div>==8404==    by 0x703809:
                                    MatGetVecs(_p_Mat*, _p_Vec**,
                                    _p_Vec**) (matrix.c:8149)</div>
                                  <div>==8404==    by 0xAFDB5E:
                                    PCSetUp_HYPRE(_p_PC*) (hypre.c:104)</div>
                                  <div>==8404== </div>
                                  <div>==8404== Use of uninitialised
                                    value of size 8</div>
                                  <div>==8404==    at 0x74AD75B:
                                    _int_free (mvapich_malloc.c:4402)</div>
                                  <div>==8404==    by 0x74AEAA8:
                                    _int_malloc (mvapich_malloc.c:4332)</div>
                                  <div>==8404==    by 0x74AEE8D: malloc
                                    (mvapich_malloc.c:3409)</div>
                                  <div>==8404==    by 0x74AFB0F:
                                    memalign (mvapich_malloc.c:3626)</div>
                                  <div>==8404==    by 0x494BF3:
                                    PetscMallocAlign(unsigned long, int,
                                    char const*, char const*, char
                                    const*, void**) (mal.c:30)</div>
                                  <div>==8404==    by 0x496DFD:
                                    PetscTrMallocDefault(unsigned long,
                                    int, char const*, char const*, char
                                    const*, void**) (mtr.c:190)</div>
                                  <div>==8404==    by 0x5FA4BA:
                                    VecCreate_Seq (bvec3.c:40)</div>
                                  <div>==8404==    by 0x5B36DC:
                                    VecSetType(_p_Vec*, char const*)
                                    (vecreg.c:53)</div>
                                  <div>==8404==    by 0x614EA3:
                                    VecCreate_Standard (pbvec.c:264)</div>
                                  <div>==8404==    by 0x5B36DC:
                                    VecSetType(_p_Vec*, char const*)
                                    (vecreg.c:53)</div>
                                  <div>==8404==    by 0x703809:
                                    MatGetVecs(_p_Mat*, _p_Vec**,
                                    _p_Vec**) (matrix.c:8149)</div>
                                  <div>==8404==    by 0xAFDB5E:
                                    PCSetUp_HYPRE(_p_PC*) (hypre.c:104)</div>
                                  <div>==8404== </div>
                                  <div>==8404== Use of uninitialised
                                    value of size 8</div>
                                  <div>==8404==    at 0x74AD77E:
                                    _int_free (mvapich_malloc.c:4409)</div>
                                  <div>==8404==    by 0x74AEAA8:
                                    _int_malloc (mvapich_malloc.c:4332)</div>
                                  <div>==8404==    by 0x74AEE8D: malloc
                                    (mvapich_malloc.c:3409)</div>
                                  <div>==8404==    by 0x74AFB0F:
                                    memalign (mvapich_malloc.c:3626)</div>
                                  <div>==8404==    by 0x494BF3:
                                    PetscMallocAlign(unsigned long, int,
                                    char const*, char const*, char
                                    const*, void**) (mal.c:30)</div>
                                  <div>==8404==    by 0x496DFD:
                                    PetscTrMallocDefault(unsigned long,
                                    int, char const*, char const*, char
                                    const*, void**) (mtr.c:190)</div>
                                  <div>==8404==    by 0x5FA4BA:
                                    VecCreate_Seq (bvec3.c:40)</div>
                                  <div>==8404==    by 0x5B36DC:
                                    VecSetType(_p_Vec*, char const*)
                                    (vecreg.c:53)</div>
                                  <div>==8404==    by 0x614EA3:
                                    VecCreate_Standard (pbvec.c:264)</div>
                                  <div>==8404==    by 0x5B36DC:
                                    VecSetType(_p_Vec*, char const*)
                                    (vecreg.c:53)</div>
                                  <div>==8404==    by 0x703809:
                                    MatGetVecs(_p_Mat*, _p_Vec**,
                                    _p_Vec**) (matrix.c:8149)</div>
                                  <div>==8404==    by 0xAFDB5E:
                                    PCSetUp_HYPRE(_p_PC*) (hypre.c:104)</div>
                                  <div>==8404== </div>
                                  <div>==8404== Use of uninitialised
                                    value of size 8</div>
                                  <div>==8404==    at 0x74AD7A9:
                                    _int_free (mvapich_malloc.c:4425)</div>
                                  <div>==8404==    by 0x74AEAA8:
                                    _int_malloc (mvapich_malloc.c:4332)</div>
                                  <div>==8404==    by 0x74AEE8D: malloc
                                    (mvapich_malloc.c:3409)</div>
                                  <div>==8404==    by 0x74AFB0F:
                                    memalign (mvapich_malloc.c:3626)</div>
                                  <div>==8404==    by 0x494BF3:
                                    PetscMallocAlign(unsigned long, int,
                                    char const*, char const*, char
                                    const*, void**) (mal.c:30)</div>
                                  <div>==8404==    by 0x496DFD:
                                    PetscTrMallocDefault(unsigned long,
                                    int, char const*, char const*, char
                                    const*, void**) (mtr.c:190)</div>
                                  <div>==8404==    by 0x5FA4BA:
                                    VecCreate_Seq (bvec3.c:40)</div>
                                  <div>==8404==    by 0x5B36DC:
                                    VecSetType(_p_Vec*, char const*)
                                    (vecreg.c:53)</div>
                                  <div>==8404==    by 0x614EA3:
                                    VecCreate_Standard (pbvec.c:264)</div>
                                  <div>==8404==    by 0x5B36DC:
                                    VecSetType(_p_Vec*, char const*)
                                    (vecreg.c:53)</div>
                                  <div>==8404==    by 0x703809:
                                    MatGetVecs(_p_Mat*, _p_Vec**,
                                    _p_Vec**) (matrix.c:8149)</div>
                                  <div>==8404==    by 0xAFDB5E:
                                    PCSetUp_HYPRE(_p_PC*) (hypre.c:104)</div>
                                  <div>==8404== </div>
                                  <div>==8404== Conditional jump or move
                                    depends on uninitialised value(s)</div>
                                  <div>==8404==    at 0x74AD7B4:
                                    _int_free (mvapich_malloc.c:4455)</div>
                                  <div>==8404==    by 0x74AEAA8:
                                    _int_malloc (mvapich_malloc.c:4332)</div>
                                  <div>==8404==    by 0x74AEE8D: malloc
                                    (mvapich_malloc.c:3409)</div>
                                  <div>==8404==    by 0x74AFB0F:
                                    memalign (mvapich_malloc.c:3626)</div>
                                  <div>==8404==    by 0x494BF3:
                                    PetscMallocAlign(unsigned long, int,
                                    char const*, char const*, char
                                    const*, void**) (mal.c:30)</div>
                                  <div>==8404==    by 0x496DFD:
                                    PetscTrMallocDefault(unsigned long,
                                    int, char const*, char const*, char
                                    const*, void**) (mtr.c:190)</div>
                                  <div>==8404==    by 0x5FA4BA:
                                    VecCreate_Seq (bvec3.c:40)</div>
                                  <div>==8404==    by 0x5B36DC:
                                    VecSetType(_p_Vec*, char const*)
                                    (vecreg.c:53)</div>
                                  <div>==8404==    by 0x614EA3:
                                    VecCreate_Standard (pbvec.c:264)</div>
                                  <div>==8404==    by 0x5B36DC:
                                    VecSetType(_p_Vec*, char const*)
                                    (vecreg.c:53)</div>
                                  <div>==8404==    by 0x703809:
                                    MatGetVecs(_p_Mat*, _p_Vec**,
                                    _p_Vec**) (matrix.c:8149)</div>
                                  <div>==8404==    by 0xAFDB5E:
                                    PCSetUp_HYPRE(_p_PC*) (hypre.c:104)</div>
                                  <div>==8404== </div>
                                  <div>==8404== Conditional jump or move
                                    depends on uninitialised value(s)</div>
                                  <div>==8404==    at 0x74ADDAE:
                                    _int_malloc (mvapich_malloc.c:4116)</div>
                                  <div>==8404==    by 0x74AEE8D: malloc
                                    (mvapich_malloc.c:3409)</div>
                                  <div>==8404==    by 0x74AFB0F:
                                    memalign (mvapich_malloc.c:3626)</div>
                                  <div>==8404==    by 0x494BF3:
                                    PetscMallocAlign(unsigned long, int,
                                    char const*, char const*, char
                                    const*, void**) (mal.c:30)</div>
                                  <div>==8404==    by 0x496DFD:
                                    PetscTrMallocDefault(unsigned long,
                                    int, char const*, char const*, char
                                    const*, void**) (mtr.c:190)</div>
                                  <div>==8404==    by 0x5E9616:
                                    VecCreate_Seq_Private(_p_Vec*,
                                    double const*) (bvec2.c:887)</div>
                                  <div>==8404==    by 0x5FA62A:
                                    VecCreate_Seq (bvec3.c:42)</div>
                                  <div>==8404==    by 0x5B36DC:
                                    VecSetType(_p_Vec*, char const*)
                                    (vecreg.c:53)</div>
                                  <div>==8404==    by 0x614EA3:
                                    VecCreate_Standard (pbvec.c:264)</div>
                                  <div>==8404==    by 0x5B36DC:
                                    VecSetType(_p_Vec*, char const*)
                                    (vecreg.c:53)</div>
                                  <div>==8404==    by 0x703809:
                                    MatGetVecs(_p_Mat*, _p_Vec**,
                                    _p_Vec**) (matrix.c:8149)</div>
                                  <div>==8404==    by 0xAFDB5E:
                                    PCSetUp_HYPRE(_p_PC*) (hypre.c:104)</div>
                                  <div>==8404== </div>
                                  <div>==8404== Conditional jump or move
                                    depends on uninitialised value(s)</div>
                                  <div>==8404==    at 0x74ADDD9:
                                    _int_malloc (mvapich_malloc.c:4122)</div>
                                  <div>==8404==    by 0x74AEE8D: malloc
                                    (mvapich_malloc.c:3409)</div>
                                  <div>==8404==    by 0x74AFB0F:
                                    memalign (mvapich_malloc.c:3626)</div>
                                  <div>==8404==    by 0x494BF3:
                                    PetscMallocAlign(unsigned long, int,
                                    char const*, char const*, char
                                    const*, void**) (mal.c:30)</div>
                                  <div>==8404==    by 0x496DFD:
                                    PetscTrMallocDefault(unsigned long,
                                    int, char const*, char const*, char
                                    const*, void**) (mtr.c:190)</div>
                                  <div>==8404==    by 0x5E9616:
                                    VecCreate_Seq_Private(_p_Vec*,
                                    double const*) (bvec2.c:887)</div>
                                  <div>==8404==    by 0x5FA62A:
                                    VecCreate_Seq (bvec3.c:42)</div>
                                  <div>==8404==    by 0x5B36DC:
                                    VecSetType(_p_Vec*, char const*)
                                    (vecreg.c:53)</div>
                                  <div>==8404==    by 0x614EA3:
                                    VecCreate_Standard (pbvec.c:264)</div>
                                  <div>==8404==    by 0x5B36DC:
                                    VecSetType(_p_Vec*, char const*)
                                    (vecreg.c:53)</div>
                                  <div>==8404==    by 0x703809:
                                    MatGetVecs(_p_Mat*, _p_Vec**,
                                    _p_Vec**) (matrix.c:8149)</div>
                                  <div>==8404==    by 0xAFDB5E:
                                    PCSetUp_HYPRE(_p_PC*) (hypre.c:104)</div>
                                  <div>==8404== </div>
                                  <div>==8404== Conditional jump or move
                                    depends on uninitialised value(s)</div>
                                  <div>==8404==    at 0x74ADDEC:
                                    _int_malloc (mvapich_malloc.c:4122)</div>
                                  <div>==8404==    by 0x74AEE8D: malloc
                                    (mvapich_malloc.c:3409)</div>
                                  <div>==8404==    by 0x74AFB0F:
                                    memalign (mvapich_malloc.c:3626)</div>
                                  <div>==8404==    by 0x494BF3:
                                    PetscMallocAlign(unsigned long, int,
                                    char const*, char const*, char
                                    const*, void**) (mal.c:30)</div>
                                  <div>==8404==    by 0x496DFD:
                                    PetscTrMallocDefault(unsigned long,
                                    int, char const*, char const*, char
                                    const*, void**) (mtr.c:190)</div>
                                  <div>==8404==    by 0x5E9616:
                                    VecCreate_Seq_Private(_p_Vec*,
                                    double const*) (bvec2.c:887)</div>
                                  <div>==8404==    by 0x5FA62A:
                                    VecCreate_Seq (bvec3.c:42)</div>
                                  <div>==8404==    by 0x5B36DC:
                                    VecSetType(_p_Vec*, char const*)
                                    (vecreg.c:53)</div>
                                  <div>==8404==    by 0x614EA3:
                                    VecCreate_Standard (pbvec.c:264)</div>
                                  <div>==8404==    by 0x5B36DC:
                                    VecSetType(_p_Vec*, char const*)
                                    (vecreg.c:53)</div>
                                  <div>==8404==    by 0x703809:
                                    MatGetVecs(_p_Mat*, _p_Vec**,
                                    _p_Vec**) (matrix.c:8149)</div>
                                  <div>==8404==    by 0xAFDB5E:
                                    PCSetUp_HYPRE(_p_PC*) (hypre.c:104)</div>
                                  <div>==8404== </div>
                                  <div>==8404== Conditional jump or move
                                    depends on uninitialised value(s)</div>
                                  <div>==8404==    at 0x74ADDFF:
                                    _int_malloc (mvapich_malloc.c:4122)</div>
                                  <div>==8404==    by 0x74AEE8D: malloc
                                    (mvapich_malloc.c:3409)</div>
                                  <div>==8404==    by 0x74AFB0F:
                                    memalign (mvapich_malloc.c:3626)</div>
                                  <div>==8404==    by 0x494BF3:
                                    PetscMallocAlign(unsigned long, int,
                                    char const*, char const*, char
                                    const*, void**) (mal.c:30)</div>
                                  <div>==8404==    by 0x496DFD:
                                    PetscTrMallocDefault(unsigned long,
                                    int, char const*, char const*, char
                                    const*, void**) (mtr.c:190)</div>
                                  <div>==8404==    by 0x5E9616:
                                    VecCreate_Seq_Private(_p_Vec*,
                                    double const*) (bvec2.c:887)</div>
                                  <div>==8404==    by 0x5FA62A:
                                    VecCreate_Seq (bvec3.c:42)</div>
                                  <div>==8404==    by 0x5B36DC:
                                    VecSetType(_p_Vec*, char const*)
                                    (vecreg.c:53)</div>
                                  <div>==8404==    by 0x614EA3:
                                    VecCreate_Standard (pbvec.c:264)</div>
                                  <div>==8404==    by 0x5B36DC:
                                    VecSetType(_p_Vec*, char const*)
                                    (vecreg.c:53)</div>
                                  <div>==8404==    by 0x703809:
                                    MatGetVecs(_p_Mat*, _p_Vec**,
                                    _p_Vec**) (matrix.c:8149)</div>
                                  <div>==8404==    by 0xAFDB5E:
                                    PCSetUp_HYPRE(_p_PC*) (hypre.c:104)</div>
                                  <div>==8404== </div>
                                  <div>==8404== Use of uninitialised
                                    value of size 8</div>
                                  <div>==8404==    at 0x74ADE42:
                                    _int_malloc (mvapich_malloc.c:4124)</div>
                                  <div>==8404==    by 0x74AEE8D: malloc
                                    (mvapich_malloc.c:3409)</div>
                                  <div>==8404==    by 0x74AFB0F:
                                    memalign (mvapich_malloc.c:3626)</div>
                                  <div>==8404==    by 0x494BF3:
                                    PetscMallocAlign(unsigned long, int,
                                    char const*, char const*, char
                                    const*, void**) (mal.c:30)</div>
                                  <div>==8404==    by 0x496DFD:
                                    PetscTrMallocDefault(unsigned long,
                                    int, char const*, char const*, char
                                    const*, void**) (mtr.c:190)</div>
                                  <div>==8404==    by 0x5E9616:
                                    VecCreate_Seq_Private(_p_Vec*,
                                    double const*) (bvec2.c:887)</div>
                                  <div>==8404==    by 0x5FA62A:
                                    VecCreate_Seq (bvec3.c:42)</div>
                                  <div>==8404==    by 0x5B36DC:
                                    VecSetType(_p_Vec*, char const*)
                                    (vecreg.c:53)</div>
                                  <div>==8404==    by 0x614EA3:
                                    VecCreate_Standard (pbvec.c:264)</div>
                                  <div>==8404==    by 0x5B36DC:
                                    VecSetType(_p_Vec*, char const*)
                                    (vecreg.c:53)</div>
                                  <div>==8404==    by 0x703809:
                                    MatGetVecs(_p_Mat*, _p_Vec**,
                                    _p_Vec**) (matrix.c:8149)</div>
                                  <div>==8404==    by 0xAFDB5E:
                                    PCSetUp_HYPRE(_p_PC*) (hypre.c:104)</div>
                                  <div>==8404== </div>
                                  <div>==8404== Conditional jump or move
                                    depends on uninitialised value(s)</div>
                                  <div>==8404==    at 0x74ADE4C:
                                    _int_malloc (mvapich_malloc.c:4126)</div>
                                  <div>==8404==    by 0x74AEE8D: malloc
                                    (mvapich_malloc.c:3409)</div>
                                  <div>==8404==    by 0x74AFB0F:
                                    memalign (mvapich_malloc.c:3626)</div>
                                  <div>==8404==    by 0x494BF3:
                                    PetscMallocAlign(unsigned long, int,
                                    char const*, char const*, char
                                    const*, void**) (mal.c:30)</div>
                                  <div>==8404==    by 0x496DFD:
                                    PetscTrMallocDefault(unsigned long,
                                    int, char const*, char const*, char
                                    const*, void**) (mtr.c:190)</div>
                                  <div>==8404==    by 0x5E9616:
                                    VecCreate_Seq_Private(_p_Vec*,
                                    double const*) (bvec2.c:887)</div>
                                  <div>==8404==    by 0x5FA62A:
                                    VecCreate_Seq (bvec3.c:42)</div>
                                  <div>==8404==    by 0x5B36DC:
                                    VecSetType(_p_Vec*, char const*)
                                    (vecreg.c:53)</div>
                                  <div>==8404==    by 0x614EA3:
                                    VecCreate_Standard (pbvec.c:264)</div>
                                  <div>==8404==    by 0x5B36DC:
                                    VecSetType(_p_Vec*, char const*)
                                    (vecreg.c:53)</div>
                                  <div>==8404==    by 0x703809:
                                    MatGetVecs(_p_Mat*, _p_Vec**,
                                    _p_Vec**) (matrix.c:8149)</div>
                                  <div>==8404==    by 0xAFDB5E:
                                    PCSetUp_HYPRE(_p_PC*) (hypre.c:104)</div>
                                  <div>==8404== </div>
                                  <div>==8404== Use of uninitialised
                                    value of size 8</div>
                                  <div>==8404==    at 0x74ADE88:
                                    _int_malloc (mvapich_malloc.c:4148)</div>
                                  <div>==8404==    by 0x74AEE8D: malloc
                                    (mvapich_malloc.c:3409)</div>
                                  <div>==8404==    by 0x74AFB0F:
                                    memalign (mvapich_malloc.c:3626)</div>
                                  <div>==8404==    by 0x494BF3:
                                    PetscMallocAlign(unsigned long, int,
                                    char const*, char const*, char
                                    const*, void**) (mal.c:30)</div>
                                  <div>==8404==    by 0x496DFD:
                                    PetscTrMallocDefault(unsigned long,
                                    int, char const*, char const*, char
                                    const*, void**) (mtr.c:190)</div>
                                  <div>==8404==    by 0x5E9616:
                                    VecCreate_Seq_Private(_p_Vec*,
                                    double const*) (bvec2.c:887)</div>
                                  <div>==8404==    by 0x5FA62A:
                                    VecCreate_Seq (bvec3.c:42)</div>
                                  <div>==8404==    by 0x5B36DC:
                                    VecSetType(_p_Vec*, char const*)
                                    (vecreg.c:53)</div>
                                  <div>==8404==    by 0x614EA3:
                                    VecCreate_Standard (pbvec.c:264)</div>
                                  <div>==8404==    by 0x5B36DC:
                                    VecSetType(_p_Vec*, char const*)
                                    (vecreg.c:53)</div>
                                  <div>==8404==    by 0x703809:
                                    MatGetVecs(_p_Mat*, _p_Vec**,
                                    _p_Vec**) (matrix.c:8149)</div>
                                  <div>==8404==    by 0xAFDB5E:
                                    PCSetUp_HYPRE(_p_PC*) (hypre.c:104)</div>
                                  <div>==8404== </div>
                                  <div>==8404== Use of uninitialised
                                    value of size 8</div>
                                  <div>==8404==    at 0x74ADE9C:
                                    _int_malloc (mvapich_malloc.c:4152)</div>
                                  <div>==8404==    by 0x74AEE8D: malloc
                                    (mvapich_malloc.c:3409)</div>
                                  <div>==8404==    by 0x74AFB0F:
                                    memalign (mvapich_malloc.c:3626)</div>
                                  <div>==8404==    by 0x494BF3:
                                    PetscMallocAlign(unsigned long, int,
                                    char const*, char const*, char
                                    const*, void**) (mal.c:30)</div>
                                  <div>==8404==    by 0x496DFD:
                                    PetscTrMallocDefault(unsigned long,
                                    int, char const*, char const*, char
                                    const*, void**) (mtr.c:190)</div>
                                  <div>==8404==    by 0x5E9616:
                                    VecCreate_Seq_Private(_p_Vec*,
                                    double const*) (bvec2.c:887)</div>
                                  <div>==8404==    by 0x5FA62A:
                                    VecCreate_Seq (bvec3.c:42)</div>
                                  <div>==8404==    by 0x5B36DC:
                                    VecSetType(_p_Vec*, char const*)
                                    (vecreg.c:53)</div>
                                  <div>==8404==    by 0x614EA3:
                                    VecCreate_Standard (pbvec.c:264)</div>
                                  <div>==8404==    by 0x5B36DC:
                                    VecSetType(_p_Vec*, char const*)
                                    (vecreg.c:53)</div>
                                  <div>==8404==    by 0x703809:
                                    MatGetVecs(_p_Mat*, _p_Vec**,
                                    _p_Vec**) (matrix.c:8149)</div>
                                  <div>==8404==    by 0xAFDB5E:
                                    PCSetUp_HYPRE(_p_PC*) (hypre.c:104)</div>
                                  <div>==8404== </div>
                                  <div>==8404== Conditional jump or move
                                    depends on uninitialised value(s)</div>
                                  <div>==8404==    at 0x74ADF56:
                                    _int_malloc (mvapich_malloc.c:4220)</div>
                                  <div>==8404==    by 0x74AEE8D: malloc
                                    (mvapich_malloc.c:3409)</div>
                                  <div>==8404==    by 0x74AFB0F:
                                    memalign (mvapich_malloc.c:3626)</div>
                                  <div>==8404==    by 0x494BF3:
                                    PetscMallocAlign(unsigned long, int,
                                    char const*, char const*, char
                                    const*, void**) (mal.c:30)</div>
                                  <div>==8404==    by 0x496DFD:
                                    PetscTrMallocDefault(unsigned long,
                                    int, char const*, char const*, char
                                    const*, void**) (mtr.c:190)</div>
                                  <div>==8404==    by 0x5E9616:
                                    VecCreate_Seq_Private(_p_Vec*,
                                    double const*) (bvec2.c:887)</div>
                                  <div>==8404==    by 0x5FA62A:
                                    VecCreate_Seq (bvec3.c:42)</div>
                                  <div>==8404==    by 0x5B36DC:
                                    VecSetType(_p_Vec*, char const*)
                                    (vecreg.c:53)</div>
                                  <div>==8404==    by 0x614EA3:
                                    VecCreate_Standard (pbvec.c:264)</div>
                                  <div>==8404==    by 0x5B36DC:
                                    VecSetType(_p_Vec*, char const*)
                                    (vecreg.c:53)</div>
                                  <div>==8404==    by 0x703809:
                                    MatGetVecs(_p_Mat*, _p_Vec**,
                                    _p_Vec**) (matrix.c:8149)</div>
                                  <div>==8404==    by 0xAFDB5E:
                                    PCSetUp_HYPRE(_p_PC*) (hypre.c:104)</div>
                                  <div>==8404== </div>
                                  <div>==8404== Conditional jump or move
                                    depends on uninitialised value(s)</div>
                                  <div>==8404==    at 0x74ADF72:
                                    _int_malloc (mvapich_malloc.c:4227)</div>
                                  <div>==8404==    by 0x74AEE8D: malloc
                                    (mvapich_malloc.c:3409)</div>
                                  <div>==8404==    by 0x74AFB0F:
                                    memalign (mvapich_malloc.c:3626)</div>
                                  <div>==8404==    by 0x494BF3:
                                    PetscMallocAlign(unsigned long, int,
                                    char const*, char const*, char
                                    const*, void**) (mal.c:30)</div>
                                  <div>==8404==    by 0x496DFD:
                                    PetscTrMallocDefault(unsigned long,
                                    int, char const*, char const*, char
                                    const*, void**) (mtr.c:190)</div>
                                  <div>==8404==    by 0x5E9616:
                                    VecCreate_Seq_Private(_p_Vec*,
                                    double const*) (bvec2.c:887)</div>
                                  <div>==8404==    by 0x5FA62A:
                                    VecCreate_Seq (bvec3.c:42)</div>
                                  <div>==8404==    by 0x5B36DC:
                                    VecSetType(_p_Vec*, char const*)
                                    (vecreg.c:53)</div>
                                  <div>==8404==    by 0x614EA3:
                                    VecCreate_Standard (pbvec.c:264)</div>
                                  <div>==8404==    by 0x5B36DC:
                                    VecSetType(_p_Vec*, char const*)
                                    (vecreg.c:53)</div>
                                  <div>==8404==    by 0x703809:
                                    MatGetVecs(_p_Mat*, _p_Vec**,
                                    _p_Vec**) (matrix.c:8149)</div>
                                  <div>==8404==    by 0xAFDB5E:
                                    PCSetUp_HYPRE(_p_PC*) (hypre.c:104)</div>
                                  <div>==8404== </div>
                                  <div>==8404== Conditional jump or move
                                    depends on uninitialised value(s)</div>
                                  <div>==8404==    at 0x74ADF7E:
                                    _int_malloc (mvapich_malloc.c:4227)</div>
                                  <div>==8404==    by 0x74AEE8D: malloc
                                    (mvapich_malloc.c:3409)</div>
                                  <div>==8404==    by 0x74AFB0F:
                                    memalign (mvapich_malloc.c:3626)</div>
                                  <div>==8404==    by 0x494BF3:
                                    PetscMallocAlign(unsigned long, int,
                                    char const*, char const*, char
                                    const*, void**) (mal.c:30)</div>
                                  <div>==8404==    by 0x496DFD:
                                    PetscTrMallocDefault(unsigned long,
                                    int, char const*, char const*, char
                                    const*, void**) (mtr.c:190)</div>
                                  <div>==8404==    by 0x5E9616:
                                    VecCreate_Seq_Private(_p_Vec*,
                                    double const*) (bvec2.c:887)</div>
                                  <div>==8404==    by 0x5FA62A:
                                    VecCreate_Seq (bvec3.c:42)</div>
                                  <div>==8404==    by 0x5B36DC:
                                    VecSetType(_p_Vec*, char const*)
                                    (vecreg.c:53)</div>
                                  <div>==8404==    by 0x614EA3:
                                    VecCreate_Standard (pbvec.c:264)</div>
                                  <div>==8404==    by 0x5B36DC:
                                    VecSetType(_p_Vec*, char const*)
                                    (vecreg.c:53)</div>
                                  <div>==8404==    by 0x703809:
                                    MatGetVecs(_p_Mat*, _p_Vec**,
                                    _p_Vec**) (matrix.c:8149)</div>
                                  <div>==8404==    by 0xAFDB5E:
                                    PCSetUp_HYPRE(_p_PC*) (hypre.c:104)</div>
                                  <div>==8404== </div>
                                  <div>==8404== Conditional jump or move
                                    depends on uninitialised value(s)</div>
                                  <div>==8404==    at 0x74ADED9:
                                    _int_malloc (mvapich_malloc.c:4168)</div>
                                  <div>==8404==    by 0x74B2189: calloc
                                    (mvapich_malloc.c:3765)</div>
                                  <div>==8404==    by 0x1623FF2:
                                    hypre_CAlloc (hypre_memory.c:121)</div>
                                  <div>==8404==    by 0x15B62C5:
                                    hypre_SeqVectorInitialize
                                    (vector.c:94)</div>
                                  <div>==8404==    by 0x158CF25:
                                    hypre_ParVectorInitialize
                                    (par_vector.c:150)</div>
                                  <div>==8404==    by 0x14E0E57:
                                    hypre_IJVectorInitializePar
                                    (IJVector_parcsr.c:124)</div>
                                  <div>==8404==    by 0x14DA2B9:
                                    HYPRE_IJVectorInitialize
                                    (HYPRE_IJVector.c:229)</div>
                                  <div>==8404==    by 0xE77A78:
                                    VecHYPRE_IJVectorCreate(_p_Vec*,
                                    hypre_IJVector_struct**) (vhyp.c:21)</div>
                                  <div>==8404==    by 0xAFDC0C:
                                    PCSetUp_HYPRE(_p_PC*) (hypre.c:105)</div>
                                  <div>==8404==    by 0x12293CE:
                                    PCSetUp(_p_PC*) (precon.c:832)</div>
                                  <div>==8404==    by 0xC1D524:
                                    KSPSetUp(_p_KSP*) (itfunc.c:278)</div>
                                  <div>==8404==    by 0xC1EFD9:
                                    KSPSolve(_p_KSP*, _p_Vec*, _p_Vec*)
                                    (itfunc.c:402)</div>
                                  <div>==8404== </div>
                                  <div>==8404== Conditional jump or move
                                    depends on uninitialised value(s)</div>
                                  <div>==8404==    at 0x74ADEE6:
                                    _int_malloc (mvapich_malloc.c:4165)</div>
                                  <div>==8404==    by 0x74B2189: calloc
                                    (mvapich_malloc.c:3765)</div>
                                  <div>==8404==    by 0x1623FF2:
                                    hypre_CAlloc (hypre_memory.c:121)</div>
                                  <div>==8404==    by 0x15B62C5:
                                    hypre_SeqVectorInitialize
                                    (vector.c:94)</div>
                                  <div>==8404==    by 0x158CF25:
                                    hypre_ParVectorInitialize
                                    (par_vector.c:150)</div>
                                  <div>==8404==    by 0x14E0E57:
                                    hypre_IJVectorInitializePar
                                    (IJVector_parcsr.c:124)</div>
                                  <div>==8404==    by 0x14DA2B9:
                                    HYPRE_IJVectorInitialize
                                    (HYPRE_IJVector.c:229)</div>
                                  <div>==8404==    by 0xE77A78:
                                    VecHYPRE_IJVectorCreate(_p_Vec*,
                                    hypre_IJVector_struct**) (vhyp.c:21)</div>
                                  <div>==8404==    by 0xAFDC0C:
                                    PCSetUp_HYPRE(_p_PC*) (hypre.c:105)</div>
                                  <div>==8404==    by 0x12293CE:
                                    PCSetUp(_p_PC*) (precon.c:832)</div>
                                  <div>==8404==    by 0xC1D524:
                                    KSPSetUp(_p_KSP*) (itfunc.c:278)</div>
                                  <div>==8404==    by 0xC1EFD9:
                                    KSPSolve(_p_KSP*, _p_Vec*, _p_Vec*)
                                    (itfunc.c:402)</div>
                                  <div>==8404== </div>
                                  <div>==8404== Conditional jump or move
                                    depends on uninitialised value(s)</div>
                                  <div>==8404==    at 0x74ADF31:
                                    _int_malloc (mvapich_malloc.c:4216)</div>
                                  <div>==8404==    by 0x74B2189: calloc
                                    (mvapich_malloc.c:3765)</div>
                                  <div>==8404==    by 0x1623FF2:
                                    hypre_CAlloc (hypre_memory.c:121)</div>
                                  <div>==8404==    by 0x15B62C5:
                                    hypre_SeqVectorInitialize
                                    (vector.c:94)</div>
                                  <div>==8404==    by 0x158CF25:
                                    hypre_ParVectorInitialize
                                    (par_vector.c:150)</div>
                                  <div>==8404==    by 0x14E0E57:
                                    hypre_IJVectorInitializePar
                                    (IJVector_parcsr.c:124)</div>
                                  <div>==8404==    by 0x14DA2B9:
                                    HYPRE_IJVectorInitialize
                                    (HYPRE_IJVector.c:229)</div>
                                  <div>==8404==    by 0xE77A78:
                                    VecHYPRE_IJVectorCreate(_p_Vec*,
                                    hypre_IJVector_struct**) (vhyp.c:21)</div>
                                  <div>==8404==    by 0xAFDC0C:
                                    PCSetUp_HYPRE(_p_PC*) (hypre.c:105)</div>
                                  <div>==8404==    by 0x12293CE:
                                    PCSetUp(_p_PC*) (precon.c:832)</div>
                                  <div>==8404==    by 0xC1D524:
                                    KSPSetUp(_p_KSP*) (itfunc.c:278)</div>
                                  <div>==8404==    by 0xC1EFD9:
                                    KSPSolve(_p_KSP*, _p_Vec*, _p_Vec*)
                                    (itfunc.c:402)</div>
                                  <div>==8404== </div>
                                  <div>==8404== Use of uninitialised
                                    value of size 8</div>
                                  <div>==8404==    at 0x74AD75B:
                                    _int_free (mvapich_malloc.c:4402)</div>
                                  <div>==8404==    by 0x74AF651: free
                                    (mvapich_malloc.c:3497)</div>
                                  <div>==8404==    by 0x494CCA:
                                    PetscFreeAlign(void*, int, char
                                    const*, char const*, char const*)
                                    (mal.c:75)</div>
                                  <div>==8404==    by 0x497F91:
                                    PetscTrFreeDefault(void*, int, char
                                    const*, char const*, char const*)
                                    (mtr.c:322)</div>
                                  <div>==8404==    by 0x5E866E:
                                    VecDestroy_Seq(_p_Vec*)
                                    (bvec2.c:777)</div>
                                  <div>==8404==    by 0x59F7CD:
                                    VecDestroy(_p_Vec**) (vector.c:580)</div>
                                  <div>==8404==    by 0xAFDD5D:
                                    PCSetUp_HYPRE(_p_PC*) (hypre.c:107)</div>
                                  <div>==8404==    by 0x12293CE:
                                    PCSetUp(_p_PC*) (precon.c:832)</div>
                                  <div>==8404==    by 0xC1D524:
                                    KSPSetUp(_p_KSP*) (itfunc.c:278)</div>
                                  <div>==8404==    by 0xC1EFD9:
                                    KSPSolve(_p_KSP*, _p_Vec*, _p_Vec*)
                                    (itfunc.c:402)</div>
                                  <div>==8404==    by 0x46C59F:
                                    PetscLinearSolver::solve(ArrayV<double>&,
                                    PetscBool)
                                    (petscLinearSolver.cpp:402)</div>
                                  <div>==8404==    by 0x472A92:
                                    amr2D::fvm::pbSolver::SolveNonLinearPB(double,
                                    int) (pbSolver_2d_FVM.cpp:148)</div>
                                  <div>==8404== </div>
                                  <div>==8404== Use of uninitialised
                                    value of size 8</div>
                                  <div>==8404==    at 0x74AD775:
                                    _int_free (mvapich_malloc.c:4406)</div>
                                  <div>==8404==    by 0x74AF651: free
                                    (mvapich_malloc.c:3497)</div>
                                  <div>==8404==    by 0x494CCA:
                                    PetscFreeAlign(void*, int, char
                                    const*, char const*, char const*)
                                    (mal.c:75)</div>
                                  <div>==8404==    by 0x497F91:
                                    PetscTrFreeDefault(void*, int, char
                                    const*, char const*, char const*)
                                    (mtr.c:322)</div>
                                  <div>==8404==    by 0x5E866E:
                                    VecDestroy_Seq(_p_Vec*)
                                    (bvec2.c:777)</div>
                                  <div>==8404==    by 0x59F7CD:
                                    VecDestroy(_p_Vec**) (vector.c:580)</div>
                                  <div>==8404==    by 0xAFDD5D:
                                    PCSetUp_HYPRE(_p_PC*) (hypre.c:107)</div>
                                  <div>==8404==    by 0x12293CE:
                                    PCSetUp(_p_PC*) (precon.c:832)</div>
                                  <div>==8404==    by 0xC1D524:
                                    KSPSetUp(_p_KSP*) (itfunc.c:278)</div>
                                  <div>==8404==    by 0xC1EFD9:
                                    KSPSolve(_p_KSP*, _p_Vec*, _p_Vec*)
                                    (itfunc.c:402)</div>
                                  <div>==8404==    by 0x46C59F:
                                    PetscLinearSolver::solve(ArrayV<double>&,
                                    PetscBool)
                                    (petscLinearSolver.cpp:402)</div>
                                  <div>==8404==    by 0x472A92:
                                    amr2D::fvm::pbSolver::SolveNonLinearPB(double,
                                    int) (pbSolver_2d_FVM.cpp:148)</div>
                                  <div>==8404== </div>
                                  <div>==8404== Use of uninitialised
                                    value of size 8</div>
                                  <div>==8404==    at 0x74AD7A9:
                                    _int_free (mvapich_malloc.c:4425)</div>
                                  <div>==8404==    by 0x74AF651: free
                                    (mvapich_malloc.c:3497)</div>
                                  <div>==8404==    by 0x494CCA:
                                    PetscFreeAlign(void*, int, char
                                    const*, char const*, char const*)
                                    (mal.c:75)</div>
                                  <div>==8404==    by 0x497F91:
                                    PetscTrFreeDefault(void*, int, char
                                    const*, char const*, char const*)
                                    (mtr.c:322)</div>
                                  <div>==8404==    by 0x5E866E:
                                    VecDestroy_Seq(_p_Vec*)
                                    (bvec2.c:777)</div>
                                  <div>==8404==    by 0x59F7CD:
                                    VecDestroy(_p_Vec**) (vector.c:580)</div>
                                  <div>==8404==    by 0xAFDD5D:
                                    PCSetUp_HYPRE(_p_PC*) (hypre.c:107)</div>
                                  <div>==8404==    by 0x12293CE:
                                    PCSetUp(_p_PC*) (precon.c:832)</div>
                                  <div>==8404==    by 0xC1D524:
                                    KSPSetUp(_p_KSP*) (itfunc.c:278)</div>
                                  <div>==8404==    by 0xC1EFD9:
                                    KSPSolve(_p_KSP*, _p_Vec*, _p_Vec*)
                                    (itfunc.c:402)</div>
                                  <div>==8404==    by 0x46C59F:
                                    PetscLinearSolver::solve(ArrayV<double>&,
                                    PetscBool)
                                    (petscLinearSolver.cpp:402)</div>
                                  <div>==8404==    by 0x472A92:
                                    amr2D::fvm::pbSolver::SolveNonLinearPB(double,
                                    int) (pbSolver_2d_FVM.cpp:148)</div>
                                  <div>==8404== </div>
                                  <div>==8404== Conditional jump or move
                                    depends on uninitialised value(s)</div>
                                  <div>==8404==    at 0x74ADDA1:
                                    _int_malloc (mvapich_malloc.c:4106)</div>
                                  <div>==8404==    by 0x74B2189: calloc
                                    (mvapich_malloc.c:3765)</div>
                                  <div>==8404==    by 0x1623FF2:
                                    hypre_CAlloc (hypre_memory.c:121)</div>
                                  <div>==8404==    by 0x15B3AA1:
                                    hypre_CSRMatrixInitialize
                                    (csr_matrix.c:91)</div>
                                  <div>==8404==    by 0x158732D:
                                    hypre_ParCSRMatrixInitialize
                                    (par_csr_matrix.c:200)</div>
                                  <div>==8404==    by 0x14DB366:
                                    hypre_IJMatrixInitializeParCSR
                                    (IJMatrix_parcsr.c:272)</div>
                                  <div>==8404==    by 0x14D8D44:
                                    HYPRE_IJMatrixInitialize
                                    (HYPRE_IJMatrix.c:303)</div>
                                  <div>==8404==    by 0x11A7FFF:
                                    MatHYPRE_IJMatrixFastCopy_MPIAIJ(_p_Mat*,
                                    hypre_IJMatrix_struct*) (mhyp.c:211)</div>
                                  <div>==8404==    by 0x11A4BFD:
                                    MatHYPRE_IJMatrixCopy(_p_Mat*,
                                    hypre_IJMatrix_struct*) (mhyp.c:122)</div>
                                  <div>==8404==    by 0xAFE3DC:
                                    PCSetUp_HYPRE(_p_PC*) (hypre.c:118)</div>
                                  <div>==8404==    by 0x12293CE:
                                    PCSetUp(_p_PC*) (precon.c:832)</div>
                                  <div>==8404==    by 0xC1D524:
                                    KSPSetUp(_p_KSP*) (itfunc.c:278)</div>
                                  <div>==8404== </div>
                                  <div>==8404== Conditional jump or move
                                    depends on uninitialised value(s)</div>
                                  <div>==8404==    at 0x74ADDAE:
                                    _int_malloc (mvapich_malloc.c:4116)</div>
                                  <div>==8404==    by 0x74B2189: calloc
                                    (mvapich_malloc.c:3765)</div>
                                  <div>==8404==    by 0x1623FF2:
                                    hypre_CAlloc (hypre_memory.c:121)</div>
                                  <div>==8404==    by 0x15B3AA1:
                                    hypre_CSRMatrixInitialize
                                    (csr_matrix.c:91)</div>
                                  <div>
                                    ==8404==    by 0x158732D:
                                    hypre_ParCSRMatrixInitialize
                                    (par_csr_matrix.c:200)</div>
                                  <div>==8404==    by 0x14DB366:
                                    hypre_IJMatrixInitializeParCSR
                                    (IJMatrix_parcsr.c:272)</div>
                                  <div>==8404==    by 0x14D8D44:
                                    HYPRE_IJMatrixInitialize
                                    (HYPRE_IJMatrix.c:303)</div>
                                  <div>==8404==    by 0x11A7FFF:
                                    MatHYPRE_IJMatrixFastCopy_MPIAIJ(_p_Mat*,
                                    hypre_IJMatrix_struct*) (mhyp.c:211)</div>
                                  <div>==8404==    by 0x11A4BFD:
                                    MatHYPRE_IJMatrixCopy(_p_Mat*,
                                    hypre_IJMatrix_struct*) (mhyp.c:122)</div>
                                  <div>
                                    ==8404==    by 0xAFE3DC:
                                    PCSetUp_HYPRE(_p_PC*) (hypre.c:118)</div>
                                  <div>==8404==    by 0x12293CE:
                                    PCSetUp(_p_PC*) (precon.c:832)</div>
                                  <div>==8404==    by 0xC1D524:
                                    KSPSetUp(_p_KSP*) (itfunc.c:278)</div>
                                  <div>==8404== </div>
                                  <div>==8404== Conditional jump or move
                                    depends on uninitialised value(s)</div>
                                  <div>==8404==    at 0x74ADDD9:
                                    _int_malloc (mvapich_malloc.c:4122)</div>
                                  <div>==8404==    by 0x74B2189: calloc
                                    (mvapich_malloc.c:3765)</div>
                                  <div>
                                    ==8404==    by 0x1623FF2:
                                    hypre_CAlloc (hypre_memory.c:121)</div>
                                  <div>==8404==    by 0x15B3AA1:
                                    hypre_CSRMatrixInitialize
                                    (csr_matrix.c:91)</div>
                                  <div>==8404==    by 0x158732D:
                                    hypre_ParCSRMatrixInitialize
                                    (par_csr_matrix.c:200)</div>
                                  <div>==8404==    by 0x14DB366:
                                    hypre_IJMatrixInitializeParCSR
                                    (IJMatrix_parcsr.c:272)</div>
                                  <div>==8404==    by 0x14D8D44:
                                    HYPRE_IJMatrixInitialize
                                    (HYPRE_IJMatrix.c:303)</div>
                                  <div>==8404==    by 0x11A7FFF:
                                    MatHYPRE_IJMatrixFastCopy_MPIAIJ(_p_Mat*,
                                    hypre_IJMatrix_struct*) (mhyp.c:211)</div>
                                  <div>==8404==    by 0x11A4BFD:
                                    MatHYPRE_IJMatrixCopy(_p_Mat*,
                                    hypre_IJMatrix_struct*) (mhyp.c:122)</div>
                                  <div>==8404==    by 0xAFE3DC:
                                    PCSetUp_HYPRE(_p_PC*) (hypre.c:118)</div>
                                  <div>==8404==    by 0x12293CE:
                                    PCSetUp(_p_PC*) (precon.c:832)</div>
                                  <div>==8404==    by 0xC1D524:
                                    KSPSetUp(_p_KSP*) (itfunc.c:278)</div>
                                  <div>==8404== </div>
                                  <div>==8404== Conditional jump or move
                                    depends on uninitialised value(s)</div>
                                  <div>==8404==    at 0x74ADDEC:
                                    _int_malloc (mvapich_malloc.c:4122)</div>
                                  <div>==8404==    by 0x74B2189: calloc
                                    (mvapich_malloc.c:3765)</div>
                                  <div>==8404==    by 0x1623FF2:
                                    hypre_CAlloc (hypre_memory.c:121)</div>
                                  <div>==8404==    by 0x15B3AA1:
                                    hypre_CSRMatrixInitialize
                                    (csr_matrix.c:91)</div>
                                  <div>
                                    ==8404==    by 0x158732D:
                                    hypre_ParCSRMatrixInitialize
                                    (par_csr_matrix.c:200)</div>
                                  <div>==8404==    by 0x14DB366:
                                    hypre_IJMatrixInitializeParCSR
                                    (IJMatrix_parcsr.c:272)</div>
                                  <div>==8404==    by 0x14D8D44:
                                    HYPRE_IJMatrixInitialize
                                    (HYPRE_IJMatrix.c:303)</div>
                                  <div>==8404==    by 0x11A7FFF:
                                    MatHYPRE_IJMatrixFastCopy_MPIAIJ(_p_Mat*,
                                    hypre_IJMatrix_struct*) (mhyp.c:211)</div>
                                  <div>==8404==    by 0x11A4BFD:
                                    MatHYPRE_IJMatrixCopy(_p_Mat*,
                                    hypre_IJMatrix_struct*) (mhyp.c:122)</div>
                                  <div>
                                    ==8404==    by 0xAFE3DC:
                                    PCSetUp_HYPRE(_p_PC*) (hypre.c:118)</div>
                                  <div>==8404==    by 0x12293CE:
                                    PCSetUp(_p_PC*) (precon.c:832)</div>
                                  <div>==8404==    by 0xC1D524:
                                    KSPSetUp(_p_KSP*) (itfunc.c:278)</div>
                                  <div>==8404== </div>
                                  <div>==8404== Conditional jump or move
                                    depends on uninitialised value(s)</div>
                                  <div>==8404==    at 0x74ADDFF:
                                    _int_malloc (mvapich_malloc.c:4122)</div>
                                  <div>==8404==    by 0x74B2189: calloc
                                    (mvapich_malloc.c:3765)</div>
                                  <div>
                                    ==8404==    by 0x1623FF2:
                                    hypre_CAlloc (hypre_memory.c:121)</div>
                                  <div>==8404==    by 0x15B3AA1:
                                    hypre_CSRMatrixInitialize
                                    (csr_matrix.c:91)</div>
                                  <div>==8404==    by 0x158732D:
                                    hypre_ParCSRMatrixInitialize
                                    (par_csr_matrix.c:200)</div>
                                  <div>==8404==    by 0x14DB366:
                                    hypre_IJMatrixInitializeParCSR
                                    (IJMatrix_parcsr.c:272)</div>
                                  <div>==8404==    by 0x14D8D44:
                                    HYPRE_IJMatrixInitialize
                                    (HYPRE_IJMatrix.c:303)</div>
                                  <div>==8404==    by 0x11A7FFF:
                                    MatHYPRE_IJMatrixFastCopy_MPIAIJ(_p_Mat*,
                                    hypre_IJMatrix_struct*) (mhyp.c:211)</div>
                                  <div>==8404==    by 0x11A4BFD:
                                    MatHYPRE_IJMatrixCopy(_p_Mat*,
                                    hypre_IJMatrix_struct*) (mhyp.c:122)</div>
                                  <div>==8404==    by 0xAFE3DC:
                                    PCSetUp_HYPRE(_p_PC*) (hypre.c:118)</div>
                                  <div>==8404==    by 0x12293CE:
                                    PCSetUp(_p_PC*) (precon.c:832)</div>
                                  <div>==8404==    by 0xC1D524:
                                    KSPSetUp(_p_KSP*) (itfunc.c:278)</div>
                                  <div>==8404== </div>
                                  <div>==8404== Conditional jump or move
                                    depends on uninitialised value(s)</div>
                                  <div>==8404==    at 0x74ADE12:
                                    _int_malloc (mvapich_malloc.c:4122)</div>
                                  <div>==8404==    by 0x74B2189: calloc
                                    (mvapich_malloc.c:3765)</div>
                                  <div>==8404==    by 0x1623FF2:
                                    hypre_CAlloc (hypre_memory.c:121)</div>
                                  <div>==8404==    by 0x15B3AA1:
                                    hypre_CSRMatrixInitialize
                                    (csr_matrix.c:91)</div>
                                  <div>
                                    ==8404==    by 0x158732D:
                                    hypre_ParCSRMatrixInitialize
                                    (par_csr_matrix.c:200)</div>
                                  <div>==8404==    by 0x14DB366:
                                    hypre_IJMatrixInitializeParCSR
                                    (IJMatrix_parcsr.c:272)</div>
                                  <div>==8404==    by 0x14D8D44:
                                    HYPRE_IJMatrixInitialize
                                    (HYPRE_IJMatrix.c:303)</div>
                                  <div>==8404==    by 0x11A7FFF:
                                    MatHYPRE_IJMatrixFastCopy_MPIAIJ(_p_Mat*,
                                    hypre_IJMatrix_struct*) (mhyp.c:211)</div>
                                  <div>==8404==    by 0x11A4BFD:
                                    MatHYPRE_IJMatrixCopy(_p_Mat*,
                                    hypre_IJMatrix_struct*) (mhyp.c:122)</div>
                                  <div>
                                    ==8404==    by 0xAFE3DC:
                                    PCSetUp_HYPRE(_p_PC*) (hypre.c:118)</div>
                                  <div>==8404==    by 0x12293CE:
                                    PCSetUp(_p_PC*) (precon.c:832)</div>
                                  <div>==8404==    by 0xC1D524:
                                    KSPSetUp(_p_KSP*) (itfunc.c:278)</div>
                                  <div>==8404== </div>
                                  <div>==8404== Use of uninitialised
                                    value of size 8</div>
                                  <div>==8404==    at 0x74ADE42:
                                    _int_malloc (mvapich_malloc.c:4124)</div>
                                  <div>==8404==    by 0x74B2189: calloc
                                    (mvapich_malloc.c:3765)</div>
                                  <div>==8404==    by 0x1623FF2:
                                    hypre_CAlloc (hypre_memory.c:121)</div>
                                  <div>==8404==    by 0x15B3AA1:
                                    hypre_CSRMatrixInitialize
                                    (csr_matrix.c:91)</div>
                                  <div>==8404==    by 0x158732D:
                                    hypre_ParCSRMatrixInitialize
                                    (par_csr_matrix.c:200)</div>
                                  <div>==8404==    by 0x14DB366:
                                    hypre_IJMatrixInitializeParCSR
                                    (IJMatrix_parcsr.c:272)</div>
                                  <div>==8404==    by 0x14D8D44:
                                    HYPRE_IJMatrixInitialize
                                    (HYPRE_IJMatrix.c:303)</div>
                                  <div>==8404==    by 0x11A7FFF:
                                    MatHYPRE_IJMatrixFastCopy_MPIAIJ(_p_Mat*,
                                    hypre_IJMatrix_struct*) (mhyp.c:211)</div>
                                  <div>==8404==    by 0x11A4BFD:
                                    MatHYPRE_IJMatrixCopy(_p_Mat*,
                                    hypre_IJMatrix_struct*) (mhyp.c:122)</div>
                                  <div>==8404==    by 0xAFE3DC:
                                    PCSetUp_HYPRE(_p_PC*) (hypre.c:118)</div>
                                  <div>==8404==    by 0x12293CE:
                                    PCSetUp(_p_PC*) (precon.c:832)</div>
                                  <div>==8404==    by 0xC1D524:
                                    KSPSetUp(_p_KSP*) (itfunc.c:278)</div>
                                  <div>==8404== </div>
                                  <div>==8404== Conditional jump or move
                                    depends on uninitialised value(s)</div>
                                  <div>==8404==    at 0x74ADE4C:
                                    _int_malloc (mvapich_malloc.c:4126)</div>
                                  <div>==8404==    by 0x74B2189: calloc
                                    (mvapich_malloc.c:3765)</div>
                                  <div>
                                    ==8404==    by 0x1623FF2:
                                    hypre_CAlloc (hypre_memory.c:121)</div>
                                  <div>==8404==    by 0x15B3AA1:
                                    hypre_CSRMatrixInitialize
                                    (csr_matrix.c:91)</div>
                                  <div>==8404==    by 0x158732D:
                                    hypre_ParCSRMatrixInitialize
                                    (par_csr_matrix.c:200)</div>
                                  <div>==8404==    by 0x14DB366:
                                    hypre_IJMatrixInitializeParCSR
                                    (IJMatrix_parcsr.c:272)</div>
                                  <div>==8404==    by 0x14D8D44:
                                    HYPRE_IJMatrixInitialize
                                    (HYPRE_IJMatrix.c:303)</div>
                                  <div>==8404==    by 0x11A7FFF:
                                    MatHYPRE_IJMatrixFastCopy_MPIAIJ(_p_Mat*,
                                    hypre_IJMatrix_struct*) (mhyp.c:211)</div>
                                  <div>==8404==    by 0x11A4BFD:
                                    MatHYPRE_IJMatrixCopy(_p_Mat*,
                                    hypre_IJMatrix_struct*) (mhyp.c:122)</div>
                                  <div>==8404==    by 0xAFE3DC:
                                    PCSetUp_HYPRE(_p_PC*) (hypre.c:118)</div>
                                  <div>==8404==    by 0x12293CE:
                                    PCSetUp(_p_PC*) (precon.c:832)</div>
                                  <div>==8404==    by 0xC1D524:
                                    KSPSetUp(_p_KSP*) (itfunc.c:278)</div>
                                  <div>==8404== </div>
                                  <div>==8404== Use of uninitialised
                                    value of size 8</div>
                                  <div>==8404==    at 0x74ADE88:
                                    _int_malloc (mvapich_malloc.c:4148)</div>
                                  <div>
                                    ==8404==    by 0x74B2189: calloc
                                    (mvapich_malloc.c:3765)</div>
                                  <div>==8404==    by 0x1623FF2:
                                    hypre_CAlloc (hypre_memory.c:121)</div>
                                  <div>==8404==    by 0x15B3AA1:
                                    hypre_CSRMatrixInitialize
                                    (csr_matrix.c:91)</div>
                                  <div>==8404==    by 0x158732D:
                                    hypre_ParCSRMatrixInitialize
                                    (par_csr_matrix.c:200)</div>
                                  <div>==8404==    by 0x14DB366:
                                    hypre_IJMatrixInitializeParCSR
                                    (IJMatrix_parcsr.c:272)</div>
                                  <div>==8404==    by 0x14D8D44:
                                    HYPRE_IJMatrixInitialize
                                    (HYPRE_IJMatrix.c:303)</div>
                                  <div>==8404==    by 0x11A7FFF:
                                    MatHYPRE_IJMatrixFastCopy_MPIAIJ(_p_Mat*,
                                    hypre_IJMatrix_struct*) (mhyp.c:211)</div>
                                  <div>==8404==    by 0x11A4BFD:
                                    MatHYPRE_IJMatrixCopy(_p_Mat*,
                                    hypre_IJMatrix_struct*) (mhyp.c:122)</div>
                                  <div>==8404==    by 0xAFE3DC:
                                    PCSetUp_HYPRE(_p_PC*) (hypre.c:118)</div>
                                  <div>==8404==    by 0x12293CE:
                                    PCSetUp(_p_PC*) (precon.c:832)</div>
                                  <div>==8404==    by 0xC1D524:
                                    KSPSetUp(_p_KSP*) (itfunc.c:278)</div>
                                  <div>==8404== </div>
                                  <div>==8404== Use of uninitialised
                                    value of size 8</div>
                                  <div>==8404==    at 0x74ADE9C:
                                    _int_malloc (mvapich_malloc.c:4152)</div>
                                  <div>
                                    ==8404==    by 0x74B2189: calloc
                                    (mvapich_malloc.c:3765)</div>
                                  <div>==8404==    by 0x1623FF2:
                                    hypre_CAlloc (hypre_memory.c:121)</div>
                                  <div>==8404==    by 0x15B3AA1:
                                    hypre_CSRMatrixInitialize
                                    (csr_matrix.c:91)</div>
                                  <div>==8404==    by 0x158732D:
                                    hypre_ParCSRMatrixInitialize
                                    (par_csr_matrix.c:200)</div>
                                  <div>==8404==    by 0x14DB366:
                                    hypre_IJMatrixInitializeParCSR
                                    (IJMatrix_parcsr.c:272)</div>
                                  <div>==8404==    by 0x14D8D44:
                                    HYPRE_IJMatrixInitialize
                                    (HYPRE_IJMatrix.c:303)</div>
                                  <div>==8404==    by 0x11A7FFF:
                                    MatHYPRE_IJMatrixFastCopy_MPIAIJ(_p_Mat*,
                                    hypre_IJMatrix_struct*) (mhyp.c:211)</div>
                                  <div>==8404==    by 0x11A4BFD:
                                    MatHYPRE_IJMatrixCopy(_p_Mat*,
                                    hypre_IJMatrix_struct*) (mhyp.c:122)</div>
                                  <div>==8404==    by 0xAFE3DC:
                                    PCSetUp_HYPRE(_p_PC*) (hypre.c:118)</div>
                                  <div>==8404==    by 0x12293CE:
                                    PCSetUp(_p_PC*) (precon.c:832)</div>
                                  <div>==8404==    by 0xC1D524:
                                    KSPSetUp(_p_KSP*) (itfunc.c:278)</div>
                                  <div>==8404== </div>
                                  <div>==8404== Use of uninitialised
                                    value of size 8</div>
                                  <div>==8404==    at 0x74AE1E7:
                                    _int_malloc (mvapich_malloc.c:4170)</div>
                                  <div>
                                    ==8404==    by 0x74B2189: calloc
                                    (mvapich_malloc.c:3765)</div>
                                  <div>==8404==    by 0x1623FF2:
                                    hypre_CAlloc (hypre_memory.c:121)</div>
                                  <div>==8404==    by 0x15B3B06:
                                    hypre_CSRMatrixInitialize
                                    (csr_matrix.c:97)</div>
                                  <div>==8404==    by 0x158732D:
                                    hypre_ParCSRMatrixInitialize
                                    (par_csr_matrix.c:200)</div>
                                  <div>==8404==    by 0x14DB366:
                                    hypre_IJMatrixInitializeParCSR
                                    (IJMatrix_parcsr.c:272)</div>
                                  <div>==8404==    by 0x14D8D44:
                                    HYPRE_IJMatrixInitialize
                                    (HYPRE_IJMatrix.c:303)</div>
                                  <div>==8404==    by 0x11A7FFF:
                                    MatHYPRE_IJMatrixFastCopy_MPIAIJ(_p_Mat*,
                                    hypre_IJMatrix_struct*) (mhyp.c:211)</div>
                                  <div>==8404==    by 0x11A4BFD:
                                    MatHYPRE_IJMatrixCopy(_p_Mat*,
                                    hypre_IJMatrix_struct*) (mhyp.c:122)</div>
                                  <div>==8404==    by 0xAFE3DC:
                                    PCSetUp_HYPRE(_p_PC*) (hypre.c:118)</div>
                                  <div>==8404==    by 0x12293CE:
                                    PCSetUp(_p_PC*) (precon.c:832)</div>
                                  <div>==8404==    by 0xC1D524:
                                    KSPSetUp(_p_KSP*) (itfunc.c:278)</div>
                                  <div>==8404== </div>
                                  <div>==8404== Conditional jump or move
                                    depends on uninitialised value(s)</div>
                                  <div>==8404==    at 0x74AE1EF:
                                    _int_malloc (mvapich_malloc.c:4173)</div>
                                  <div>==8404==    by 0x74B2189: calloc
                                    (mvapich_malloc.c:3765)</div>
                                  <div>==8404==    by 0x1623FF2:
                                    hypre_CAlloc (hypre_memory.c:121)</div>
                                  <div>==8404==    by 0x15B3B06:
                                    hypre_CSRMatrixInitialize
                                    (csr_matrix.c:97)</div>
                                  <div>
                                    ==8404==    by 0x158732D:
                                    hypre_ParCSRMatrixInitialize
                                    (par_csr_matrix.c:200)</div>
                                  <div>==8404==    by 0x14DB366:
                                    hypre_IJMatrixInitializeParCSR
                                    (IJMatrix_parcsr.c:272)</div>
                                  <div>==8404==    by 0x14D8D44:
                                    HYPRE_IJMatrixInitialize
                                    (HYPRE_IJMatrix.c:303)</div>
                                  <div>==8404==    by 0x11A7FFF:
                                    MatHYPRE_IJMatrixFastCopy_MPIAIJ(_p_Mat*,
                                    hypre_IJMatrix_struct*) (mhyp.c:211)</div>
                                  <div>==8404==    by 0x11A4BFD:
                                    MatHYPRE_IJMatrixCopy(_p_Mat*,
                                    hypre_IJMatrix_struct*) (mhyp.c:122)</div>
                                  <div>
                                    ==8404==    by 0xAFE3DC:
                                    PCSetUp_HYPRE(_p_PC*) (hypre.c:118)</div>
                                  <div>==8404==    by 0x12293CE:
                                    PCSetUp(_p_PC*) (precon.c:832)</div>
                                  <div>==8404==    by 0xC1D524:
                                    KSPSetUp(_p_KSP*) (itfunc.c:278)</div>
                                  <div>==8404== </div>
                                  <div>==8404== Use of uninitialised
                                    value of size 8</div>
                                  <div>==8404==    at 0x74AE266:
                                    _int_malloc (mvapich_malloc.c:4188)</div>
                                  <div>==8404==    by 0x74B2189: calloc
                                    (mvapich_malloc.c:3765)</div>
                                  <div>==8404==    by 0x1623FF2:
                                    hypre_CAlloc (hypre_memory.c:121)</div>
                                  <div>==8404==    by 0x15B3B06:
                                    hypre_CSRMatrixInitialize
                                    (csr_matrix.c:97)</div>
                                  <div>==8404==    by 0x158732D:
                                    hypre_ParCSRMatrixInitialize
                                    (par_csr_matrix.c:200)</div>
                                  <div>==8404==    by 0x14DB366:
                                    hypre_IJMatrixInitializeParCSR
                                    (IJMatrix_parcsr.c:272)</div>
                                  <div>==8404==    by 0x14D8D44:
                                    HYPRE_IJMatrixInitialize
                                    (HYPRE_IJMatrix.c:303)</div>
                                  <div>==8404==    by 0x11A7FFF:
                                    MatHYPRE_IJMatrixFastCopy_MPIAIJ(_p_Mat*,
                                    hypre_IJMatrix_struct*) (mhyp.c:211)</div>
                                  <div>==8404==    by 0x11A4BFD:
                                    MatHYPRE_IJMatrixCopy(_p_Mat*,
                                    hypre_IJMatrix_struct*) (mhyp.c:122)</div>
                                  <div>==8404==    by 0xAFE3DC:
                                    PCSetUp_HYPRE(_p_PC*) (hypre.c:118)</div>
                                  <div>==8404==    by 0x12293CE:
                                    PCSetUp(_p_PC*) (precon.c:832)</div>
                                  <div>==8404==    by 0xC1D524:
                                    KSPSetUp(_p_KSP*) (itfunc.c:278)</div>
                                  <div>==8404== </div>
                                  <div>==8404== Conditional jump or move
                                    depends on uninitialised value(s)</div>
                                  <div>==8404==    at 0x74ADF87:
                                    _int_malloc (mvapich_malloc.c:4237)</div>
                                  <div>==8404==    by 0x74B2189: calloc
                                    (mvapich_malloc.c:3765)</div>
                                  <div>
                                    ==8404==    by 0x1623FF2:
                                    hypre_CAlloc (hypre_memory.c:121)</div>
                                  <div>==8404==    by 0x1626536:
                                    hypre_AuxParCSRMatrixInitialize
                                    (aux_parcsr_matrix.c:177)</div>
                                  <div>==8404==    by 0x14DB372:
                                    hypre_IJMatrixInitializeParCSR
                                    (IJMatrix_parcsr.c:273)</div>
                                  <div>==8404==    by 0x14D8D44:
                                    HYPRE_IJMatrixInitialize
                                    (HYPRE_IJMatrix.c:303)</div>
                                  <div>==8404==    by 0x11A7FFF:
                                    MatHYPRE_IJMatrixFastCopy_MPIAIJ(_p_Mat*,
                                    hypre_IJMatrix_struct*) (mhyp.c:211)</div>
                                  <div>==8404==    by 0x11A4BFD:
                                    MatHYPRE_IJMatrixCopy(_p_Mat*,
                                    hypre_IJMatrix_struct*) (mhyp.c:122)</div>
                                  <div>==8404==    by 0xAFE3DC:
                                    PCSetUp_HYPRE(_p_PC*) (hypre.c:118)</div>
                                  <div>==8404==    by 0x12293CE:
                                    PCSetUp(_p_PC*) (precon.c:832)</div>
                                  <div>==8404==    by 0xC1D524:
                                    KSPSetUp(_p_KSP*) (itfunc.c:278)</div>
                                  <div>==8404==    by 0xC1EFD9:
                                    KSPSolve(_p_KSP*, _p_Vec*, _p_Vec*)
                                    (itfunc.c:402)</div>
                                  <div>==8404== </div>
                                  <div>==8404== Conditional jump or move
                                    depends on uninitialised value(s)</div>
                                  <div>==8404==    at 0x74ADECC:
                                    _int_malloc (mvapich_malloc.c:4165)</div>
                                  <div>==8404==    by 0x74B2189: calloc
                                    (mvapich_malloc.c:3765)</div>
                                  <div>==8404==    by 0x1623FF2:
                                    hypre_CAlloc (hypre_memory.c:121)</div>
                                  <div>==8404==    by 0x15B62C5:
                                    hypre_SeqVectorInitialize
                                    (vector.c:94)</div>
                                  <div>==8404==    by 0x158CF25:
                                    hypre_ParVectorInitialize
                                    (par_vector.c:150)</div>
                                  <div>==8404==    by 0x14ECF47:
                                    hypre_BoomerAMGSetup
                                    (par_amg_setup.c:464)</div>
                                  <div>==8404==    by 0x14E2EA6:
                                    HYPRE_BoomerAMGSetup
                                    (HYPRE_parcsr_amg.c:58)</div>
                                  <div>==8404==    by 0xAFF31D:
                                    PCSetUp_HYPRE(_p_PC*) (hypre.c:122)</div>
                                  <div>==8404==    by 0x12293CE:
                                    PCSetUp(_p_PC*) (precon.c:832)</div>
                                  <div>==8404==    by 0xC1D524:
                                    KSPSetUp(_p_KSP*) (itfunc.c:278)</div>
                                  <div>==8404==    by 0xC1EFD9:
                                    KSPSolve(_p_KSP*, _p_Vec*, _p_Vec*)
                                    (itfunc.c:402)</div>
                                  <div>==8404==    by 0x46C59F:
                                    PetscLinearSolver::solve(ArrayV<double>&,
                                    PetscBool)
                                    (petscLinearSolver.cpp:402)</div>
                                  <div>==8404== </div>
                                  <div>==8404== Conditional jump or move
                                    depends on uninitialised value(s)</div>
                                  <div>==8404==    at 0x74ADF72:
                                    _int_malloc (mvapich_malloc.c:4227)</div>
                                  <div>==8404==    by 0x74B2189: calloc
                                    (mvapich_malloc.c:3765)</div>
                                  <div>==8404==    by 0x1623FF2:
                                    hypre_CAlloc (hypre_memory.c:121)</div>
                                  <div>==8404==    by 0x14FC3F9:
                                    hypre_BoomerAMGCoarsenRuge
                                    (par_coarsen.c:940)</div>
                                  <div>==8404==    by 0x14FF1EE:
                                    hypre_BoomerAMGCoarsenFalgout
                                    (par_coarsen.c:1918)</div>
                                  <div>==8404==    by 0x14EDE45:
                                    hypre_BoomerAMGSetup
                                    (par_amg_setup.c:758)</div>
                                  <div>==8404==    by 0x14E2EA6:
                                    HYPRE_BoomerAMGSetup
                                    (HYPRE_parcsr_amg.c:58)</div>
                                  <div>==8404==    by 0xAFF31D:
                                    PCSetUp_HYPRE(_p_PC*) (hypre.c:122)</div>
                                  <div>==8404==    by 0x12293CE:
                                    PCSetUp(_p_PC*) (precon.c:832)</div>
                                  <div>==8404==    by 0xC1D524:
                                    KSPSetUp(_p_KSP*) (itfunc.c:278)</div>
                                  <div>==8404==    by 0xC1EFD9:
                                    KSPSolve(_p_KSP*, _p_Vec*, _p_Vec*)
                                    (itfunc.c:402)</div>
                                  <div>==8404==    by 0x46C59F:
                                    PetscLinearSolver::solve(ArrayV<double>&,
                                    PetscBool)
                                    (petscLinearSolver.cpp:402)</div>
                                  <div>==8404== </div>
                                  <div>==8404== Conditional jump or move
                                    depends on uninitialised value(s)</div>
                                  <div>==8404==    at 0x74ADF7E:
                                    _int_malloc (mvapich_malloc.c:4227)</div>
                                  <div>==8404==    by 0x74B2189: calloc
                                    (mvapich_malloc.c:3765)</div>
                                  <div>==8404==    by 0x1623FF2:
                                    hypre_CAlloc (hypre_memory.c:121)</div>
                                  <div>==8404==    by 0x14FC3F9:
                                    hypre_BoomerAMGCoarsenRuge
                                    (par_coarsen.c:940)</div>
                                  <div>==8404==    by 0x14FF1EE:
                                    hypre_BoomerAMGCoarsenFalgout
                                    (par_coarsen.c:1918)</div>
                                  <div>==8404==    by 0x14EDE45:
                                    hypre_BoomerAMGSetup
                                    (par_amg_setup.c:758)</div>
                                  <div>==8404==    by 0x14E2EA6:
                                    HYPRE_BoomerAMGSetup
                                    (HYPRE_parcsr_amg.c:58)</div>
                                  <div>==8404==    by 0xAFF31D:
                                    PCSetUp_HYPRE(_p_PC*) (hypre.c:122)</div>
                                  <div>==8404==    by 0x12293CE:
                                    PCSetUp(_p_PC*) (precon.c:832)</div>
                                  <div>==8404==    by 0xC1D524:
                                    KSPSetUp(_p_KSP*) (itfunc.c:278)</div>
                                  <div>==8404==    by 0xC1EFD9:
                                    KSPSolve(_p_KSP*, _p_Vec*, _p_Vec*)
                                    (itfunc.c:402)</div>
                                  <div>==8404==    by 0x46C59F:
                                    PetscLinearSolver::solve(ArrayV<double>&,
                                    PetscBool)
                                    (petscLinearSolver.cpp:402)</div>
                                  <div>==8404== </div>
                                  <div>==8404== Use of uninitialised
                                    value of size 8</div>
                                  <div>==8404==    at 0x74AE293:
                                    _int_malloc (mvapich_malloc.c:4254)</div>
                                  <div>==8404==    by 0x74B2189: calloc
                                    (mvapich_malloc.c:3765)</div>
                                  <div>==8404==    by 0x1623FF2:
                                    hypre_CAlloc (hypre_memory.c:121)</div>
                                  <div>==8404==    by 0x153D557:
                                    hypre_BoomerAMGBuildCoarseOperator
                                    (par_rap.c:1012)</div>
                                  <div>==8404==    by 0x14F1CCB:
                                    hypre_BoomerAMGSetup
                                    (par_amg_setup.c:1650)</div>
                                  <div>==8404==    by 0x14E2EA6:
                                    HYPRE_BoomerAMGSetup
                                    (HYPRE_parcsr_amg.c:58)</div>
                                  <div>==8404==    by 0xAFF31D:
                                    PCSetUp_HYPRE(_p_PC*) (hypre.c:122)</div>
                                  <div>==8404==    by 0x12293CE:
                                    PCSetUp(_p_PC*) (precon.c:832)</div>
                                  <div>==8404==    by 0xC1D524:
                                    KSPSetUp(_p_KSP*) (itfunc.c:278)</div>
                                  <div>==8404==    by 0xC1EFD9:
                                    KSPSolve(_p_KSP*, _p_Vec*, _p_Vec*)
                                    (itfunc.c:402)</div>
                                  <div>==8404==    by 0x46C59F:
                                    PetscLinearSolver::solve(ArrayV<double>&,
                                    PetscBool)
                                    (petscLinearSolver.cpp:402)</div>
                                  <div>==8404==    by 0x472A92:
                                    amr2D::fvm::pbSolver::SolveNonLinearPB(double,
                                    int) (pbSolver_2d_FVM.cpp:148)</div>
                                  <div>==8404== </div>
                                  <div>==8404== Conditional jump or move
                                    depends on uninitialised value(s)</div>
                                  <div>==8404==    at 0x74AE29B:
                                    _int_malloc (mvapich_malloc.c:4257)</div>
                                  <div>==8404==    by 0x74B2189: calloc
                                    (mvapich_malloc.c:3765)</div>
                                  <div>==8404==    by 0x1623FF2:
                                    hypre_CAlloc (hypre_memory.c:121)</div>
                                  <div>==8404==    by 0x153D557:
                                    hypre_BoomerAMGBuildCoarseOperator
                                    (par_rap.c:1012)</div>
                                  <div>==8404==    by 0x14F1CCB:
                                    hypre_BoomerAMGSetup
                                    (par_amg_setup.c:1650)</div>
                                  <div>==8404==    by 0x14E2EA6:
                                    HYPRE_BoomerAMGSetup
                                    (HYPRE_parcsr_amg.c:58)</div>
                                  <div>==8404==    by 0xAFF31D:
                                    PCSetUp_HYPRE(_p_PC*) (hypre.c:122)</div>
                                  <div>==8404==    by 0x12293CE:
                                    PCSetUp(_p_PC*) (precon.c:832)</div>
                                  <div>
                                    ==8404==    by 0xC1D524:
                                    KSPSetUp(_p_KSP*) (itfunc.c:278)</div>
                                  <div>==8404==    by 0xC1EFD9:
                                    KSPSolve(_p_KSP*, _p_Vec*, _p_Vec*)
                                    (itfunc.c:402)</div>
                                  <div>==8404==    by 0x46C59F:
                                    PetscLinearSolver::solve(ArrayV<double>&,
                                    PetscBool)
                                    (petscLinearSolver.cpp:402)</div>
                                  <div>==8404==    by 0x472A92:
                                    amr2D::fvm::pbSolver::SolveNonLinearPB(double,
                                    int) (pbSolver_2d_FVM.cpp:148)</div>
                                  <div>==8404== </div>
                                  <div>==8404== Use of uninitialised
                                    value of size 8</div>
                                  <div>==8404==    at 0x74AE327:
                                    _int_malloc (mvapich_malloc.c:4278)</div>
                                  <div>==8404==    by 0x74B2189: calloc
                                    (mvapich_malloc.c:3765)</div>
                                  <div>==8404==    by 0x1623FF2:
                                    hypre_CAlloc (hypre_memory.c:121)</div>
                                  <div>==8404==    by 0x153D557:
                                    hypre_BoomerAMGBuildCoarseOperator
                                    (par_rap.c:1012)</div>
                                  <div>==8404==    by 0x14F1CCB:
                                    hypre_BoomerAMGSetup
                                    (par_amg_setup.c:1650)</div>
                                  <div>==8404==    by 0x14E2EA6:
                                    HYPRE_BoomerAMGSetup
                                    (HYPRE_parcsr_amg.c:58)</div>
                                  <div>==8404==    by 0xAFF31D:
                                    PCSetUp_HYPRE(_p_PC*) (hypre.c:122)</div>
                                  <div>==8404==    by 0x12293CE:
                                    PCSetUp(_p_PC*) (precon.c:832)</div>
                                  <div>==8404==    by 0xC1D524:
                                    KSPSetUp(_p_KSP*) (itfunc.c:278)</div>
                                  <div>==8404==    by 0xC1EFD9:
                                    KSPSolve(_p_KSP*, _p_Vec*, _p_Vec*)
                                    (itfunc.c:402)</div>
                                  <div>==8404==    by 0x46C59F:
                                    PetscLinearSolver::solve(ArrayV<double>&,
                                    PetscBool)
                                    (petscLinearSolver.cpp:402)</div>
                                  <div>==8404==    by 0x472A92:
                                    amr2D::fvm::pbSolver::SolveNonLinearPB(double,
                                    int) (pbSolver_2d_FVM.cpp:148)</div>
                                  <div>==8404== </div>
                                  <div>==8404== Use of uninitialised
                                    value of size 8</div>
                                  <div>==8404==    at 0x74ADE4E:
                                    _int_malloc (mvapich_malloc.c:4129)</div>
                                  <div>==8404==    by 0x74B2189: calloc
                                    (mvapich_malloc.c:3765)</div>
                                  <div>
                                    ==8404==    by 0x1623FF2:
                                    hypre_CAlloc (hypre_memory.c:121)</div>
                                  <div>==8404==    by 0x153DAD9:
                                    hypre_BoomerAMGBuildCoarseOperator
                                    (par_rap.c:1122)</div>
                                  <div>==8404==    by 0x14F1CCB:
                                    hypre_BoomerAMGSetup
                                    (par_amg_setup.c:1650)</div>
                                  <div>==8404==    by 0x14E2EA6:
                                    HYPRE_BoomerAMGSetup
                                    (HYPRE_parcsr_amg.c:58)</div>
                                  <div>==8404==    by 0xAFF31D:
                                    PCSetUp_HYPRE(_p_PC*) (hypre.c:122)</div>
                                  <div>==8404==    by 0x12293CE:
                                    PCSetUp(_p_PC*) (precon.c:832)</div>
                                  <div>==8404==    by 0xC1D524:
                                    KSPSetUp(_p_KSP*) (itfunc.c:278)</div>
                                  <div>==8404==    by 0xC1EFD9:
                                    KSPSolve(_p_KSP*, _p_Vec*, _p_Vec*)
                                    (itfunc.c:402)</div>
                                  <div>==8404==    by 0x46C59F:
                                    PetscLinearSolver::solve(ArrayV<double>&,
                                    PetscBool)
                                    (petscLinearSolver.cpp:402)</div>
                                  <div>==8404==    by 0x472A92:
                                    amr2D::fvm::pbSolver::SolveNonLinearPB(double,
                                    int) (pbSolver_2d_FVM.cpp:148)</div>
                                  <div>==8404== </div>
                                  <div>==8404== Conditional jump or move
                                    depends on uninitialised value(s)</div>
                                  <div>==8404==    at 0x74ADE56:
                                    _int_malloc (mvapich_malloc.c:4129)</div>
                                  <div>==8404==    by 0x74B2189: calloc
                                    (mvapich_malloc.c:3765)</div>
                                  <div>==8404==    by 0x1623FF2:
                                    hypre_CAlloc (hypre_memory.c:121)</div>
                                  <div>==8404==    by 0x153DAD9:
                                    hypre_BoomerAMGBuildCoarseOperator
                                    (par_rap.c:1122)</div>
                                  <div>==8404==    by 0x14F1CCB:
                                    hypre_BoomerAMGSetup
                                    (par_amg_setup.c:1650)</div>
                                  <div>==8404==    by 0x14E2EA6:
                                    HYPRE_BoomerAMGSetup
                                    (HYPRE_parcsr_amg.c:58)</div>
                                  <div>==8404==    by 0xAFF31D:
                                    PCSetUp_HYPRE(_p_PC*) (hypre.c:122)</div>
                                  <div>==8404==    by 0x12293CE:
                                    PCSetUp(_p_PC*) (precon.c:832)</div>
                                  <div>
                                    ==8404==    by 0xC1D524:
                                    KSPSetUp(_p_KSP*) (itfunc.c:278)</div>
                                  <div>==8404==    by 0xC1EFD9:
                                    KSPSolve(_p_KSP*, _p_Vec*, _p_Vec*)
                                    (itfunc.c:402)</div>
                                  <div>==8404==    by 0x46C59F:
                                    PetscLinearSolver::solve(ArrayV<double>&,
                                    PetscBool)
                                    (petscLinearSolver.cpp:402)</div>
                                  <div>==8404==    by 0x472A92:
                                    amr2D::fvm::pbSolver::SolveNonLinearPB(double,
                                    int) (pbSolver_2d_FVM.cpp:148)</div>
                                  <div>==8404== </div>
                                  <div>==8404== Use of uninitialised
                                    value of size 8</div>
                                  <div>==8404==    at 0x74ADE98:
                                    _int_malloc (mvapich_malloc.c:4151)</div>
                                  <div>==8404==    by 0x74B2189: calloc
                                    (mvapich_malloc.c:3765)</div>
                                  <div>==8404==    by 0x1623FF2:
                                    hypre_CAlloc (hypre_memory.c:121)</div>
                                  <div>==8404==    by 0x153DAD9:
                                    hypre_BoomerAMGBuildCoarseOperator
                                    (par_rap.c:1122)</div>
                                  <div>==8404==    by 0x14F1CCB:
                                    hypre_BoomerAMGSetup
                                    (par_amg_setup.c:1650)</div>
                                  <div>==8404==    by 0x14E2EA6:
                                    HYPRE_BoomerAMGSetup
                                    (HYPRE_parcsr_amg.c:58)</div>
                                  <div>==8404==    by 0xAFF31D:
                                    PCSetUp_HYPRE(_p_PC*) (hypre.c:122)</div>
                                  <div>==8404==    by 0x12293CE:
                                    PCSetUp(_p_PC*) (precon.c:832)</div>
                                  <div>==8404==    by 0xC1D524:
                                    KSPSetUp(_p_KSP*) (itfunc.c:278)</div>
                                  <div>==8404==    by 0xC1EFD9:
                                    KSPSolve(_p_KSP*, _p_Vec*, _p_Vec*)
                                    (itfunc.c:402)</div>
                                  <div>==8404==    by 0x46C59F:
                                    PetscLinearSolver::solve(ArrayV<double>&,
                                    PetscBool)
                                    (petscLinearSolver.cpp:402)</div>
                                  <div>==8404==    by 0x472A92:
                                    amr2D::fvm::pbSolver::SolveNonLinearPB(double,
                                    int) (pbSolver_2d_FVM.cpp:148)</div>
                                  <div>==8404== </div>
                                  <div>==8404== Use of uninitialised
                                    value of size 8</div>
                                  <div>==8404==    at 0x74AD771:
                                    _int_free (mvapich_malloc.c:4406)</div>
                                  <div>==8404==    by 0x74AF651: free
                                    (mvapich_malloc.c:3497)</div>
                                  <div>==8404==    by 0x16240BA:
                                    hypre_Free (hypre_memory.c:196)</div>
                                  <div>==8404==    by 0x153F2EA:
                                    hypre_BoomerAMGBuildCoarseOperator
                                    (par_rap.c:1685)</div>
                                  <div>==8404==    by 0x14F1CCB:
                                    hypre_BoomerAMGSetup
                                    (par_amg_setup.c:1650)</div>
                                  <div>==8404==    by 0x14E2EA6:
                                    HYPRE_BoomerAMGSetup
                                    (HYPRE_parcsr_amg.c:58)</div>
                                  <div>==8404==    by 0xAFF31D:
                                    PCSetUp_HYPRE(_p_PC*) (hypre.c:122)</div>
                                  <div>==8404==    by 0x12293CE:
                                    PCSetUp(_p_PC*) (precon.c:832)</div>
                                  <div>==8404==    by 0xC1D524:
                                    KSPSetUp(_p_KSP*) (itfunc.c:278)</div>
                                  <div>==8404==    by 0xC1EFD9:
                                    KSPSolve(_p_KSP*, _p_Vec*, _p_Vec*)
                                    (itfunc.c:402)</div>
                                  <div>==8404==    by 0x46C59F:
                                    PetscLinearSolver::solve(ArrayV<double>&,
                                    PetscBool)
                                    (petscLinearSolver.cpp:402)</div>
                                  <div>==8404==    by 0x472A92:
                                    amr2D::fvm::pbSolver::SolveNonLinearPB(double,
                                    int) (pbSolver_2d_FVM.cpp:148)</div>
                                  <div>==8404== </div>
                                  <div>==8404== Conditional jump or move
                                    depends on uninitialised value(s)</div>
                                  <div>==8404==    at 0x74ADF56:
                                    _int_malloc (mvapich_malloc.c:4220)</div>
                                  <div>==8404==    by 0x74B2189: calloc
                                    (mvapich_malloc.c:3765)</div>
                                  <div>==8404==    by 0x1623FF2:
                                    hypre_CAlloc (hypre_memory.c:121)</div>
                                  <div>==8404==    by 0x1586F83:
                                    hypre_ParCSRMatrixCreate
                                    (par_csr_matrix.c:60)</div>
                                  <div>==8404==    by 0x1554BE0:
                                    hypre_BoomerAMGCreateS
                                    (par_strength.c:156)</div>
                                  <div>==8404==    by 0x14EDD1B:
                                    hypre_BoomerAMGSetup
                                    (par_amg_setup.c:736)</div>
                                  <div>==8404==    by 0x14E2EA6:
                                    HYPRE_BoomerAMGSetup
                                    (HYPRE_parcsr_amg.c:58)</div>
                                  <div>==8404==    by 0xAFF31D:
                                    PCSetUp_HYPRE(_p_PC*) (hypre.c:122)</div>
                                  <div>==8404==    by 0x12293CE:
                                    PCSetUp(_p_PC*) (precon.c:832)</div>
                                  <div>==8404==    by 0xC1D524:
                                    KSPSetUp(_p_KSP*) (itfunc.c:278)</div>
                                  <div>==8404==    by 0xC1EFD9:
                                    KSPSolve(_p_KSP*, _p_Vec*, _p_Vec*)
                                    (itfunc.c:402)</div>
                                  <div>==8404==    by 0x46C59F:
                                    PetscLinearSolver::solve(ArrayV<double>&,
                                    PetscBool)
                                    (petscLinearSolver.cpp:402)</div>
                                  <div>==8404== </div>
                                  <div>==8404== Use of uninitialised
                                    value of size 8</div>
                                  <div>==8404==    at 0x828313B:
                                    __intel_new_memset (in
                                    /opt/apps/intel/11.1/lib/intel64/libirc.so)</div>
                                  <div>==8404==    by 0x8261535:
                                    _intel_fast_memset.J (in
                                    /opt/apps/intel/11.1/lib/intel64/libirc.so)</div>
                                  <div>==8404==    by 0x74B221A: calloc
                                    (mvapich_malloc.c:3826)</div>
                                  <div>==8404==    by 0x1623FF2:
                                    hypre_CAlloc (hypre_memory.c:121)</div>
                                  <div>==8404==    by 0x14FC57D:
                                    hypre_BoomerAMGCoarsenRuge
                                    (par_coarsen.c:988)</div>
                                  <div>==8404==    by 0x14FF1EE:
                                    hypre_BoomerAMGCoarsenFalgout
                                    (par_coarsen.c:1918)</div>
                                  <div>==8404==    by 0x14EDE45:
                                    hypre_BoomerAMGSetup
                                    (par_amg_setup.c:758)</div>
                                  <div>==8404==    by 0x14E2EA6:
                                    HYPRE_BoomerAMGSetup
                                    (HYPRE_parcsr_amg.c:58)</div>
                                  <div>==8404==    by 0xAFF31D:
                                    PCSetUp_HYPRE(_p_PC*) (hypre.c:122)</div>
                                  <div>==8404==    by 0x12293CE:
                                    PCSetUp(_p_PC*) (precon.c:832)</div>
                                  <div>
                                    ==8404==    by 0xC1D524:
                                    KSPSetUp(_p_KSP*) (itfunc.c:278)</div>
                                  <div>==8404==    by 0xC1EFD9:
                                    KSPSolve(_p_KSP*, _p_Vec*, _p_Vec*)
                                    (itfunc.c:402)</div>
                                  <div>==8404== </div>
                                  <div>==8404== Use of uninitialised
                                    value of size 8</div>
                                  <div>==8404==    at 0x8283145:
                                    __intel_new_memset (in
                                    /opt/apps/intel/11.1/lib/intel64/libirc.so)</div>
                                  <div>==8404==    by 0x8261535:
                                    _intel_fast_memset.J (in
                                    /opt/apps/intel/11.1/lib/intel64/libirc.so)</div>
                                  <div>==8404==    by 0x74B221A: calloc
                                    (mvapich_malloc.c:3826)</div>
                                  <div>==8404==    by 0x1623FF2:
                                    hypre_CAlloc (hypre_memory.c:121)</div>
                                  <div>==8404==    by 0x153E2B7:
                                    hypre_BoomerAMGBuildCoarseOperator
                                    (par_rap.c:1354)</div>
                                  <div>==8404==    by 0x14F1CCB:
                                    hypre_BoomerAMGSetup
                                    (par_amg_setup.c:1650)</div>
                                  <div>==8404==    by 0x14E2EA6:
                                    HYPRE_BoomerAMGSetup
                                    (HYPRE_parcsr_amg.c:58)</div>
                                  <div>==8404==    by 0xAFF31D:
                                    PCSetUp_HYPRE(_p_PC*) (hypre.c:122)</div>
                                  <div>==8404==    by 0x12293CE:
                                    PCSetUp(_p_PC*) (precon.c:832)</div>
                                  <div>
                                    ==8404==    by 0xC1D524:
                                    KSPSetUp(_p_KSP*) (itfunc.c:278)</div>
                                  <div>==8404==    by 0xC1EFD9:
                                    KSPSolve(_p_KSP*, _p_Vec*, _p_Vec*)
                                    (itfunc.c:402)</div>
                                  <div>==8404==    by 0x46C59F:
                                    PetscLinearSolver::solve(ArrayV<double>&,
                                    PetscBool)
                                    (petscLinearSolver.cpp:402)</div>
                                  <div>==8404== </div>
                                  <div>==8404== Use of uninitialised
                                    value of size 8</div>
                                  <div>==8404==    at 0x74AE1F1:
                                    _int_malloc (mvapich_malloc.c:4174)</div>
                                  <div>==8404==    by 0x74B2189: calloc
                                    (mvapich_malloc.c:3765)</div>
                                  <div>
                                    ==8404==    by 0x1623FF2:
                                    hypre_CAlloc (hypre_memory.c:121)</div>
                                  <div>==8404==    by 0x15B3457:
                                    hypre_CSRMatrixTranspose
                                    (csr_matop.c:354)</div>
                                  <div>==8404==    by 0x153B7B8:
                                    hypre_BoomerAMGBuildCoarseOperator
                                    (par_rap.c:372)</div>
                                  <div>==8404==    by 0x14F1CCB:
                                    hypre_BoomerAMGSetup
                                    (par_amg_setup.c:1650)</div>
                                  <div>==8404==    by 0x14E2EA6:
                                    HYPRE_BoomerAMGSetup
                                    (HYPRE_parcsr_amg.c:58)</div>
                                  <div>==8404==    by 0xAFF31D:
                                    PCSetUp_HYPRE(_p_PC*) (hypre.c:122)</div>
                                  <div>==8404==    by 0x12293CE:
                                    PCSetUp(_p_PC*) (precon.c:832)</div>
                                  <div>
                                    ==8404==    by 0xC1D524:
                                    KSPSetUp(_p_KSP*) (itfunc.c:278)</div>
                                  <div>==8404==    by 0xC1EFD9:
                                    KSPSolve(_p_KSP*, _p_Vec*, _p_Vec*)
                                    (itfunc.c:402)</div>
                                  <div>==8404==    by 0x46C59F:
                                    PetscLinearSolver::solve(ArrayV<double>&,
                                    PetscBool)
                                    (petscLinearSolver.cpp:402)</div>
                                  <div>==8404== </div>
                                  <div>==8404== Use of uninitialised
                                    value of size 8</div>
                                  <div>==8404==    at 0x74AD77E:
                                    _int_free (mvapich_malloc.c:4409)</div>
                                  <div>==8404==    by 0x74AF651: free
                                    (mvapich_malloc.c:3497)</div>
                                  <div>==8404==    by 0x16240BA:
                                    hypre_Free (hypre_memory.c:196)</div>
                                  <div>==8404==    by 0x15B3A2F:
                                    hypre_CSRMatrixDestroy
                                    (csr_matrix.c:69)</div>
                                  <div>==8404==    by 0x153F6C2:
                                    hypre_BoomerAMGBuildCoarseOperator
                                    (par_rap.c:1767)</div>
                                  <div>==8404==    by 0x14F1CCB:
                                    hypre_BoomerAMGSetup
                                    (par_amg_setup.c:1650)</div>
                                  <div>==8404==    by 0x14E2EA6:
                                    HYPRE_BoomerAMGSetup
                                    (HYPRE_parcsr_amg.c:58)</div>
                                  <div>==8404==    by 0xAFF31D:
                                    PCSetUp_HYPRE(_p_PC*) (hypre.c:122)</div>
                                  <div>==8404==    by 0x12293CE:
                                    PCSetUp(_p_PC*) (precon.c:832)</div>
                                  <div>
                                    ==8404==    by 0xC1D524:
                                    KSPSetUp(_p_KSP*) (itfunc.c:278)</div>
                                  <div>==8404==    by 0xC1EFD9:
                                    KSPSolve(_p_KSP*, _p_Vec*, _p_Vec*)
                                    (itfunc.c:402)</div>
                                  <div>==8404==    by 0x46C59F:
                                    PetscLinearSolver::solve(ArrayV<double>&,
                                    PetscBool)
                                    (petscLinearSolver.cpp:402)</div>
                                  <div>==8404== </div>
                                  <div>==8404== Use of uninitialised
                                    value of size 8</div>
                                  <div>==8404==    at 0x8283131:
                                    __intel_new_memset (in
                                    /opt/apps/intel/11.1/lib/intel64/libirc.so)</div>
                                  <div>==8404==    by 0x8261535:
                                    _intel_fast_memset.J (in
                                    /opt/apps/intel/11.1/lib/intel64/libirc.so)</div>
                                  <div>==8404==    by 0x74B221A: calloc
                                    (mvapich_malloc.c:3826)</div>
                                  <div>==8404==    by 0x1623FF2:
                                    hypre_CAlloc (hypre_memory.c:121)</div>
                                  <div>==8404==    by 0x153E2DD:
                                    hypre_BoomerAMGBuildCoarseOperator
                                    (par_rap.c:1355)</div>
                                  <div>==8404==    by 0x14F1CCB:
                                    hypre_BoomerAMGSetup
                                    (par_amg_setup.c:1650)</div>
                                  <div>==8404==    by 0x14E2EA6:
                                    HYPRE_BoomerAMGSetup
                                    (HYPRE_parcsr_amg.c:58)</div>
                                  <div>==8404==    by 0xAFF31D:
                                    PCSetUp_HYPRE(_p_PC*) (hypre.c:122)</div>
                                  <div>==8404==    by 0x12293CE:
                                    PCSetUp(_p_PC*) (precon.c:832)</div>
                                  <div>==8404==    by 0xC1D524:
                                    KSPSetUp(_p_KSP*) (itfunc.c:278)</div>
                                  <div>==8404==    by 0xC1EFD9:
                                    KSPSolve(_p_KSP*, _p_Vec*, _p_Vec*)
                                    (itfunc.c:402)</div>
                                  <div>==8404==    by 0x46C59F:
                                    PetscLinearSolver::solve(ArrayV<double>&,
                                    PetscBool)
                                    (petscLinearSolver.cpp:402)</div>
                                  <div>==8404== </div>
                                  <div>==8404== Conditional jump or move
                                    depends on uninitialised value(s)</div>
                                  <div>==8404==    at 0x74ADED9:
                                    _int_malloc (mvapich_malloc.c:4168)</div>
                                  <div>==8404==    by 0x74AEE8D: malloc
                                    (mvapich_malloc.c:3409)</div>
                                  <div>==8404==    by 0x74AFB0F:
                                    memalign (mvapich_malloc.c:3626)</div>
                                  <div>==8404==    by 0x494BF3:
                                    PetscMallocAlign(unsigned long, int,
                                    char const*, char const*, char
                                    const*, void**) (mal.c:30)</div>
                                  <div>==8404==    by 0x496DFD:
                                    PetscTrMallocDefault(unsigned long,
                                    int, char const*, char const*, char
                                    const*, void**) (mtr.c:190)</div>
                                  <div>==8404==    by 0xE71ECC:
                                    VecStashCreate_Private(int, int,
                                    VecStash*) (vecstash.c:37)</div>
                                  <div>==8404==    by 0x6145A1:
                                    VecCreate_MPI_Private(_p_Vec*,
                                    PetscBool, int, double const*)
                                    (pbvec.c:207)</div>
                                  <div>==8404==    by 0x613475:
                                    VecDuplicate_MPI(_p_Vec*, _p_Vec**)
                                    (pbvec.c:70)</div>
                                  <div>==8404==    by 0x59EF10:
                                    VecDuplicate(_p_Vec*, _p_Vec**)
                                    (vector.c:551)</div>
                                  <div>==8404==    by 0xC4F687:
                                    KSPDefaultConverged(_p_KSP*, int,
                                    double, KSPConvergedReason*, void*)
                                    (iterativ.c:585)</div>
                                  <div>==8404==    by 0xC6CB92:
                                    KSPSolve_BCGS(_p_KSP*) (bcgs.c:86)</div>
                                  <div>==8404==    by 0xC1FC32:
                                    KSPSolve(_p_KSP*, _p_Vec*, _p_Vec*)
                                    (itfunc.c:446)</div>
                                  <div>==8404== </div>
                                </div>
                                <div><br>
                                </div>
                                <div><br>
                                </div>
                                <div><br>
                                </div>
                                <div><br>
                                </div>
                              </div>
                            </blockquote>
                          </div>
                          <br>
                        </div>
                      </div>
                    </blockquote>
                  </div>
                </div>
              </div>
              <span class="HOEnZb"><font color="#888888"><br>
                  <br clear="all">
                  <div><br>
                  </div>
                  -- <br>
                  What most experimenters take for granted before they
                  begin their experiments is infinitely more interesting
                  than any results to which their experiments lead.<br>
                  -- Norbert Wiener<br>
                </font></span></blockquote>
          </div>
          <br>
        </div>
      </div>
    </blockquote>
    <br>
  </body>
</html>