<!DOCTYPE HTML PUBLIC "-//W3C//DTD HTML 4.01 Transitional//EN">
<html>
  <head>
    <meta content="text/html; charset=UTF-8" http-equiv="Content-Type">
  </head>
  <body bgcolor="#ffffff" text="#000000">
    Jed,<br>
    <br>
    Ok, I see. Initially I've changed solver because I observed one
    thing. I have two petsc-dev (one is older than the other) versions
    compiled.<br>
    Running the same program with both gives different results:<br>
    <br>
    ./solveTest -ksp_view -ksp_converged_reason
    -ksp_monitor_true_residual -log_summary -mat_type aij -ksp_rtol
    1.0e-7 -ksp_type tfqmr -pc_type sor -ksp_max_it 750<br>
      0 KSP preconditioned resid norm 9.760858225033e-10 true resid norm
    4.108026443997e-08 ||r(i)||/||b|| 1.000000000000e+00<br>
      1 KSP preconditioned resid norm 9.497939702484e-10 true resid norm
    3.591828545356e-08 ||r(i)||/||b|| 8.743440662618e-01<br>
      1 KSP preconditioned resid norm 1.341212527158e-09 true resid norm
    3.754099340764e-08 ||r(i)||/||b|| 9.138449793207e-01<br>
      2 KSP preconditioned resid norm 9.481744679086e-10 true resid norm
    3.710424003325e-08 ||r(i)||/||b|| 9.032132713620e-01<br>
      2 KSP preconditioned resid norm 1.340878639500e-09 true resid norm
    3.730261027312e-08 ||r(i)||/||b|| 9.080421166135e-01<br>
      3 KSP preconditioned resid norm 9.481415577317e-10 true resid norm
    3.725585425324e-08 ||r(i)||/||b|| 9.069039540306e-01<br>
     ...<br>
    750 KSP preconditioned resid norm 1.340874209607e-09 true resid norm
    3.726506102951e-08 ||r(i)||/||b|| 9.071280708031e-01<br>
    Linear solve did not converge due to DIVERGED_ITS iterations 750<br>
    KSP Object: 1 MPI processes<br>
      type: tfqmr<br>
      maximum iterations=750, initial guess is zero<br>
      tolerances:  relative=1e-07, absolute=1e-50, divergence=10000<br>
      left preconditioning<br>
      using PRECONDITIONED norm type for convergence test<br>
    PC Object: 1 MPI processes<br>
      type: sor<br>
        SOR: type = local_symmetric, iterations = 1, local iterations =
    1, omega = 1<br>
      linear system matrix = precond matrix:<br>
      Matrix Object:   1 MPI processes<br>
        type: seqaij<br>
        rows=1375920, cols=1375920<br>
        total: nonzeros=17671714, allocated nonzeros=17671714<br>
        total number of mallocs used during MatSetValues calls =0<br>
          not using I-node routines<br>
          <br>
    Using Petsc Development HG revision:
    59ca71b85d784abbe22f12c34ffcb2ccc6dc68b0  HG Date: Tue Mar 20
    01:05:13 2012 -0500<br>
    Configure options: --with-petsc-arch=openmpi-intel-complex-release-c
    --with-mpi-dir=/opt/mpi/intel/openmpi-1.4.2
    --with-scalar-type=complex --with-precision=double
    --with-blas-lapack-dir=/usr/local/lib --with-x=0 --with-debugging=0<br>
    <br>
    #######################################<br>
    And now second one:<br>
    ./solveTest -ksp_view -ksp_converged_reason
    -ksp_monitor_true_residual -log_summary -mat_type aij -ksp_rtol
    1.0e-7 -ksp_type tfqmr -pc_type sor -ksp_max_it 750<br>
      0 KSP preconditioned resid norm 9.760858225034e-10 true resid norm
    4.108026443997e-08 ||r(i)||/||b|| 1.000000000000e+00<br>
      1 KSP preconditioned resid norm 9.497930576113e-10 true resid norm
    3.591633653854e-08 ||r(i)||/||b|| 8.742966246242e-01<br>
      1 KSP preconditioned resid norm 1.341211098002e-09 true resid norm
    3.754049143693e-08 ||r(i)||/||b|| 9.138327600539e-01<br>
      2 KSP preconditioned resid norm 9.481662292281e-10 true resid norm
    3.709648505700e-08 ||r(i)||/||b|| 9.030244951612e-01<br>
      2 KSP preconditioned resid norm 1.340863953080e-09 true resid norm
    3.730358317575e-08 ||r(i)||/||b|| 9.080657995827e-01<br>
      3 KSP preconditioned resid norm 9.481308142928e-10 true resid norm
    3.725036905334e-08 ||r(i)||/||b|| 9.067704300630e-01<br>
    ...<br>
    230 KSP preconditioned resid norm 8.875661094394e-17 true resid norm
    1.062030983067e-14 ||r(i)||/||b|| 2.585258389996e-07<br>
    Linear solve converged due to CONVERGED_RTOL iterations 230<br>
    KSP Object: 1 MPI processes<br>
      type: tfqmr<br>
      maximum iterations=750, initial guess is zero<br>
      tolerances:  relative=1e-07, absolute=1e-50, divergence=10000<br>
      left preconditioning<br>
      using PRECONDITIONED norm type for convergence test<br>
    PC Object: 1 MPI processes<br>
      type: sor<br>
        SOR: type = local_symmetric, iterations = 1, local iterations =
    1, omega = 1<br>
      linear system matrix = precond matrix:<br>
      Matrix Object:   1 MPI processes<br>
        type: seqaij<br>
        rows=1375920, cols=1375920<br>
        total: nonzeros=17671714, allocated nonzeros=17671714<br>
        total number of mallocs used during MatSetValues calls =0<br>
          not using I-node routines<br>
    <br>
    Using Petsc Development HG revision:
    a4dae06b4d05ef5b78a9a9aa2cbc31b2b158834f  HG Date: Wed Feb 08
    11:29:52 2012 -0600<br>
    Configure options:
    --with-petsc-arch=openmpi-intel-complex-release-f-mkl
    --with-fortran-interfaces=1 --download-superlu
    --download-superlu_dist --download-mumps --download-parmetis
    --download-ptscotch --download-metis
    --with-scalapack-lib=/opt/intel/Compiler/11.1/072/mkl/lib/em64t/libmkl_scalapack_lp64.a
    --with-scalapack-include=/opt/intel/Compiler/11.1/072/mkl/include
    --with-blacs-lib=/opt/intel/Compiler/11.1/072/mkl/lib/em64t/libmkl_blacs_openmpi_lp64.a
    --with-blacs-include=/opt/intel/Compiler/11.1/072/mkl/include
    --with-mpi-dir=/opt/mpi/intel/openmpi-1.4.2
    --with-scalar-type=complex
    --with-blas-lapack-lib="[/opt/intel/Compiler/11.1/072/mkl/lib/em64t/libmkl_intel_lp64.a,/opt/intel/Compiler/11.1/072/mkl/lib/em64t/libmkl_intel_thread.a,/opt/intel/Compiler/11.1/072/mkl/lib/em64t/libmkl_core.a,/opt/intel/Compiler/11.1/072/lib/intel64/libiomp5.a]"
    --with-precision=double --with-x=0 --with-debugging=0<br>
    <br>
    <br>
    Well, two version compiled with different lines, but still I don't
    think this is the reason...<br>
    Where actually to look at?<br>
    <br>
    Thanks.<br>
    <br>
    On 22.03.2012 15:42, Jed Brown wrote:
    <blockquote
