<br><br><div class="gmail_quote">On Mon, Aug 18, 2008 at 11:24 PM, Barry Smith <span dir="ltr"><<a href="mailto:bsmith@mcs.anl.gov">bsmith@mcs.anl.gov</a>></span> wrote:<br><blockquote class="gmail_quote" style="margin:0 0 0 .8ex;border-left:1px #ccc solid;padding-left:1ex;">
<div class="Ih2E3d"><br>On Aug 18, 2008, at 12:35 AM, Shengyong wrote:<br><br>
<blockquote class="gmail_quote" style="PADDING-LEFT: 1ex; MARGIN: 0px 0px 0px 0.8ex; BORDER-LEFT: #ccc 1px solid">hi, Barry<br><br>Thanks for your kindly reply!<br><br>Here I report some experiments accoording to your hints.<br>
<br>-pc_type sor -pc_sor_local_symmetric _ksp_type cg failed.<br></blockquote><br></div> What does failed mean? Converged for a while then stagnated? Diverged (the residual norm got larger and larger)? Never converged at all?<br>
<blockquote class="gmail_quote" style="PADDING-LEFT: 1ex; MARGIN: 0px 0px 0px 0.8ex; BORDER-LEFT: #ccc 1px solid"><br>icc(1) also failed.<br></blockquote><br> What does failed mean?<br><br> I suggest running with -pc_type lu (keep the -ksp_type gmres) and see what happens? Does you simulation run fine for an unlimited number<br>
of timesteps? If not, how does it fail?<br><font color="#888888"><br> Barry</font>
<div>
<div></div>
<div class="Wj3C7c"><br><br>
<blockquote class="gmail_quote" style="PADDING-LEFT: 1ex; MARGIN: 0px 0px 0px 0.8ex; BORDER-LEFT: #ccc 1px solid"><br><br>When using -ksp_monitor_true _residual with icc(0), I have found the precond residual is osillation around some value about 1.06e-004, the true residual norm almost staying at 7.128 e-004. The ||Ae||/||Ax|| also stagnent at 6.3e-005.<br>
<br>After the maximum number of iterations (=2000) reached, the iteration fails. Even when I set iteration number to 10000, it seems that petsc also fails.<br><br>Below is some resiual information near iteration number 2000 when with ksp_monitor_true_residual.<br>
<br><br>1990 KSP preconditioned resid norm 1.064720311837e-004 true resid norm 7.1284721<br>18425e-004 ||Ae||/||Ax|| 6.302380221818e-005<br><br>1991 KSP preconditioned resid norm 1.062055494352e-004 true resid norm 7.1281202<br>
17324e-004 ||Ae||/||Ax|| 6.302069101215e-005<br><br>1992 KSP preconditioned resid norm 1.061228895583e-004 true resid norm 7.1277740<br>15661e-004 ||Ae||/||Ax|| 6.301763019565e-005<br><br>1993 KSP preconditioned resid norm 1.062165148129e-004 true resid norm 7.1274335<br>
10277e-004 ||Ae||/||Ax|| 6.301461974073e-005<br><br>1994 KSP preconditioned resid norm 1.064780917764e-004 true resid norm 7.1270986<br>90168e-004 ||Ae||/||Ax|| 6.301165955010e-005<br><br>1995 KSP preconditioned resid norm 1.068986431546e-004 true resid norm 7.1267695<br>
37853e-004 ||Ae||/||Ax|| 6.300874946922e-005<br><br>1996 KSP preconditioned resid norm 1.074687043135e-004 true resid norm 7.1264460<br>30395e-004 ||Ae||/||Ax|| 6.300588929530e-005<br><br>1997 KSP preconditioned resid norm 1.081784773720e-004 true resid norm 7.1261281<br>
40328e-004 ||Ae||/||Ax|| 6.300307878551e-005<br><br>1998 KSP preconditioned resid norm 1.090179775109e-004 true resid norm 7.1258158<br>36472e-004 ||Ae||/||Ax|| 6.300031766417e-005<br><br>1999 KSP preconditioned resid norm 1.099771672684e-004 true resid norm 7.1255090<br>
84603e-004 ||Ae||/||Ax|| 6.299760562872e-005<br><br>2000 KSP preconditioned resid norm 1.110460758301e-004 true resid norm 7.1252078<br>48108e-004 ||Ae||/||Ax|| 6.299494235544e-005<br><br>On Sun, Aug 17, 2008 at 10:32 PM, Barry Smith <<a href="mailto:bsmith@mcs.anl.gov" target="_blank">bsmith@mcs.anl.gov</a>> wrote:<br>
<br> Try using -pc_type sor -pc_sor_local_symmetric -ksp_type cg<br><br> Also try running the original icc one with the additional option -ksp_monitor_true_residual, see if funky stuff starts to happen.<br><br> You could also try adding -pc_factor_levels 1 to try ICC(1) instead of ICC(0).<br>
<br> Your code looks fine, I don't see a problem there,<br><br> Barry<br><br><br> Here is my guess, as the simulation proceeds the variable coefficient problem changes enough so that the ICC produces<br>a badly scaled preconditioner that messes up the iterative method. I see this on occasion and don't have a good fix, the shift<br>
positive definite helps sometimes but not always.<br><br><br><br><br>On Aug 17, 2008, at 3:36 AM, Shengyong wrote:<br><br>Hi,<br><br>I am still struggling to use petsc to solve variable coefficient poisson problems (which orinates from a multi-phase(liquid-gas two phase flow with sharp interface method, the density ratio is 1000, and with surface tension) flow problem) successively.<br>
<br>Initially petsc produces good results with icc pc_type , cg iterative method and with _pc_factor_shift_positive_define flag. I follow petsc's null space method to constrain the singular property of coefficient matrix. However, after several time steps good results of simulation, the KSP Residual Norm suddenly reaches to a number greater than 1000. I guess that petsc diverges. I have also tried to swith to other types of methods, e.g. to gmeres, it just behaves similar to cg method. However, when I use my previous self-coded SOR iterative solver, it produces nice results. And I have tested the same petsc solver class for a single phase driven cavity flow problem, it also produces nice results.<br>
<br>It seems that I have missed something important setup procedure in my solver class. could anyone to point me the problem ? I have attached large part of the code below:<br><br>//in Header<br>class CPETScPoissonSolver<br>
{<br> typedef struct {<br> Vec x,b; //x, b<br> Mat A; //A<br> KSP ksp; //Krylov subspace preconditioner<br> PC pc;<br> MatNullSpace nullspace;<br>
PetscInt l, m, n;//L, M, N<br> } UserContext;<br><br>public:<br> CPETScPoissonSolver(int argc, char** argv);<br> ~CPETScPoissonSolver(void);<br><br> //........<br><br>private:<br><br> //Yale Sparse Matrix format matrix<br>
PetscScalar* A;<br> PetscInt * I;<br> PetscInt * J;<br><br> // Number of Nonzero Element<br> PetscInt nnz;<br> //grid step<br> PetscInt L, M, N;<br> UserContext userctx;<br>
private:<br> bool FirstTime;<br>};<br><br>//in cpp<br>static char helpPetscPoisson[] = "PETSc class Solves a variable Poisson problem with Null Space Method.\n\n";<br><br>CPETScPoissonSolver::CPETScPoissonSolver(int argc, char** argv)<br>
{<br> PetscInitialize(&argc, &argv, (char*)0, helpPetscPoisson);<br> FirstTime=true;<br>}<br>CPETScPoissonSolver::~CPETScPoissonSolver(void)<br>{<br> PetscFinalize();<br>}<br>......<br>void CPETScPoissonSolver::SetAIJ(PetscScalar *a, PetscInt *i, PetscInt *j, PetscInt Nnz)<br>
{<br> A= a; I=i; J=j; nnz = Nnz;<br>}<br><br>PetscErrorCode CPETScPoissonSolver::UserInitializeLinearSolver()<br>{<br> PetscErrorCode ierr = 0;<br> PetscInt Num = L*M*N;<br><br> //Since we use successive solvers, so in the second time step we must deallocate the original matrix then setup a new one<br>
if(FirstTime==true)<br> {<br> ierr = MatCreateSeqAIJWithArrays(PETSC_COMM_SELF, Num, Num, I, J, A, &userctx.A); CHKERRQ(ierr);<br> }<br> else<br> {<br> FirstTime = false;<br> ierr = MatDestroy(userctx.A);CHKERRQ(ierr);<br>
ierr = MatCreateSeqAIJWithArrays(PETSC_COMM_SELF, Num, Num, I, J, A, &userctx.A); CHKERRQ(ierr);<br> }<br><br> if(FirstTime==true)<br> {<br><br> ierr = VecCreateSeqWithArray(PETSC_COMM_SELF,Num,PETSC_NULL,&userctx.b);CHKERRQ(ierr);<br>
ierr = VecDuplicate(userctx.b,&userctx.x);CHKERRQ(ierr);<br> ierr = MatNullSpaceCreate(PETSC_COMM_SELF, PETSC_TRUE, 0, PETSC_NULL, &userctx.nullspace); CHKERRQ(ierr);<br> ierr = KSPCreate(PETSC_COMM_SELF,&userctx.ksp);CHKERRQ(ierr);<br>
/*Set Null Space for KSP*/<br> ierr = KSPSetNullSpace(userctx.ksp, userctx.nullspace);CHKERRQ(ierr);<br> }<br> return 0;<br>}<br><br><br>PetscErrorCode CPETScPoissonSolver::UserSetBX(PetscScalar *x, PetscScalar *b)<br>
{<br> PetscErrorCode ierr ;<br> //below code we must set it every time step<br> ierr = VecPlaceArray(userctx.x,x);CHKERRQ(ierr);<br> ierr = VecPlaceArray(userctx.b,b);CHKERRQ(ierr);<br> ierr = MatNullSpaceRemove(userctx.nullspace,userctx.b, PETSC_NULL);CHKERRQ(ierr);<br>
return 0;<br>}<br><br>PetscInt CPETScPoissonSolver::UserSolve()<br>{<br> PetscErrorCode ierr;<br> ierr = KSPSetOperators(userctx.ksp,userctx.A,userctx.A,SAME_NONZERO_PATTERN);CHKERRQ(ierr);<br> ierr = KSPSetType(userctx.ksp, KSPCG);<br>
ierr = KSPSetInitialGuessNonzero(userctx.ksp, PETSC_TRUE);<br> ierr = KSPGetPC(userctx.ksp,&userctx.pc);CHKERRQ(ierr);<br> ierr = PCSetType(userctx.pc,PCICC);CHKERRQ(ierr);<br> ierr = PCFactorSetShiftPd(userctx.pc, PETSC_TRUE);<br>
ierr = KSPSetTolerances(userctx.ksp,1.e-4,PETSC_DEFAULT,PETSC_DEFAULT,2000);<br> ierr = KSPSetFromOptions(userctx.ksp);CHKERRQ(ierr);<br> /* - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - -<br>
Solve the linear system<br> - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - */<br> ierr = KSPSolve(userctx.ksp,userctx.b,userctx.x);CHKERRQ(ierr);<br><br> ierr = VecResetArray(userctx.x);CHKERRQ(ierr);<br>
ierr = VecResetArray(userctx.b);CHKERRQ(ierr);<br><br> return 0;<br>}<br><br>PetscErrorCode CPETScPoissonSolver::ReleaseMem()<br>{<br> PetscErrorCode ierr;<br> ierr = KSPDestroy(userctx.ksp);CHKERRQ(ierr);<br>
ierr = VecDestroy(userctx.x); CHKERRQ(ierr);<br> ierr = VecDestroy(userctx.b); CHKERRQ(ierr);<br> ierr = MatDestroy(userctx.A); CHKERRQ(ierr);<br> ierr = MatNullSpaceDestroy(userctx.nullspace); CHKERRQ(ierr);<br>
return 0;<br>}<br><br>Thanks very much!<br><br><br>-- <br>Pang Shengyong<br>Solidification Simulation Lab,<br>State Key Lab of Mould & Die Technology,<br>Huazhong Univ. of Sci. & Tech. China<br><br><br><br><br>
-- <br>Pang Shengyong<br>Solidification Simulation Lab,<br>State Key Lab of Mould & Die Technology,<br>Huazhong Univ. of Sci. & Tech. China<br></blockquote><br></div></div></blockquote></div><br><br clear="all"><br>
-- <br>Pang Shengyong<br>Solidification Simulation Lab, <br>State Key Lab of Mould & Die Technology,<br>Huazhong Univ. of Sci. & Tech. China<br>