<div dir="ltr">Hi Jose,<div><br></div><div>Thank you very much. The instruction you gave is of particular useful. I do think I can use deflation feature to reduce my subspace a lot. I will let you know if I made further progress.</div>
<div><br></div><div>One more thing to check with you. I am right now using bJacobi as preconditioner. I know it is among one of the simplest preconditioners, but it turns out it gives faster convergence than SOR (maybe ASM). Is Hypre or pARMS designed to be suited for FEM model, and will usually be faster than bjacobi?   </div>
<div><br></div><div>Since Hypre or pARMS is external packages not readily available in SLEPc, I need ask my server administrator to install it. So it is a not-so-easy job for me.</div><div><br></div><div>Thank you so much,</div>
<div>Jifeng Zhao</div><div><br></div><div>Best regards,</div><div>Jifeng Zhao</div></div><div class="gmail_extra"><br><br><div class="gmail_quote">On Thu, Jun 19, 2014 at 3:32 AM, Jose E. Roman <span dir="ltr"><<a href="mailto:jroman@dsic.upv.es" target="_blank">jroman@dsic.upv.es</a>></span> wrote:<br>
<blockquote class="gmail_quote" style="margin:0 0 0 .8ex;border-left:1px #ccc solid;padding-left:1ex"><br>
El 18/06/2014, a las 22:37, jifeng zhao escribió:<br>
<div><div class="h5"><br>
> Hello,<br>
><br>
> I am a new user to Petsc + Slepc. I am trying to extract natural frequency of a finite element model using Slepc. The way I do is<br>
><br>
> 1. Use other software (Abaqus) to assembly the stiffness and mass matrix.<br>
> 2. Use Slepc to solve a generalized eigenvalue problem. K x = lamda M x<br>
> with K, M being stiffness and mass matrix.<br>
><br>
> I wrote my petsc/slepc code based on the examples on slepc web. They all compiled and working correctly.<br>
><br>
> The question I am raising here is what solvers (solver combinations) should I use to be most efficient?<br>
><br>
> Right now I am using "bcgsl" (BiCGSTAB) solver for KSP linear solvers, "JD" jacobian-davison for eigen solver, and "bjacobi" (block jacobian) for my preconditioner. It works, but I need it to be more efficient to solver big problem (millions of degrees of freedom). I am not an expert on knowing how these solvers are different at all!<br>

><br>
> Is there anybody who has extracted eigenvalues of a Finite element model using Slepc? How can I possibly improve the performance?<br>
><br>
> Thank you!<br>
><br>
> PS: my running command reads like:<br>
> ./eigen_solver -f1 petsc_stiff1.dat -f2 petsc_mass1.dat -eps_nev 40 -eps_target 0.0 -eps_type jd -st_type precond -st_ksp_type bcgsl -st_pc_type bjacobi -st_ksp_rtol 0.001 -eps_tol 1e-5 -eps_harmonic<br>
><br>
> --<br>
> Jifeng Zhao<br>
> PhD candidate at Northwestern University, US<br>
> Theoretical and Applied Mechanics Program<br>
<br>
</div></div>For not-too-difficult problems, GD will be faster than JD. The options for tuning Davidson solvers are described here: <a href="http://dx.doi.org/10.1145/2543696" target="_blank">http://dx.doi.org/10.1145/2543696</a><br>

You can also try a preconditioner provided by an external package such as Hypre or pARMS.<br>
<br>
Alternatively, you can try with Krylov-Schur and exact shift-and-invert (with a parallel external solver such as MUMPS).<br>
<span class="HOEnZb"><font color="#888888"><br>
Jose<br>
<br>
</font></span></blockquote></div><br><br clear="all"><div><br></div>-- <br><div dir="ltr">Jifeng Zhao<div>PhD candidate at Northwestern University, US</div><div>Theoretical and Applied Mechanics Program</div></div>
</div>