cite="mid:CAM9tzSmgr34Sxk+K1jVhageGvGLifHw+RSc662QF+sdKzKwZAg@mail.gmail.com"
      type="cite">
      <div class="gmail_quote">On Thu, Mar 22, 2012 at 04:23, Alexander
        Grayver <span dir="ltr"><<a moz-do-not-send="true"
            href="mailto:agrayver@gfz-potsdam.de">agrayver@gfz-potsdam.de</a>></span>
        wrote:<br>
        <blockquote class="gmail_quote" style="margin: 0pt 0pt 0pt
          0.8ex; border-left: 1px solid rgb(204, 204, 204);
          padding-left: 1ex;">
          I've got the following error when applying bicg+sor to my
          problem:<br>
          <br>
          mt-soft/solveTest> ./solveTest -ksp_view
          -ksp_converged_reason -ksp_monitor_true_residual -log_summary
          -mat_type aij -ksp_rtol 1.0e-7 -ksp_type bicg -pc_type sor
          -ksp_max_it 750<br>
          [0]PETSC ERROR: --------------------- Error Message
          ------------------------------------<br>
          [0]PETSC ERROR: No support for this operation for this object
          type!<br>
          [0]PETSC ERROR: PC does not have apply transpose!<br>
          [0]PETSC ERROR: ------------------------------------------------------------------------<br>
          [0]PETSC ERROR: Petsc Development HG revision:
          59ca71b85d784abbe22f12c34ffcb2ccc6dc68b0  HG Date: Tue Mar 20
          01:05:13 2012 -0500<br>
          [0]PETSC ERROR: See docs/changes/index.html for recent
          updates.<br>
          [0]PETSC ERROR: See docs/faq.html for hints about trouble
          shooting.<br>
          [0]PETSC ERROR: See docs/index.html for manual pages.<br>
          [0]PETSC ERROR: ------------------------------------------------------------------------<br>
          [0]PETSC ERROR: Configure options --with-petsc-arch=openmpi-intel-complex-release-c
          --with-mpi-dir=/opt/mpi/intel/openmpi-1.4.2
          --with-scalar-type=complex --with-precision=double
          --with-blas-lapack-dir=/usr/local/lib --with-x=0
          --with-debugging=0<br>
          [0]PETSC ERROR: ------------------------------------------------------------------------<br>
          [0]PETSC ERROR: PCApplyTranspose() line 515 in
          /home/mt/agrayver/lib/petsc-dev/src/ksp/pc/interface/precon.c<br>
          [0]PETSC ERROR: KSPSolve_BiCG() line 55 in
          /home/mt/agrayver/lib/petsc-dev/src/ksp/ksp/impls/bicg/bicg.c<br>
          [0]PETSC ERROR: KSPSolve() line 434 in
          /home/mt/agrayver/lib/petsc-dev/src/ksp/ksp/interface/itfunc.c<br>
          [0]PETSC ERROR: main() line 114 in /home/solveTest.c<br>
          <br>
          Any ideas?<br>
        </blockquote>
        <div><br>
        </div>
        <div>PCApplyTranspose_SOR is not implemented. It is
          unfortunately not an operation that is efficient to implement
          in-place like SOR.</div>
      </div>
    </blockquote>
    <br>
    <br>
    <pre class="moz-signature" cols="72">-- 
Regards,
Alexander</pre>
  </body>
</html>