Actual source code: snes.c

petsc-3.12.0 2019-09-29
Report Typos and Errors
  1:  #include <petsc/private/snesimpl.h>
  2:  #include <petscdmshell.h>
  3:  #include <petscdraw.h>
  4:  #include <petscds.h>
  5:  #include <petscdmadaptor.h>
  6:  #include <petscconvest.h>

  8: PetscBool         SNESRegisterAllCalled = PETSC_FALSE;
  9: PetscFunctionList SNESList              = NULL;

 11: /* Logging support */
 12: PetscClassId  SNES_CLASSID, DMSNES_CLASSID;
 13: PetscLogEvent SNES_Solve, SNES_Setup, SNES_FunctionEval, SNES_JacobianEval, SNES_NGSEval, SNES_NGSFuncEval, SNES_NPCSolve, SNES_ObjectiveEval;

 15: /*@
 16:    SNESSetErrorIfNotConverged - Causes SNESSolve() to generate an error if the solver has not converged.

 18:    Logically Collective on SNES

 20:    Input Parameters:
 21: +  snes - iterative context obtained from SNESCreate()
 22: -  flg - PETSC_TRUE indicates you want the error generated

 24:    Options database keys:
 25: .  -snes_error_if_not_converged : this takes an optional truth value (0/1/no/yes/true/false)

 27:    Level: intermediate

 29:    Notes:
 30:     Normally PETSc continues if a linear solver fails to converge, you can call SNESGetConvergedReason() after a SNESSolve()
 31:     to determine if it has converged.

 33: .seealso: SNESGetErrorIfNotConverged(), KSPGetErrorIfNotConverged(), KSPSetErrorIFNotConverged()
 34: @*/
 35: PetscErrorCode  SNESSetErrorIfNotConverged(SNES snes,PetscBool flg)
 36: {
 40:   snes->errorifnotconverged = flg;
 41:   return(0);
 42: }

 44: /*@
 45:    SNESGetErrorIfNotConverged - Will SNESSolve() generate an error if the solver does not converge?

 47:    Not Collective

 49:    Input Parameter:
 50: .  snes - iterative context obtained from SNESCreate()

 52:    Output Parameter:
 53: .  flag - PETSC_TRUE if it will generate an error, else PETSC_FALSE

 55:    Level: intermediate

 57: .seealso:  SNESSetErrorIfNotConverged(), KSPGetErrorIfNotConverged(), KSPSetErrorIFNotConverged()
 58: @*/
 59: PetscErrorCode  SNESGetErrorIfNotConverged(SNES snes,PetscBool  *flag)
 60: {
 64:   *flag = snes->errorifnotconverged;
 65:   return(0);
 66: }

 68: /*@
 69:     SNESSetAlwaysComputesFinalResidual - does the SNES always compute the residual at the final solution?

 71:    Logically Collective on SNES

 73:     Input Parameters:
 74: +   snes - the shell SNES
 75: -   flg - is the residual computed?

 77:    Level: advanced

 79: .seealso: SNESGetAlwaysComputesFinalResidual()
 80: @*/
 81: PetscErrorCode  SNESSetAlwaysComputesFinalResidual(SNES snes, PetscBool flg)
 82: {
 85:   snes->alwayscomputesfinalresidual = flg;
 86:   return(0);
 87: }

 89: /*@
 90:     SNESGetAlwaysComputesFinalResidual - does the SNES always compute the residual at the final solution?

 92:    Logically Collective on SNES

 94:     Input Parameter:
 95: .   snes - the shell SNES

 97:     Output Parameter:
 98: .   flg - is the residual computed?

100:    Level: advanced

102: .seealso: SNESSetAlwaysComputesFinalResidual()
103: @*/
104: PetscErrorCode  SNESGetAlwaysComputesFinalResidual(SNES snes, PetscBool *flg)
105: {
108:   *flg = snes->alwayscomputesfinalresidual;
109:   return(0);
110: }

112: /*@
113:    SNESSetFunctionDomainError - tells SNES that the input vector to your SNESFunction is not
114:      in the functions domain. For example, negative pressure.

116:    Logically Collective on SNES

118:    Input Parameters:
119: .  snes - the SNES context

121:    Level: advanced

123: .seealso: SNESCreate(), SNESSetFunction(), SNESFunction
124: @*/
125: PetscErrorCode  SNESSetFunctionDomainError(SNES snes)
126: {
129:   if (snes->errorifnotconverged) SETERRQ(PETSC_COMM_SELF,PETSC_ERR_ARG_OUTOFRANGE,"User code indicates input vector is not in the function domain");
130:   snes->domainerror = PETSC_TRUE;
131:   return(0);
132: }

134: /*@
135:    SNESSetJacobianDomainError - tells SNES that computeJacobian does not make sense any more. For example there is a negative element transformation.

137:    Logically Collective on SNES

139:    Input Parameters:
140: .  snes - the SNES context

142:    Level: advanced

144: .seealso: SNESCreate(), SNESSetFunction(), SNESFunction(), SNESSetFunctionDomainError()
145: @*/
146: PetscErrorCode SNESSetJacobianDomainError(SNES snes)
147: {
150:   if (snes->errorifnotconverged) SETERRQ(PETSC_COMM_SELF,PETSC_ERR_ARG_OUTOFRANGE,"User code indicates computeJacobian does not make sense");
151:   snes->jacobiandomainerror = PETSC_TRUE;
152:   return(0);
153: }

155: /*@
156:    SNESSetCheckJacobianDomainError - if or not to check jacobian domain error after each Jacobian evaluation. By default, we check Jacobian domain error
157:    in the debug mode, and do not check it in the optimized mode.

159:    Logically Collective on SNES

161:    Input Parameters:
162: +  snes - the SNES context
163: -  flg  - indicates if or not to check jacobian domain error after each Jacobian evaluation

165:    Level: advanced

167: .seealso: SNESCreate(), SNESSetFunction(), SNESFunction(), SNESSetFunctionDomainError(), SNESGetCheckJacobianDomainError()
168: @*/
169: PetscErrorCode SNESSetCheckJacobianDomainError(SNES snes, PetscBool flg)
170: {
173:   snes->checkjacdomainerror = flg;
174:   return(0);
175: }

177: /*@
178:    SNESGetCheckJacobianDomainError - Get an indicator whether or not we are checking Jacobian domain errors after each Jacobian evaluation.

180:    Logically Collective on SNES

182:    Input Parameters:
183: .  snes - the SNES context

185:    Output Parameters:
186: .  flg  - PETSC_FALSE indicates that we don't check jacobian domain errors after each Jacobian evaluation

188:    Level: advanced

190: .seealso: SNESCreate(), SNESSetFunction(), SNESFunction(), SNESSetFunctionDomainError(), SNESSetCheckJacobianDomainError()
191: @*/
192: PetscErrorCode SNESGetCheckJacobianDomainError(SNES snes, PetscBool *flg)
193: {
197:   *flg = snes->checkjacdomainerror;
198:   return(0);
199: }

201: /*@
202:    SNESGetFunctionDomainError - Gets the status of the domain error after a call to SNESComputeFunction;

204:    Logically Collective on SNES

206:    Input Parameters:
207: .  snes - the SNES context

209:    Output Parameters:
210: .  domainerror - Set to PETSC_TRUE if there's a domain error; PETSC_FALSE otherwise.

212:    Level: advanced

214: .seealso: SNESSetFunctionDomainError(), SNESComputeFunction()
215: @*/
216: PetscErrorCode  SNESGetFunctionDomainError(SNES snes, PetscBool *domainerror)
217: {
221:   *domainerror = snes->domainerror;
222:   return(0);
223: }

225: /*@
226:    SNESGetJacobianDomainError - Gets the status of the Jacobian domain error after a call to SNESComputeJacobian;

228:    Logically Collective on SNES

230:    Input Parameters:
231: .  snes - the SNES context

233:    Output Parameters:
234: .  domainerror - Set to PETSC_TRUE if there's a jacobian domain error; PETSC_FALSE otherwise.

236:    Level: advanced

238: .seealso: SNESSetFunctionDomainError(), SNESComputeFunction(),SNESGetFunctionDomainError()
239: @*/
240: PetscErrorCode SNESGetJacobianDomainError(SNES snes, PetscBool *domainerror)
241: {
245:   *domainerror = snes->jacobiandomainerror;
246:   return(0);
247: }

249: /*@C
250:   SNESLoad - Loads a SNES that has been stored in binary  with SNESView().

252:   Collective on PetscViewer

254:   Input Parameters:
255: + newdm - the newly loaded SNES, this needs to have been created with SNESCreate() or
256:            some related function before a call to SNESLoad().
257: - viewer - binary file viewer, obtained from PetscViewerBinaryOpen()

259:    Level: intermediate

261:   Notes:
262:    The type is determined by the data in the file, any type set into the SNES before this call is ignored.

264:   Notes for advanced users:
265:   Most users should not need to know the details of the binary storage
266:   format, since SNESLoad() and TSView() completely hide these details.
267:   But for anyone who's interested, the standard binary matrix storage
268:   format is
269: .vb
270:      has not yet been determined
271: .ve

273: .seealso: PetscViewerBinaryOpen(), SNESView(), MatLoad(), VecLoad()
274: @*/
275: PetscErrorCode  SNESLoad(SNES snes, PetscViewer viewer)
276: {
278:   PetscBool      isbinary;
279:   PetscInt       classid;
280:   char           type[256];
281:   KSP            ksp;
282:   DM             dm;
283:   DMSNES         dmsnes;

288:   PetscObjectTypeCompare((PetscObject)viewer,PETSCVIEWERBINARY,&isbinary);
289:   if (!isbinary) SETERRQ(PETSC_COMM_SELF,PETSC_ERR_ARG_WRONG,"Invalid viewer; open viewer with PetscViewerBinaryOpen()");

291:   PetscViewerBinaryRead(viewer,&classid,1,NULL,PETSC_INT);
292:   if (classid != SNES_FILE_CLASSID) SETERRQ(PetscObjectComm((PetscObject)snes),PETSC_ERR_ARG_WRONG,"Not SNES next in file");
293:   PetscViewerBinaryRead(viewer,type,256,NULL,PETSC_CHAR);
294:   SNESSetType(snes, type);
295:   if (snes->ops->load) {
296:     (*snes->ops->load)(snes,viewer);
297:   }
298:   SNESGetDM(snes,&dm);
299:   DMGetDMSNES(dm,&dmsnes);
300:   DMSNESLoad(dmsnes,viewer);
301:   SNESGetKSP(snes,&ksp);
302:   KSPLoad(ksp,viewer);
303:   return(0);
304: }

306:  #include <petscdraw.h>
307: #if defined(PETSC_HAVE_SAWS)
308:  #include <petscviewersaws.h>
309: #endif

311: PETSC_EXTERN PetscErrorCode SNESComputeJacobian_DMDA(SNES,Vec,Mat,Mat,void*);

313: /*@C
314:    SNESView - Prints the SNES data structure.

316:    Collective on SNES

318:    Input Parameters:
319: +  SNES - the SNES context
320: -  viewer - visualization context

322:    Options Database Key:
323: .  -snes_view - Calls SNESView() at end of SNESSolve()

325:    Notes:
326:    The available visualization contexts include
327: +     PETSC_VIEWER_STDOUT_SELF - standard output (default)
328: -     PETSC_VIEWER_STDOUT_WORLD - synchronized standard
329:          output where only the first processor opens
330:          the file.  All other processors send their
331:          data to the first processor to print.

333:    The user can open an alternative visualization context with
334:    PetscViewerASCIIOpen() - output to a specified file.

336:    Level: beginner

338: .seealso: PetscViewerASCIIOpen()
339: @*/
340: PetscErrorCode  SNESView(SNES snes,PetscViewer viewer)
341: {
342:   SNESKSPEW      *kctx;
344:   KSP            ksp;
345:   SNESLineSearch linesearch;
346:   PetscBool      iascii,isstring,isbinary,isdraw;
347:   DMSNES         dmsnes;
348: #if defined(PETSC_HAVE_SAWS)
349:   PetscBool      issaws;
350: #endif

354:   if (!viewer) {
355:     PetscViewerASCIIGetStdout(PetscObjectComm((PetscObject)snes),&viewer);
356:   }

360:   PetscObjectTypeCompare((PetscObject)viewer,PETSCVIEWERASCII,&iascii);
361:   PetscObjectTypeCompare((PetscObject)viewer,PETSCVIEWERSTRING,&isstring);
362:   PetscObjectTypeCompare((PetscObject)viewer,PETSCVIEWERBINARY,&isbinary);
363:   PetscObjectTypeCompare((PetscObject)viewer,PETSCVIEWERDRAW,&isdraw);
364: #if defined(PETSC_HAVE_SAWS)
365:   PetscObjectTypeCompare((PetscObject)viewer,PETSCVIEWERSAWS,&issaws);
366: #endif
367:   if (iascii) {
368:     SNESNormSchedule normschedule;
369:     DM               dm;
370:     PetscErrorCode   (*cJ)(SNES,Vec,Mat,Mat,void*);
371:     void             *ctx;
372:     const char       *pre = "";

374:     PetscObjectPrintClassNamePrefixType((PetscObject)snes,viewer);
375:     if (!snes->setupcalled) {
376:       PetscViewerASCIIPrintf(viewer,"  SNES has not been set up so information may be incomplete\n");
377:     }
378:     if (snes->ops->view) {
379:       PetscViewerASCIIPushTab(viewer);
380:       (*snes->ops->view)(snes,viewer);
381:       PetscViewerASCIIPopTab(viewer);
382:     }
383:     PetscViewerASCIIPrintf(viewer,"  maximum iterations=%D, maximum function evaluations=%D\n",snes->max_its,snes->max_funcs);
384:     PetscViewerASCIIPrintf(viewer,"  tolerances: relative=%g, absolute=%g, solution=%g\n",(double)snes->rtol,(double)snes->abstol,(double)snes->stol);
385:     if (snes->usesksp) {
386:       PetscViewerASCIIPrintf(viewer,"  total number of linear solver iterations=%D\n",snes->linear_its);
387:     }
388:     PetscViewerASCIIPrintf(viewer,"  total number of function evaluations=%D\n",snes->nfuncs);
389:     SNESGetNormSchedule(snes, &normschedule);
390:     if (normschedule > 0) {PetscViewerASCIIPrintf(viewer,"  norm schedule %s\n",SNESNormSchedules[normschedule]);}
391:     if (snes->gridsequence) {
392:       PetscViewerASCIIPrintf(viewer,"  total number of grid sequence refinements=%D\n",snes->gridsequence);
393:     }
394:     if (snes->ksp_ewconv) {
395:       kctx = (SNESKSPEW*)snes->kspconvctx;
396:       if (kctx) {
397:         PetscViewerASCIIPrintf(viewer,"  Eisenstat-Walker computation of KSP relative tolerance (version %D)\n",kctx->version);
398:         PetscViewerASCIIPrintf(viewer,"    rtol_0=%g, rtol_max=%g, threshold=%g\n",(double)kctx->rtol_0,(double)kctx->rtol_max,(double)kctx->threshold);
399:         PetscViewerASCIIPrintf(viewer,"    gamma=%g, alpha=%g, alpha2=%g\n",(double)kctx->gamma,(double)kctx->alpha,(double)kctx->alpha2);
400:       }
401:     }
402:     if (snes->lagpreconditioner == -1) {
403:       PetscViewerASCIIPrintf(viewer,"  Preconditioned is never rebuilt\n");
404:     } else if (snes->lagpreconditioner > 1) {
405:       PetscViewerASCIIPrintf(viewer,"  Preconditioned is rebuilt every %D new Jacobians\n",snes->lagpreconditioner);
406:     }
407:     if (snes->lagjacobian == -1) {
408:       PetscViewerASCIIPrintf(viewer,"  Jacobian is never rebuilt\n");
409:     } else if (snes->lagjacobian > 1) {
410:       PetscViewerASCIIPrintf(viewer,"  Jacobian is rebuilt every %D SNES iterations\n",snes->lagjacobian);
411:     }
412:     SNESGetDM(snes,&dm);
413:     DMSNESGetJacobian(dm,&cJ,&ctx);
414:     if (snes->mf_operator) {
415:       PetscViewerASCIIPrintf(viewer,"  Jacobian is applied matrix-free with differencing\n");
416:       pre  = "Preconditioning ";
417:     }
418:     if (cJ == SNESComputeJacobianDefault) {
419:       PetscViewerASCIIPrintf(viewer,"  %sJacobian is built using finite differences one column at a time\n",pre);
420:     } else if (cJ == SNESComputeJacobianDefaultColor) {
421:       PetscViewerASCIIPrintf(viewer,"  %sJacobian is built using finite differences with coloring\n",pre);
422:     /* it slightly breaks data encapsulation for access the DMDA information directly */
423:     } else if (cJ == SNESComputeJacobian_DMDA) {
424:       MatFDColoring fdcoloring;
425:       PetscObjectQuery((PetscObject)dm,"DMDASNES_FDCOLORING",(PetscObject*)&fdcoloring);
426:       if (fdcoloring) {
427:         PetscViewerASCIIPrintf(viewer,"  %sJacobian is built using colored finite differences on a DMDA\n",pre);
428:       } else {
429:         PetscViewerASCIIPrintf(viewer,"  %sJacobian is built using a DMDA local Jacobian\n",pre);
430:       }
431:     } else if (snes->mf) {
432:       PetscViewerASCIIPrintf(viewer,"  Jacobian is applied matrix-free with differencing, no explict Jacobian\n");
433:     }
434:   } else if (isstring) {
435:     const char *type;
436:     SNESGetType(snes,&type);
437:     PetscViewerStringSPrintf(viewer," SNESType: %-7.7s",type);
438:     if (snes->ops->view) {(*snes->ops->view)(snes,viewer);}
439:   } else if (isbinary) {
440:     PetscInt    classid = SNES_FILE_CLASSID;
441:     MPI_Comm    comm;
442:     PetscMPIInt rank;
443:     char        type[256];

445:     PetscObjectGetComm((PetscObject)snes,&comm);
446:     MPI_Comm_rank(comm,&rank);
447:     if (!rank) {
448:       PetscViewerBinaryWrite(viewer,&classid,1,PETSC_INT,PETSC_FALSE);
449:       PetscStrncpy(type,((PetscObject)snes)->type_name,sizeof(type));
450:       PetscViewerBinaryWrite(viewer,type,sizeof(type),PETSC_CHAR,PETSC_FALSE);
451:     }
452:     if (snes->ops->view) {
453:       (*snes->ops->view)(snes,viewer);
454:     }
455:   } else if (isdraw) {
456:     PetscDraw draw;
457:     char      str[36];
458:     PetscReal x,y,bottom,h;

460:     PetscViewerDrawGetDraw(viewer,0,&draw);
461:     PetscDrawGetCurrentPoint(draw,&x,&y);
462:     PetscStrncpy(str,"SNES: ",sizeof(str));
463:     PetscStrlcat(str,((PetscObject)snes)->type_name,sizeof(str));
464:     PetscDrawStringBoxed(draw,x,y,PETSC_DRAW_BLUE,PETSC_DRAW_BLACK,str,NULL,&h);
465:     bottom = y - h;
466:     PetscDrawPushCurrentPoint(draw,x,bottom);
467:     if (snes->ops->view) {
468:       (*snes->ops->view)(snes,viewer);
469:     }
470: #if defined(PETSC_HAVE_SAWS)
471:   } else if (issaws) {
472:     PetscMPIInt rank;
473:     const char *name;

475:     PetscObjectGetName((PetscObject)snes,&name);
476:     MPI_Comm_rank(PETSC_COMM_WORLD,&rank);
477:     if (!((PetscObject)snes)->amsmem && !rank) {
478:       char       dir[1024];

480:       PetscObjectViewSAWs((PetscObject)snes,viewer);
481:       PetscSNPrintf(dir,1024,"/PETSc/Objects/%s/its",name);
482:       PetscStackCallSAWs(SAWs_Register,(dir,&snes->iter,1,SAWs_READ,SAWs_INT));
483:       if (!snes->conv_hist) {
484:         SNESSetConvergenceHistory(snes,NULL,NULL,PETSC_DECIDE,PETSC_TRUE);
485:       }
486:       PetscSNPrintf(dir,1024,"/PETSc/Objects/%s/conv_hist",name);
487:       PetscStackCallSAWs(SAWs_Register,(dir,snes->conv_hist,10,SAWs_READ,SAWs_DOUBLE));
488:     }
489: #endif
490:   }
491:   if (snes->linesearch) {
492:     SNESGetLineSearch(snes, &linesearch);
493:     PetscViewerASCIIPushTab(viewer);
494:     SNESLineSearchView(linesearch, viewer);
495:     PetscViewerASCIIPopTab(viewer);
496:   }
497:   if (snes->npc && snes->usesnpc) {
498:     PetscViewerASCIIPushTab(viewer);
499:     SNESView(snes->npc, viewer);
500:     PetscViewerASCIIPopTab(viewer);
501:   }
502:   PetscViewerASCIIPushTab(viewer);
503:   DMGetDMSNES(snes->dm,&dmsnes);
504:   DMSNESView(dmsnes, viewer);
505:   PetscViewerASCIIPopTab(viewer);
506:   if (snes->usesksp) {
507:     SNESGetKSP(snes,&ksp);
508:     PetscViewerASCIIPushTab(viewer);
509:     KSPView(ksp,viewer);
510:     PetscViewerASCIIPopTab(viewer);
511:   }
512:   if (isdraw) {
513:     PetscDraw draw;
514:     PetscViewerDrawGetDraw(viewer,0,&draw);
515:     PetscDrawPopCurrentPoint(draw);
516:   }
517:   return(0);
518: }

520: /*
521:   We retain a list of functions that also take SNES command
522:   line options. These are called at the end SNESSetFromOptions()
523: */
524: #define MAXSETFROMOPTIONS 5
525: static PetscInt numberofsetfromoptions;
526: static PetscErrorCode (*othersetfromoptions[MAXSETFROMOPTIONS])(SNES);

528: /*@C
529:   SNESAddOptionsChecker - Adds an additional function to check for SNES options.

531:   Not Collective

533:   Input Parameter:
534: . snescheck - function that checks for options

536:   Level: developer

538: .seealso: SNESSetFromOptions()
539: @*/
540: PetscErrorCode  SNESAddOptionsChecker(PetscErrorCode (*snescheck)(SNES))
541: {
543:   if (numberofsetfromoptions >= MAXSETFROMOPTIONS) SETERRQ1(PETSC_COMM_SELF,PETSC_ERR_ARG_OUTOFRANGE, "Too many options checkers, only %D allowed", MAXSETFROMOPTIONS);
544:   othersetfromoptions[numberofsetfromoptions++] = snescheck;
545:   return(0);
546: }

548: PETSC_INTERN PetscErrorCode SNESDefaultMatrixFreeCreate2(SNES,Vec,Mat*);

550: static PetscErrorCode SNESSetUpMatrixFree_Private(SNES snes, PetscBool hasOperator, PetscInt version)
551: {
552:   Mat            J;
554:   MatNullSpace   nullsp;


559:   if (!snes->vec_func && (snes->jacobian || snes->jacobian_pre)) {
560:     Mat A = snes->jacobian, B = snes->jacobian_pre;
561:     MatCreateVecs(A ? A : B, NULL,&snes->vec_func);
562:   }

564:   if (version == 1) {
565:     MatCreateSNESMF(snes,&J);
566:     MatMFFDSetOptionsPrefix(J,((PetscObject)snes)->prefix);
567:     MatSetFromOptions(J);
568:   } else if (version == 2) {
569:     if (!snes->vec_func) SETERRQ(PETSC_COMM_SELF,PETSC_ERR_ARG_WRONGSTATE,"SNESSetFunction() must be called first");
570: #if !defined(PETSC_USE_COMPLEX) && !defined(PETSC_USE_REAL_SINGLE) && !defined(PETSC_USE_REAL___FLOAT128) && !defined(PETSC_USE_REAL___FP16)
571:     SNESDefaultMatrixFreeCreate2(snes,snes->vec_func,&J);
572: #else
573:     SETERRQ(PETSC_COMM_SELF,PETSC_ERR_SUP, "matrix-free operator rutines (version 2)");
574: #endif
575:   } else SETERRQ(PETSC_COMM_SELF,PETSC_ERR_ARG_OUTOFRANGE, "matrix-free operator rutines, only version 1 and 2");

577:   /* attach any user provided null space that was on Amat to the newly created matrix free matrix */
578:   if (snes->jacobian) {
579:     MatGetNullSpace(snes->jacobian,&nullsp);
580:     if (nullsp) {
581:       MatSetNullSpace(J,nullsp);
582:     }
583:   }

585:   PetscInfo1(snes,"Setting default matrix-free operator routines (version %D)\n", version);
586:   if (hasOperator) {

588:     /* This version replaces the user provided Jacobian matrix with a
589:        matrix-free version but still employs the user-provided preconditioner matrix. */
590:     SNESSetJacobian(snes,J,0,0,0);
591:   } else {
592:     /* This version replaces both the user-provided Jacobian and the user-
593:      provided preconditioner Jacobian with the default matrix free version. */
594:     if ((snes->npcside== PC_LEFT) && snes->npc) {
595:       if (!snes->jacobian){SNESSetJacobian(snes,J,0,0,0);}
596:     } else {
597:       KSP       ksp;
598:       PC        pc;
599:       PetscBool match;

601:       SNESSetJacobian(snes,J,J,MatMFFDComputeJacobian,0);
602:       /* Force no preconditioner */
603:       SNESGetKSP(snes,&ksp);
604:       KSPGetPC(ksp,&pc);
605:       PetscObjectTypeCompare((PetscObject)pc,PCSHELL,&match);
606:       if (!match) {
607:         PetscInfo(snes,"Setting default matrix-free preconditioner routines\nThat is no preconditioner is being used\n");
608:         PCSetType(pc,PCNONE);
609:       }
610:     }
611:   }
612:   MatDestroy(&J);
613:   return(0);
614: }

616: static PetscErrorCode DMRestrictHook_SNESVecSol(DM dmfine,Mat Restrict,Vec Rscale,Mat Inject,DM dmcoarse,void *ctx)
617: {
618:   SNES           snes = (SNES)ctx;
620:   Vec            Xfine,Xfine_named = NULL,Xcoarse;

623:   if (PetscLogPrintInfo) {
624:     PetscInt finelevel,coarselevel,fineclevel,coarseclevel;
625:     DMGetRefineLevel(dmfine,&finelevel);
626:     DMGetCoarsenLevel(dmfine,&fineclevel);
627:     DMGetRefineLevel(dmcoarse,&coarselevel);
628:     DMGetCoarsenLevel(dmcoarse,&coarseclevel);
629:     PetscInfo4(dmfine,"Restricting SNES solution vector from level %D-%D to level %D-%D\n",finelevel,fineclevel,coarselevel,coarseclevel);
630:   }
631:   if (dmfine == snes->dm) Xfine = snes->vec_sol;
632:   else {
633:     DMGetNamedGlobalVector(dmfine,"SNESVecSol",&Xfine_named);
634:     Xfine = Xfine_named;
635:   }
636:   DMGetNamedGlobalVector(dmcoarse,"SNESVecSol",&Xcoarse);
637:   if (Inject) {
638:     MatRestrict(Inject,Xfine,Xcoarse);
639:   } else {
640:     MatRestrict(Restrict,Xfine,Xcoarse);
641:     VecPointwiseMult(Xcoarse,Xcoarse,Rscale);
642:   }
643:   DMRestoreNamedGlobalVector(dmcoarse,"SNESVecSol",&Xcoarse);
644:   if (Xfine_named) {DMRestoreNamedGlobalVector(dmfine,"SNESVecSol",&Xfine_named);}
645:   return(0);
646: }

648: static PetscErrorCode DMCoarsenHook_SNESVecSol(DM dm,DM dmc,void *ctx)
649: {

653:   DMCoarsenHookAdd(dmc,DMCoarsenHook_SNESVecSol,DMRestrictHook_SNESVecSol,ctx);
654:   return(0);
655: }

657: /* This may be called to rediscretize the operator on levels of linear multigrid. The DM shuffle is so the user can
658:  * safely call SNESGetDM() in their residual evaluation routine. */
659: static PetscErrorCode KSPComputeOperators_SNES(KSP ksp,Mat A,Mat B,void *ctx)
660: {
661:   SNES           snes = (SNES)ctx;
663:   Vec            X,Xnamed = NULL;
664:   DM             dmsave;
665:   void           *ctxsave;
666:   PetscErrorCode (*jac)(SNES,Vec,Mat,Mat,void*) = NULL;

669:   dmsave = snes->dm;
670:   KSPGetDM(ksp,&snes->dm);
671:   if (dmsave == snes->dm) X = snes->vec_sol; /* We are on the finest level */
672:   else {                                     /* We are on a coarser level, this vec was initialized using a DM restrict hook */
673:     DMGetNamedGlobalVector(snes->dm,"SNESVecSol",&Xnamed);
674:     X    = Xnamed;
675:     SNESGetJacobian(snes,NULL,NULL,&jac,&ctxsave);
676:     /* If the DM's don't match up, the MatFDColoring context needed for the jacobian won't match up either -- fixit. */
677:     if (jac == SNESComputeJacobianDefaultColor) {
678:       SNESSetJacobian(snes,NULL,NULL,SNESComputeJacobianDefaultColor,0);
679:     }
680:   }
681:   /* Make sure KSP DM has the Jacobian computation routine */
682:   {
683:     DMSNES sdm;

685:     DMGetDMSNES(snes->dm, &sdm);
686:     if (!sdm->ops->computejacobian) {
687:       DMCopyDMSNES(dmsave, snes->dm);
688:     }
689:   }
690:   /* Compute the operators */
691:   SNESComputeJacobian(snes,X,A,B);
692:   /* Put the previous context back */
693:   if (snes->dm != dmsave && jac == SNESComputeJacobianDefaultColor) {
694:     SNESSetJacobian(snes,NULL,NULL,jac,ctxsave);
695:   }

697:   if (Xnamed) {DMRestoreNamedGlobalVector(snes->dm,"SNESVecSol",&Xnamed);}
698:   snes->dm = dmsave;
699:   return(0);
700: }

702: /*@
703:    SNESSetUpMatrices - ensures that matrices are available for SNES, to be called by SNESSetUp_XXX()

705:    Collective

707:    Input Arguments:
708: .  snes - snes to configure

710:    Level: developer

712: .seealso: SNESSetUp()
713: @*/
714: PetscErrorCode SNESSetUpMatrices(SNES snes)
715: {
717:   DM             dm;
718:   DMSNES         sdm;

721:   SNESGetDM(snes,&dm);
722:   DMGetDMSNES(dm,&sdm);
723:   if (!sdm->ops->computejacobian) SETERRQ(PetscObjectComm((PetscObject)snes),PETSC_ERR_PLIB,"DMSNES not properly configured");
724:   else if (!snes->jacobian && snes->mf) {
725:     Mat  J;
726:     void *functx;
727:     MatCreateSNESMF(snes,&J);
728:     MatMFFDSetOptionsPrefix(J,((PetscObject)snes)->prefix);
729:     MatSetFromOptions(J);
730:     SNESGetFunction(snes,NULL,NULL,&functx);
731:     SNESSetJacobian(snes,J,J,0,0);
732:     MatDestroy(&J);
733:   } else if (snes->mf_operator && !snes->jacobian_pre && !snes->jacobian) {
734:     Mat J,B;
735:     MatCreateSNESMF(snes,&J);
736:     MatMFFDSetOptionsPrefix(J,((PetscObject)snes)->prefix);
737:     MatSetFromOptions(J);
738:     DMCreateMatrix(snes->dm,&B);
739:     /* sdm->computejacobian was already set to reach here */
740:     SNESSetJacobian(snes,J,B,NULL,NULL);
741:     MatDestroy(&J);
742:     MatDestroy(&B);
743:   } else if (!snes->jacobian_pre) {
744:     PetscErrorCode (*nspconstr)(DM, PetscInt, MatNullSpace *);
745:     PetscDS          prob;
746:     Mat              J, B;
747:     MatNullSpace     nullspace = NULL;
748:     PetscBool        hasPrec   = PETSC_FALSE;
749:     PetscInt         Nf;

751:     J    = snes->jacobian;
752:     DMGetDS(dm, &prob);
753:     if (prob) {PetscDSHasJacobianPreconditioner(prob, &hasPrec);}
754:     if (J)            {PetscObjectReference((PetscObject) J);}
755:     else if (hasPrec) {DMCreateMatrix(snes->dm, &J);}
756:     DMCreateMatrix(snes->dm, &B);
757:     PetscDSGetNumFields(prob, &Nf);
758:     DMGetNullSpaceConstructor(snes->dm, Nf, &nspconstr);
759:     if (nspconstr) (*nspconstr)(snes->dm, -1, &nullspace);
760:     MatSetNullSpace(B, nullspace);
761:     MatNullSpaceDestroy(&nullspace);
762:     SNESSetJacobian(snes, J ? J : B, B, NULL, NULL);
763:     MatDestroy(&J);
764:     MatDestroy(&B);
765:   }
766:   {
767:     KSP ksp;
768:     SNESGetKSP(snes,&ksp);
769:     KSPSetComputeOperators(ksp,KSPComputeOperators_SNES,snes);
770:     DMCoarsenHookAdd(snes->dm,DMCoarsenHook_SNESVecSol,DMRestrictHook_SNESVecSol,snes);
771:   }
772:   return(0);
773: }

775: /*@C
776:    SNESMonitorSetFromOptions - Sets a monitor function and viewer appropriate for the type indicated by the user

778:    Collective on SNES

780:    Input Parameters:
781: +  snes - SNES object you wish to monitor
782: .  name - the monitor type one is seeking
783: .  help - message indicating what monitoring is done
784: .  manual - manual page for the monitor
785: .  monitor - the monitor function
786: -  monitorsetup - a function that is called once ONLY if the user selected this monitor that may set additional features of the SNES or PetscViewer objects

788:    Level: developer

790: .seealso: PetscOptionsGetViewer(), PetscOptionsGetReal(), PetscOptionsHasName(), PetscOptionsGetString(),
791:           PetscOptionsGetIntArray(), PetscOptionsGetRealArray(), PetscOptionsBool()
792:           PetscOptionsInt(), PetscOptionsString(), PetscOptionsReal(), PetscOptionsBool(),
793:           PetscOptionsName(), PetscOptionsBegin(), PetscOptionsEnd(), PetscOptionsHead(),
794:           PetscOptionsStringArray(),PetscOptionsRealArray(), PetscOptionsScalar(),
795:           PetscOptionsBoolGroupBegin(), PetscOptionsBoolGroup(), PetscOptionsBoolGroupEnd(),
796:           PetscOptionsFList(), PetscOptionsEList()
797: @*/
798: PetscErrorCode  SNESMonitorSetFromOptions(SNES snes,const char name[],const char help[], const char manual[],PetscErrorCode (*monitor)(SNES,PetscInt,PetscReal,PetscViewerAndFormat*),PetscErrorCode (*monitorsetup)(SNES,PetscViewerAndFormat*))
799: {
800:   PetscErrorCode    ierr;
801:   PetscViewer       viewer;
802:   PetscViewerFormat format;
803:   PetscBool         flg;

806:   PetscOptionsGetViewer(PetscObjectComm((PetscObject)snes),((PetscObject) snes)->options,((PetscObject)snes)->prefix,name,&viewer,&format,&flg);
807:   if (flg) {
808:     PetscViewerAndFormat *vf;
809:     PetscViewerAndFormatCreate(viewer,format,&vf);
810:     PetscObjectDereference((PetscObject)viewer);
811:     if (monitorsetup) {
812:       (*monitorsetup)(snes,vf);
813:     }
814:     SNESMonitorSet(snes,(PetscErrorCode (*)(SNES,PetscInt,PetscReal,void*))monitor,vf,(PetscErrorCode (*)(void**))PetscViewerAndFormatDestroy);
815:   }
816:   return(0);
817: }

819: /*@
820:    SNESSetFromOptions - Sets various SNES and KSP parameters from user options.

822:    Collective on SNES

824:    Input Parameter:
825: .  snes - the SNES context

827:    Options Database Keys:
828: +  -snes_type <type> - newtonls, newtontr, ngmres, ncg, nrichardson, qn, vi, fas, SNESType for complete list
829: .  -snes_stol - convergence tolerance in terms of the norm
830:                 of the change in the solution between steps
831: .  -snes_atol <abstol> - absolute tolerance of residual norm
832: .  -snes_rtol <rtol> - relative decrease in tolerance norm from initial
833: .  -snes_divergence_tolerance <divtol> - if the residual goes above divtol*rnorm0, exit with divergence
834: .  -snes_force_iteration <force> - force SNESSolve() to take at least one iteration
835: .  -snes_max_it <max_it> - maximum number of iterations
836: .  -snes_max_funcs <max_funcs> - maximum number of function evaluations
837: .  -snes_max_fail <max_fail> - maximum number of line search failures allowed before stopping, default is none
838: .  -snes_max_linear_solve_fail - number of linear solver failures before SNESSolve() stops
839: .  -snes_lag_preconditioner <lag> - how often preconditioner is rebuilt (use -1 to never rebuild)
840: .  -snes_lag_jacobian <lag> - how often Jacobian is rebuilt (use -1 to never rebuild)
841: .  -snes_trtol <trtol> - trust region tolerance
842: .  -snes_no_convergence_test - skip convergence test in nonlinear
843:                                solver; hence iterations will continue until max_it
844:                                or some other criterion is reached. Saves expense
845:                                of convergence test
846: .  -snes_monitor [ascii][:filename][:viewer format] - prints residual norm at each iteration. if no filename given prints to stdout
847: .  -snes_monitor_solution [ascii binary draw][:filename][:viewer format] - plots solution at each iteration
848: .  -snes_monitor_residual [ascii binary draw][:filename][:viewer format] - plots residual (not its norm) at each iteration
849: .  -snes_monitor_solution_update [ascii binary draw][:filename][:viewer format] - plots update to solution at each iteration
850: .  -snes_monitor_lg_residualnorm - plots residual norm at each iteration
851: .  -snes_monitor_lg_range - plots residual norm at each iteration
852: .  -snes_fd - use finite differences to compute Jacobian; very slow, only for testing
853: .  -snes_fd_color - use finite differences with coloring to compute Jacobian
854: .  -snes_mf_ksp_monitor - if using matrix-free multiply then print h at each KSP iteration
855: .  -snes_converged_reason - print the reason for convergence/divergence after each solve
856: -  -npc_snes_type <type> - the SNES type to use as a nonlinear preconditioner

858:     Options Database for Eisenstat-Walker method:
859: +  -snes_ksp_ew - use Eisenstat-Walker method for determining linear system convergence
860: .  -snes_ksp_ew_version ver - version of  Eisenstat-Walker method
861: .  -snes_ksp_ew_rtol0 <rtol0> - Sets rtol0
862: .  -snes_ksp_ew_rtolmax <rtolmax> - Sets rtolmax
863: .  -snes_ksp_ew_gamma <gamma> - Sets gamma
864: .  -snes_ksp_ew_alpha <alpha> - Sets alpha
865: .  -snes_ksp_ew_alpha2 <alpha2> - Sets alpha2
866: -  -snes_ksp_ew_threshold <threshold> - Sets threshold

868:    Notes:
869:    To see all options, run your program with the -help option or consult
870:    Users-Manual: ch_snes

872:    Level: beginner

874: .seealso: SNESSetOptionsPrefix(), SNESResetFromOptions()
875: @*/
876: PetscErrorCode  SNESSetFromOptions(SNES snes)
877: {
878:   PetscBool      flg,pcset,persist,set;
879:   PetscInt       i,indx,lag,grids;
880:   const char     *deft        = SNESNEWTONLS;
881:   const char     *convtests[] = {"default","skip"};
882:   SNESKSPEW      *kctx        = NULL;
883:   char           type[256], monfilename[PETSC_MAX_PATH_LEN];
885:   PCSide         pcside;
886:   const char     *optionsprefix;

890:   SNESRegisterAll();
891:   PetscObjectOptionsBegin((PetscObject)snes);
892:   if (((PetscObject)snes)->type_name) deft = ((PetscObject)snes)->type_name;
893:   PetscOptionsFList("-snes_type","Nonlinear solver method","SNESSetType",SNESList,deft,type,256,&flg);
894:   if (flg) {
895:     SNESSetType(snes,type);
896:   } else if (!((PetscObject)snes)->type_name) {
897:     SNESSetType(snes,deft);
898:   }
899:   PetscOptionsReal("-snes_stol","Stop if step length less than","SNESSetTolerances",snes->stol,&snes->stol,NULL);
900:   PetscOptionsReal("-snes_atol","Stop if function norm less than","SNESSetTolerances",snes->abstol,&snes->abstol,NULL);

902:   PetscOptionsReal("-snes_rtol","Stop if decrease in function norm less than","SNESSetTolerances",snes->rtol,&snes->rtol,NULL);
903:   PetscOptionsReal("-snes_divergence_tolerance","Stop if residual norm increases by this factor","SNESSetDivergenceTolerance",snes->divtol,&snes->divtol,NULL);
904:   PetscOptionsInt("-snes_max_it","Maximum iterations","SNESSetTolerances",snes->max_its,&snes->max_its,NULL);
905:   PetscOptionsInt("-snes_max_funcs","Maximum function evaluations","SNESSetTolerances",snes->max_funcs,&snes->max_funcs,NULL);
906:   PetscOptionsInt("-snes_max_fail","Maximum nonlinear step failures","SNESSetMaxNonlinearStepFailures",snes->maxFailures,&snes->maxFailures,NULL);
907:   PetscOptionsInt("-snes_max_linear_solve_fail","Maximum failures in linear solves allowed","SNESSetMaxLinearSolveFailures",snes->maxLinearSolveFailures,&snes->maxLinearSolveFailures,NULL);
908:   PetscOptionsBool("-snes_error_if_not_converged","Generate error if solver does not converge","SNESSetErrorIfNotConverged",snes->errorifnotconverged,&snes->errorifnotconverged,NULL);
909:   PetscOptionsBool("-snes_force_iteration","Force SNESSolve() to take at least one iteration","SNESSetForceIteration",snes->forceiteration,&snes->forceiteration,NULL);
910:   PetscOptionsBool("-snes_check_jacobian_domain_error","Check Jacobian domain error after Jacobian evaluation","SNESCheckJacobianDomainError",snes->checkjacdomainerror,&snes->checkjacdomainerror,NULL);

912:   PetscOptionsInt("-snes_lag_preconditioner","How often to rebuild preconditioner","SNESSetLagPreconditioner",snes->lagpreconditioner,&lag,&flg);
913:   if (flg) {
914:     SNESSetLagPreconditioner(snes,lag);
915:   }
916:   PetscOptionsBool("-snes_lag_preconditioner_persists","Preconditioner lagging through multiple solves","SNESSetLagPreconditionerPersists",snes->lagjac_persist,&persist,&flg);
917:   if (flg) {
918:     SNESSetLagPreconditionerPersists(snes,persist);
919:   }
920:   PetscOptionsInt("-snes_lag_jacobian","How often to rebuild Jacobian","SNESSetLagJacobian",snes->lagjacobian,&lag,&flg);
921:   if (flg) {
922:     SNESSetLagJacobian(snes,lag);
923:   }
924:   PetscOptionsBool("-snes_lag_jacobian_persists","Jacobian lagging through multiple solves","SNESSetLagJacobianPersists",snes->lagjac_persist,&persist,&flg);
925:   if (flg) {
926:     SNESSetLagJacobianPersists(snes,persist);
927:   }

929:   PetscOptionsInt("-snes_grid_sequence","Use grid sequencing to generate initial guess","SNESSetGridSequence",snes->gridsequence,&grids,&flg);
930:   if (flg) {
931:     SNESSetGridSequence(snes,grids);
932:   }

934:   PetscOptionsEList("-snes_convergence_test","Convergence test","SNESSetConvergenceTest",convtests,2,"default",&indx,&flg);
935:   if (flg) {
936:     switch (indx) {
937:     case 0: SNESSetConvergenceTest(snes,SNESConvergedDefault,NULL,NULL); break;
938:     case 1: SNESSetConvergenceTest(snes,SNESConvergedSkip,NULL,NULL);    break;
939:     }
940:   }

942:   PetscOptionsEList("-snes_norm_schedule","SNES Norm schedule","SNESSetNormSchedule",SNESNormSchedules,5,"function",&indx,&flg);
943:   if (flg) { SNESSetNormSchedule(snes,(SNESNormSchedule)indx); }

945:   PetscOptionsEList("-snes_function_type","SNES Norm schedule","SNESSetFunctionType",SNESFunctionTypes,2,"unpreconditioned",&indx,&flg);
946:   if (flg) { SNESSetFunctionType(snes,(SNESFunctionType)indx); }

948:   kctx = (SNESKSPEW*)snes->kspconvctx;

950:   PetscOptionsBool("-snes_ksp_ew","Use Eisentat-Walker linear system convergence test","SNESKSPSetUseEW",snes->ksp_ewconv,&snes->ksp_ewconv,NULL);

952:   PetscOptionsInt("-snes_ksp_ew_version","Version 1, 2 or 3","SNESKSPSetParametersEW",kctx->version,&kctx->version,NULL);
953:   PetscOptionsReal("-snes_ksp_ew_rtol0","0 <= rtol0 < 1","SNESKSPSetParametersEW",kctx->rtol_0,&kctx->rtol_0,NULL);
954:   PetscOptionsReal("-snes_ksp_ew_rtolmax","0 <= rtolmax < 1","SNESKSPSetParametersEW",kctx->rtol_max,&kctx->rtol_max,NULL);
955:   PetscOptionsReal("-snes_ksp_ew_gamma","0 <= gamma <= 1","SNESKSPSetParametersEW",kctx->gamma,&kctx->gamma,NULL);
956:   PetscOptionsReal("-snes_ksp_ew_alpha","1 < alpha <= 2","SNESKSPSetParametersEW",kctx->alpha,&kctx->alpha,NULL);
957:   PetscOptionsReal("-snes_ksp_ew_alpha2","alpha2","SNESKSPSetParametersEW",kctx->alpha2,&kctx->alpha2,NULL);
958:   PetscOptionsReal("-snes_ksp_ew_threshold","0 < threshold < 1","SNESKSPSetParametersEW",kctx->threshold,&kctx->threshold,NULL);

960:   flg  = PETSC_FALSE;
961:   PetscOptionsBool("-snes_monitor_cancel","Remove all monitors","SNESMonitorCancel",flg,&flg,&set);
962:   if (set && flg) {SNESMonitorCancel(snes);}

964:   SNESMonitorSetFromOptions(snes,"-snes_monitor","Monitor norm of function","SNESMonitorDefault",SNESMonitorDefault,NULL);
965:   SNESMonitorSetFromOptions(snes,"-snes_monitor_short","Monitor norm of function with fewer digits","SNESMonitorDefaultShort",SNESMonitorDefaultShort,NULL);
966:   SNESMonitorSetFromOptions(snes,"-snes_monitor_range","Monitor range of elements of function","SNESMonitorRange",SNESMonitorRange,NULL);

968:   SNESMonitorSetFromOptions(snes,"-snes_monitor_ratio","Monitor ratios of the norm of function for consecutive steps","SNESMonitorRatio",SNESMonitorRatio,SNESMonitorRatioSetUp);
969:   SNESMonitorSetFromOptions(snes,"-snes_monitor_field","Monitor norm of function (split into fields)","SNESMonitorDefaultField",SNESMonitorDefaultField,NULL);
970:   SNESMonitorSetFromOptions(snes,"-snes_monitor_solution","View solution at each iteration","SNESMonitorSolution",SNESMonitorSolution,NULL);
971:   SNESMonitorSetFromOptions(snes,"-snes_monitor_solution_update","View correction at each iteration","SNESMonitorSolutionUpdate",SNESMonitorSolutionUpdate,NULL);
972:   SNESMonitorSetFromOptions(snes,"-snes_monitor_residual","View residual at each iteration","SNESMonitorResidual",SNESMonitorResidual,NULL);
973:   SNESMonitorSetFromOptions(snes,"-snes_monitor_jacupdate_spectrum","Print the change in the spectrum of the Jacobian","SNESMonitorJacUpdateSpectrum",SNESMonitorJacUpdateSpectrum,NULL);
974:   SNESMonitorSetFromOptions(snes,"-snes_monitor_fields","Monitor norm of function per field","SNESMonitorSet",SNESMonitorFields,NULL);

976:   PetscOptionsString("-snes_monitor_python","Use Python function","SNESMonitorSet",0,monfilename,PETSC_MAX_PATH_LEN,&flg);
977:   if (flg) {PetscPythonMonitorSet((PetscObject)snes,monfilename);}

979:   flg  = PETSC_FALSE;
980:   PetscOptionsBool("-snes_monitor_lg_residualnorm","Plot function norm at each iteration","SNESMonitorLGResidualNorm",flg,&flg,NULL);
981:   if (flg) {
982:     PetscDrawLG ctx;

984:     SNESMonitorLGCreate(PetscObjectComm((PetscObject)snes),NULL,NULL,PETSC_DECIDE,PETSC_DECIDE,400,300,&ctx);
985:     SNESMonitorSet(snes,SNESMonitorLGResidualNorm,ctx,(PetscErrorCode (*)(void**))PetscDrawLGDestroy);
986:   }
987:   flg  = PETSC_FALSE;
988:   PetscOptionsBool("-snes_monitor_lg_range","Plot function range at each iteration","SNESMonitorLGRange",flg,&flg,NULL);
989:   if (flg) {
990:     PetscViewer ctx;

992:     PetscViewerDrawOpen(PetscObjectComm((PetscObject)snes),NULL,NULL,PETSC_DECIDE,PETSC_DECIDE,400,300,&ctx);
993:     SNESMonitorSet(snes,SNESMonitorLGRange,ctx,(PetscErrorCode (*)(void**))PetscViewerDestroy);
994:   }

996:   flg  = PETSC_FALSE;
997:   PetscOptionsBool("-snes_fd","Use finite differences (slow) to compute Jacobian","SNESComputeJacobianDefault",flg,&flg,NULL);
998:   if (flg) {
999:     void    *functx;
1000:     DM      dm;
1001:     DMSNES  sdm;
1002:     SNESGetDM(snes,&dm);
1003:     DMGetDMSNES(dm,&sdm);
1004:     sdm->jacobianctx = NULL;
1005:     SNESGetFunction(snes,NULL,NULL,&functx);
1006:     SNESSetJacobian(snes,snes->jacobian,snes->jacobian_pre,SNESComputeJacobianDefault,functx);
1007:     PetscInfo(snes,"Setting default finite difference Jacobian matrix\n");
1008:   }

1010:   flg  = PETSC_FALSE;
1011:   PetscOptionsBool("-snes_fd_function","Use finite differences (slow) to compute function from user objective","SNESObjectiveComputeFunctionDefaultFD",flg,&flg,NULL);
1012:   if (flg) {
1013:     SNESSetFunction(snes,NULL,SNESObjectiveComputeFunctionDefaultFD,NULL);
1014:   }

1016:   flg  = PETSC_FALSE;
1017:   PetscOptionsBool("-snes_fd_color","Use finite differences with coloring to compute Jacobian","SNESComputeJacobianDefaultColor",flg,&flg,NULL);
1018:   if (flg) {
1019:     DM             dm;
1020:     DMSNES         sdm;
1021:     SNESGetDM(snes,&dm);
1022:     DMGetDMSNES(dm,&sdm);
1023:     sdm->jacobianctx = NULL;
1024:     SNESSetJacobian(snes,snes->jacobian,snes->jacobian_pre,SNESComputeJacobianDefaultColor,0);
1025:     PetscInfo(snes,"Setting default finite difference coloring Jacobian matrix\n");
1026:   }

1028:   flg  = PETSC_FALSE;
1029:   PetscOptionsBool("-snes_mf_operator","Use a Matrix-Free Jacobian with user-provided preconditioner matrix","SNESSetUseMatrixFree",PETSC_FALSE,&snes->mf_operator,&flg);
1030:   if (flg && snes->mf_operator) {
1031:     snes->mf_operator = PETSC_TRUE;
1032:     snes->mf          = PETSC_TRUE;
1033:   }
1034:   flg  = PETSC_FALSE;
1035:   PetscOptionsBool("-snes_mf","Use a Matrix-Free Jacobian with no preconditioner matrix","SNESSetUseMatrixFree",PETSC_FALSE,&snes->mf,&flg);
1036:   if (!flg && snes->mf_operator) snes->mf = PETSC_TRUE;
1037:   PetscOptionsInt("-snes_mf_version","Matrix-Free routines version 1 or 2","None",snes->mf_version,&snes->mf_version,0);

1039:   flg  = PETSC_FALSE;
1040:   SNESGetNPCSide(snes,&pcside);
1041:   PetscOptionsEnum("-snes_npc_side","SNES nonlinear preconditioner side","SNESSetNPCSide",PCSides,(PetscEnum)pcside,(PetscEnum*)&pcside,&flg);
1042:   if (flg) {SNESSetNPCSide(snes,pcside);}

1044: #if defined(PETSC_HAVE_SAWS)
1045:   /*
1046:     Publish convergence information using SAWs
1047:   */
1048:   flg  = PETSC_FALSE;
1049:   PetscOptionsBool("-snes_monitor_saws","Publish SNES progress using SAWs","SNESMonitorSet",flg,&flg,NULL);
1050:   if (flg) {
1051:     void *ctx;
1052:     SNESMonitorSAWsCreate(snes,&ctx);
1053:     SNESMonitorSet(snes,SNESMonitorSAWs,ctx,SNESMonitorSAWsDestroy);
1054:   }
1055: #endif
1056: #if defined(PETSC_HAVE_SAWS)
1057:   {
1058:   PetscBool set;
1059:   flg  = PETSC_FALSE;
1060:   PetscOptionsBool("-snes_saws_block","Block for SAWs at end of SNESSolve","PetscObjectSAWsBlock",((PetscObject)snes)->amspublishblock,&flg,&set);
1061:   if (set) {
1062:     PetscObjectSAWsSetBlock((PetscObject)snes,flg);
1063:   }
1064:   }
1065: #endif

1067:   for (i = 0; i < numberofsetfromoptions; i++) {
1068:     (*othersetfromoptions[i])(snes);
1069:   }

1071:   if (snes->ops->setfromoptions) {
1072:     (*snes->ops->setfromoptions)(PetscOptionsObject,snes);
1073:   }

1075:   /* process any options handlers added with PetscObjectAddOptionsHandler() */
1076:   PetscObjectProcessOptionsHandlers(PetscOptionsObject,(PetscObject)snes);
1077:   PetscOptionsEnd();

1079:   if (snes->linesearch) {
1080:     SNESGetLineSearch(snes, &snes->linesearch);
1081:     SNESLineSearchSetFromOptions(snes->linesearch);
1082:   }

1084:   if (snes->usesksp) {
1085:     if (!snes->ksp) {SNESGetKSP(snes,&snes->ksp);}
1086:     KSPSetOperators(snes->ksp,snes->jacobian,snes->jacobian_pre);
1087:     KSPSetFromOptions(snes->ksp);
1088:   }

1090:   /* if user has set the SNES NPC type via options database, create it. */
1091:   SNESGetOptionsPrefix(snes, &optionsprefix);
1092:   PetscOptionsHasName(((PetscObject)snes)->options,optionsprefix, "-npc_snes_type", &pcset);
1093:   if (pcset && (!snes->npc)) {
1094:     SNESGetNPC(snes, &snes->npc);
1095:   }
1096:   if (snes->npc) {
1097:     SNESSetFromOptions(snes->npc);
1098:   }
1099:   snes->setfromoptionscalled++;
1100:   return(0);
1101: }

1103: /*@
1104:    SNESResetFromOptions - Sets various SNES and KSP parameters from user options ONLY if the SNES was previously set from options

1106:    Collective on SNES

1108:    Input Parameter:
1109: .  snes - the SNES context

1111:    Level: beginner

1113: .seealso: SNESSetFromOptions(), SNESSetOptionsPrefix()
1114: @*/
1115: PetscErrorCode SNESResetFromOptions(SNES snes)
1116: {

1120:   if (snes->setfromoptionscalled) {SNESSetFromOptions(snes);}
1121:   return(0);
1122: }

1124: /*@C
1125:    SNESSetComputeApplicationContext - Sets an optional function to compute a user-defined context for
1126:    the nonlinear solvers.

1128:    Logically Collective on SNES

1130:    Input Parameters:
1131: +  snes - the SNES context
1132: .  compute - function to compute the context
1133: -  destroy - function to destroy the context

1135:    Level: intermediate

1137:    Notes:
1138:    This function is currently not available from Fortran.

1140: .seealso: SNESGetApplicationContext(), SNESSetComputeApplicationContext(), SNESGetApplicationContext()
1141: @*/
1142: PetscErrorCode  SNESSetComputeApplicationContext(SNES snes,PetscErrorCode (*compute)(SNES,void**),PetscErrorCode (*destroy)(void**))
1143: {
1146:   snes->ops->usercompute = compute;
1147:   snes->ops->userdestroy = destroy;
1148:   return(0);
1149: }

1151: /*@
1152:    SNESSetApplicationContext - Sets the optional user-defined context for
1153:    the nonlinear solvers.

1155:    Logically Collective on SNES

1157:    Input Parameters:
1158: +  snes - the SNES context
1159: -  usrP - optional user context

1161:    Level: intermediate

1163:    Fortran Notes:
1164:     To use this from Fortran you must write a Fortran interface definition for this
1165:     function that tells Fortran the Fortran derived data type that you are passing in as the ctx argument.

1167: .seealso: SNESGetApplicationContext()
1168: @*/
1169: PetscErrorCode  SNESSetApplicationContext(SNES snes,void *usrP)
1170: {
1172:   KSP            ksp;

1176:   SNESGetKSP(snes,&ksp);
1177:   KSPSetApplicationContext(ksp,usrP);
1178:   snes->user = usrP;
1179:   return(0);
1180: }

1182: /*@
1183:    SNESGetApplicationContext - Gets the user-defined context for the
1184:    nonlinear solvers.

1186:    Not Collective

1188:    Input Parameter:
1189: .  snes - SNES context

1191:    Output Parameter:
1192: .  usrP - user context

1194:    Fortran Notes:
1195:     To use this from Fortran you must write a Fortran interface definition for this
1196:     function that tells Fortran the Fortran derived data type that you are passing in as the ctx argument.

1198:    Level: intermediate

1200: .seealso: SNESSetApplicationContext()
1201: @*/
1202: PetscErrorCode  SNESGetApplicationContext(SNES snes,void *usrP)
1203: {
1206:   *(void**)usrP = snes->user;
1207:   return(0);
1208: }

1210: /*@
1211:    SNESSetUseMatrixFree - indicates that SNES should use matrix free finite difference matrix vector products internally to apply
1212:                           the Jacobian.

1214:    Collective on SNES

1216:    Input Parameters:
1217: +  snes - SNES context
1218: .  mf - use matrix-free for both the Amat and Pmat used by SNESSetJacobian(), both the Amat and Pmat set in SNESSetJacobian() will be ignored
1219: -  mf_operator - use matrix-free only for the Amat used by SNESSetJacobian(), this means the user provided Pmat will continue to be used

1221:    Options Database:
1222: + -snes_mf - use matrix free for both the mat and pmat operator
1223: - -snes_mf_operator - use matrix free only for the mat operator

1225:    Level: intermediate

1227: .seealso:   SNESGetUseMatrixFree(), MatCreateSNESMF()
1228: @*/
1229: PetscErrorCode  SNESSetUseMatrixFree(SNES snes,PetscBool mf_operator,PetscBool mf)
1230: {
1235:   if (mf && !mf_operator) SETERRQ(PetscObjectComm((PetscObject)snes),PETSC_ERR_ARG_INCOMP,"If using mf must also use mf_operator");
1236:   snes->mf          = mf;
1237:   snes->mf_operator = mf_operator;
1238:   return(0);
1239: }

1241: /*@
1242:    SNESGetUseMatrixFree - indicates if the SNES uses matrix free finite difference matrix vector products to apply
1243:                           the Jacobian.

1245:    Collective on SNES

1247:    Input Parameter:
1248: .  snes - SNES context

1250:    Output Parameters:
1251: +  mf - use matrix-free for both the Amat and Pmat used by SNESSetJacobian(), both the Amat and Pmat set in SNESSetJacobian() will be ignored
1252: -  mf_operator - use matrix-free only for the Amat used by SNESSetJacobian(), this means the user provided Pmat will continue to be used

1254:    Options Database:
1255: + -snes_mf - use matrix free for both the mat and pmat operator
1256: - -snes_mf_operator - use matrix free only for the mat operator

1258:    Level: intermediate

1260: .seealso:   SNESSetUseMatrixFree(), MatCreateSNESMF()
1261: @*/
1262: PetscErrorCode  SNESGetUseMatrixFree(SNES snes,PetscBool *mf_operator,PetscBool *mf)
1263: {
1266:   if (mf)          *mf          = snes->mf;
1267:   if (mf_operator) *mf_operator = snes->mf_operator;
1268:   return(0);
1269: }

1271: /*@
1272:    SNESGetIterationNumber - Gets the number of nonlinear iterations completed
1273:    at this time.

1275:    Not Collective

1277:    Input Parameter:
1278: .  snes - SNES context

1280:    Output Parameter:
1281: .  iter - iteration number

1283:    Notes:
1284:    For example, during the computation of iteration 2 this would return 1.

1286:    This is useful for using lagged Jacobians (where one does not recompute the
1287:    Jacobian at each SNES iteration). For example, the code
1288: .vb
1289:       SNESGetIterationNumber(snes,&it);
1290:       if (!(it % 2)) {
1291:         [compute Jacobian here]
1292:       }
1293: .ve
1294:    can be used in your ComputeJacobian() function to cause the Jacobian to be
1295:    recomputed every second SNES iteration.

1297:    After the SNES solve is complete this will return the number of nonlinear iterations used.

1299:    Level: intermediate

1301: .seealso:   SNESGetLinearSolveIterations()
1302: @*/
1303: PetscErrorCode  SNESGetIterationNumber(SNES snes,PetscInt *iter)
1304: {
1308:   *iter = snes->iter;
1309:   return(0);
1310: }

1312: /*@
1313:    SNESSetIterationNumber - Sets the current iteration number.

1315:    Not Collective

1317:    Input Parameter:
1318: +  snes - SNES context
1319: -  iter - iteration number

1321:    Level: developer

1323: .seealso:   SNESGetLinearSolveIterations()
1324: @*/
1325: PetscErrorCode  SNESSetIterationNumber(SNES snes,PetscInt iter)
1326: {

1331:   PetscObjectSAWsTakeAccess((PetscObject)snes);
1332:   snes->iter = iter;
1333:   PetscObjectSAWsGrantAccess((PetscObject)snes);
1334:   return(0);
1335: }

1337: /*@
1338:    SNESGetNonlinearStepFailures - Gets the number of unsuccessful steps
1339:    attempted by the nonlinear solver.

1341:    Not Collective

1343:    Input Parameter:
1344: .  snes - SNES context

1346:    Output Parameter:
1347: .  nfails - number of unsuccessful steps attempted

1349:    Notes:
1350:    This counter is reset to zero for each successive call to SNESSolve().

1352:    Level: intermediate

1354: .seealso: SNESGetMaxLinearSolveFailures(), SNESGetLinearSolveIterations(), SNESSetMaxLinearSolveFailures(), SNESGetLinearSolveFailures(),
1355:           SNESSetMaxNonlinearStepFailures(), SNESGetMaxNonlinearStepFailures()
1356: @*/
1357: PetscErrorCode  SNESGetNonlinearStepFailures(SNES snes,PetscInt *nfails)
1358: {
1362:   *nfails = snes->numFailures;
1363:   return(0);
1364: }

1366: /*@
1367:    SNESSetMaxNonlinearStepFailures - Sets the maximum number of unsuccessful steps
1368:    attempted by the nonlinear solver before it gives up.

1370:    Not Collective

1372:    Input Parameters:
1373: +  snes     - SNES context
1374: -  maxFails - maximum of unsuccessful steps

1376:    Level: intermediate

1378: .seealso: SNESGetMaxLinearSolveFailures(), SNESGetLinearSolveIterations(), SNESSetMaxLinearSolveFailures(), SNESGetLinearSolveFailures(),
1379:           SNESGetMaxNonlinearStepFailures(), SNESGetNonlinearStepFailures()
1380: @*/
1381: PetscErrorCode  SNESSetMaxNonlinearStepFailures(SNES snes, PetscInt maxFails)
1382: {
1385:   snes->maxFailures = maxFails;
1386:   return(0);
1387: }

1389: /*@
1390:    SNESGetMaxNonlinearStepFailures - Gets the maximum number of unsuccessful steps
1391:    attempted by the nonlinear solver before it gives up.

1393:    Not Collective

1395:    Input Parameter:
1396: .  snes     - SNES context

1398:    Output Parameter:
1399: .  maxFails - maximum of unsuccessful steps

1401:    Level: intermediate

1403: .seealso: SNESGetMaxLinearSolveFailures(), SNESGetLinearSolveIterations(), SNESSetMaxLinearSolveFailures(), SNESGetLinearSolveFailures(),
1404:           SNESSetMaxNonlinearStepFailures(), SNESGetNonlinearStepFailures()

1406: @*/
1407: PetscErrorCode  SNESGetMaxNonlinearStepFailures(SNES snes, PetscInt *maxFails)
1408: {
1412:   *maxFails = snes->maxFailures;
1413:   return(0);
1414: }

1416: /*@
1417:    SNESGetNumberFunctionEvals - Gets the number of user provided function evaluations
1418:      done by SNES.

1420:    Not Collective

1422:    Input Parameter:
1423: .  snes     - SNES context

1425:    Output Parameter:
1426: .  nfuncs - number of evaluations

1428:    Level: intermediate

1430:    Notes:
1431:     Reset every time SNESSolve is called unless SNESSetCountersReset() is used.

1433: .seealso: SNESGetMaxLinearSolveFailures(), SNESGetLinearSolveIterations(), SNESSetMaxLinearSolveFailures(), SNESGetLinearSolveFailures(), SNESSetCountersReset()
1434: @*/
1435: PetscErrorCode  SNESGetNumberFunctionEvals(SNES snes, PetscInt *nfuncs)
1436: {
1440:   *nfuncs = snes->nfuncs;
1441:   return(0);
1442: }

1444: /*@
1445:    SNESGetLinearSolveFailures - Gets the number of failed (non-converged)
1446:    linear solvers.

1448:    Not Collective

1450:    Input Parameter:
1451: .  snes - SNES context

1453:    Output Parameter:
1454: .  nfails - number of failed solves

1456:    Level: intermediate

1458:    Options Database Keys:
1459: . -snes_max_linear_solve_fail <num> - The number of failures before the solve is terminated

1461:    Notes:
1462:    This counter is reset to zero for each successive call to SNESSolve().

1464: .seealso: SNESGetMaxLinearSolveFailures(), SNESGetLinearSolveIterations(), SNESSetMaxLinearSolveFailures()
1465: @*/
1466: PetscErrorCode  SNESGetLinearSolveFailures(SNES snes,PetscInt *nfails)
1467: {
1471:   *nfails = snes->numLinearSolveFailures;
1472:   return(0);
1473: }

1475: /*@
1476:    SNESSetMaxLinearSolveFailures - the number of failed linear solve attempts
1477:    allowed before SNES returns with a diverged reason of SNES_DIVERGED_LINEAR_SOLVE

1479:    Logically Collective on SNES

1481:    Input Parameters:
1482: +  snes     - SNES context
1483: -  maxFails - maximum allowed linear solve failures

1485:    Level: intermediate

1487:    Options Database Keys:
1488: . -snes_max_linear_solve_fail <num> - The number of failures before the solve is terminated

1490:    Notes:
1491:     By default this is 0; that is SNES returns on the first failed linear solve

1493: .seealso: SNESGetLinearSolveFailures(), SNESGetMaxLinearSolveFailures(), SNESGetLinearSolveIterations()
1494: @*/
1495: PetscErrorCode  SNESSetMaxLinearSolveFailures(SNES snes, PetscInt maxFails)
1496: {
1500:   snes->maxLinearSolveFailures = maxFails;
1501:   return(0);
1502: }

1504: /*@
1505:    SNESGetMaxLinearSolveFailures - gets the maximum number of linear solve failures that
1506:      are allowed before SNES terminates

1508:    Not Collective

1510:    Input Parameter:
1511: .  snes     - SNES context

1513:    Output Parameter:
1514: .  maxFails - maximum of unsuccessful solves allowed

1516:    Level: intermediate

1518:    Notes:
1519:     By default this is 1; that is SNES returns on the first failed linear solve

1521: .seealso: SNESGetLinearSolveFailures(), SNESGetLinearSolveIterations(), SNESSetMaxLinearSolveFailures(),
1522: @*/
1523: PetscErrorCode  SNESGetMaxLinearSolveFailures(SNES snes, PetscInt *maxFails)
1524: {
1528:   *maxFails = snes->maxLinearSolveFailures;
1529:   return(0);
1530: }

1532: /*@
1533:    SNESGetLinearSolveIterations - Gets the total number of linear iterations
1534:    used by the nonlinear solver.

1536:    Not Collective

1538:    Input Parameter:
1539: .  snes - SNES context

1541:    Output Parameter:
1542: .  lits - number of linear iterations

1544:    Notes:
1545:    This counter is reset to zero for each successive call to SNESSolve() unless SNESSetCountersReset() is used.

1547:    If the linear solver fails inside the SNESSolve() the iterations for that call to the linear solver are not included. If you wish to count them
1548:    then call KSPGetIterationNumber() after the failed solve.

1550:    Level: intermediate

1552: .seealso:  SNESGetIterationNumber(), SNESGetLinearSolveFailures(), SNESGetMaxLinearSolveFailures(), SNESSetCountersReset()
1553: @*/
1554: PetscErrorCode  SNESGetLinearSolveIterations(SNES snes,PetscInt *lits)
1555: {
1559:   *lits = snes->linear_its;
1560:   return(0);
1561: }

1563: /*@
1564:    SNESSetCountersReset - Sets whether or not the counters for linear iterations and function evaluations
1565:    are reset every time SNESSolve() is called.

1567:    Logically Collective on SNES

1569:    Input Parameter:
1570: +  snes - SNES context
1571: -  reset - whether to reset the counters or not

1573:    Notes:
1574:    This defaults to PETSC_TRUE

1576:    Level: developer

1578: .seealso:  SNESGetNumberFunctionEvals(), SNESGetLinearSolveIterations(), SNESGetNPC()
1579: @*/
1580: PetscErrorCode  SNESSetCountersReset(SNES snes,PetscBool reset)
1581: {
1585:   snes->counters_reset = reset;
1586:   return(0);
1587: }


1590: /*@
1591:    SNESSetKSP - Sets a KSP context for the SNES object to use

1593:    Not Collective, but the SNES and KSP objects must live on the same MPI_Comm

1595:    Input Parameters:
1596: +  snes - the SNES context
1597: -  ksp - the KSP context

1599:    Notes:
1600:    The SNES object already has its KSP object, you can obtain with SNESGetKSP()
1601:    so this routine is rarely needed.

1603:    The KSP object that is already in the SNES object has its reference count
1604:    decreased by one.

1606:    Level: developer

1608: .seealso: KSPGetPC(), SNESCreate(), KSPCreate(), SNESSetKSP()
1609: @*/
1610: PetscErrorCode  SNESSetKSP(SNES snes,KSP ksp)
1611: {

1618:   PetscObjectReference((PetscObject)ksp);
1619:   if (snes->ksp) {PetscObjectDereference((PetscObject)snes->ksp);}
1620:   snes->ksp = ksp;
1621:   return(0);
1622: }

1624: /* -----------------------------------------------------------*/
1625: /*@
1626:    SNESCreate - Creates a nonlinear solver context.

1628:    Collective

1630:    Input Parameters:
1631: .  comm - MPI communicator

1633:    Output Parameter:
1634: .  outsnes - the new SNES context

1636:    Options Database Keys:
1637: +   -snes_mf - Activates default matrix-free Jacobian-vector products,
1638:                and no preconditioning matrix
1639: .   -snes_mf_operator - Activates default matrix-free Jacobian-vector
1640:                products, and a user-provided preconditioning matrix
1641:                as set by SNESSetJacobian()
1642: -   -snes_fd - Uses (slow!) finite differences to compute Jacobian

1644:    Level: beginner

1646:    Developer Notes:
1647:     SNES always creates a KSP object even though many SNES methods do not use it. This is
1648:                     unfortunate and should be fixed at some point. The flag snes->usesksp indicates if the
1649:                     particular method does use KSP and regulates if the information about the KSP is printed
1650:                     in SNESView(). TSSetFromOptions() does call SNESSetFromOptions() which can lead to users being confused
1651:                     by help messages about meaningless SNES options.

1653:                     SNES always creates the snes->kspconvctx even though it is used by only one type. This should
1654:                     be fixed.

1656: .seealso: SNESSolve(), SNESDestroy(), SNES, SNESSetLagPreconditioner()

1658: @*/
1659: PetscErrorCode  SNESCreate(MPI_Comm comm,SNES *outsnes)
1660: {
1662:   SNES           snes;
1663:   SNESKSPEW      *kctx;

1667:   *outsnes = NULL;
1668:   SNESInitializePackage();

1670:   PetscHeaderCreate(snes,SNES_CLASSID,"SNES","Nonlinear solver","SNES",comm,SNESDestroy,SNESView);

1672:   snes->ops->converged    = SNESConvergedDefault;
1673:   snes->usesksp           = PETSC_TRUE;
1674:   snes->tolerancesset     = PETSC_FALSE;
1675:   snes->max_its           = 50;
1676:   snes->max_funcs         = 10000;
1677:   snes->norm              = 0.0;
1678:   snes->xnorm             = 0.0;
1679:   snes->ynorm             = 0.0;
1680:   snes->normschedule      = SNES_NORM_ALWAYS;
1681:   snes->functype          = SNES_FUNCTION_DEFAULT;
1682: #if defined(PETSC_USE_REAL_SINGLE)
1683:   snes->rtol              = 1.e-5;
1684: #else
1685:   snes->rtol              = 1.e-8;
1686: #endif
1687:   snes->ttol              = 0.0;
1688: #if defined(PETSC_USE_REAL_SINGLE)
1689:   snes->abstol            = 1.e-25;
1690: #else
1691:   snes->abstol            = 1.e-50;
1692: #endif
1693: #if defined(PETSC_USE_REAL_SINGLE)
1694:   snes->stol              = 1.e-5;
1695: #else
1696:   snes->stol              = 1.e-8;
1697: #endif
1698: #if defined(PETSC_USE_REAL_SINGLE)
1699:   snes->deltatol          = 1.e-6;
1700: #else
1701:   snes->deltatol          = 1.e-12;
1702: #endif
1703:   snes->divtol            = 1.e4;
1704:   snes->rnorm0            = 0;
1705:   snes->nfuncs            = 0;
1706:   snes->numFailures       = 0;
1707:   snes->maxFailures       = 1;
1708:   snes->linear_its        = 0;
1709:   snes->lagjacobian       = 1;
1710:   snes->jac_iter          = 0;
1711:   snes->lagjac_persist    = PETSC_FALSE;
1712:   snes->lagpreconditioner = 1;
1713:   snes->pre_iter          = 0;
1714:   snes->lagpre_persist    = PETSC_FALSE;
1715:   snes->numbermonitors    = 0;
1716:   snes->data              = 0;
1717:   snes->setupcalled       = PETSC_FALSE;
1718:   snes->ksp_ewconv        = PETSC_FALSE;
1719:   snes->nwork             = 0;
1720:   snes->work              = 0;
1721:   snes->nvwork            = 0;
1722:   snes->vwork             = 0;
1723:   snes->conv_hist_len     = 0;
1724:   snes->conv_hist_max     = 0;
1725:   snes->conv_hist         = NULL;
1726:   snes->conv_hist_its     = NULL;
1727:   snes->conv_hist_reset   = PETSC_TRUE;
1728:   snes->counters_reset    = PETSC_TRUE;
1729:   snes->vec_func_init_set = PETSC_FALSE;
1730:   snes->reason            = SNES_CONVERGED_ITERATING;
1731:   snes->npcside           = PC_RIGHT;
1732:   snes->setfromoptionscalled = 0;

1734:   snes->mf          = PETSC_FALSE;
1735:   snes->mf_operator = PETSC_FALSE;
1736:   snes->mf_version  = 1;

1738:   snes->numLinearSolveFailures = 0;
1739:   snes->maxLinearSolveFailures = 1;

1741:   snes->vizerotolerance = 1.e-8;
1742: #if defined(PETSC_USE_DEBUG)
1743:   snes->checkjacdomainerror = PETSC_TRUE;
1744: #else
1745:   snes->checkjacdomainerror = PETSC_FALSE;
1746: #endif

1748:   /* Set this to true if the implementation of SNESSolve_XXX does compute the residual at the final solution. */
1749:   snes->alwayscomputesfinalresidual = PETSC_FALSE;

1751:   /* Create context to compute Eisenstat-Walker relative tolerance for KSP */
1752:   PetscNewLog(snes,&kctx);

1754:   snes->kspconvctx  = (void*)kctx;
1755:   kctx->version     = 2;
1756:   kctx->rtol_0      = .3; /* Eisenstat and Walker suggest rtol_0=.5, but
1757:                              this was too large for some test cases */
1758:   kctx->rtol_last   = 0.0;
1759:   kctx->rtol_max    = .9;
1760:   kctx->gamma       = 1.0;
1761:   kctx->alpha       = .5*(1.0 + PetscSqrtReal(5.0));
1762:   kctx->alpha2      = kctx->alpha;
1763:   kctx->threshold   = .1;
1764:   kctx->lresid_last = 0.0;
1765:   kctx->norm_last   = 0.0;

1767:   *outsnes = snes;
1768:   return(0);
1769: }

1771: /*MC
1772:     SNESFunction - Functional form used to convey the nonlinear function to be solved by SNES

1774:      Synopsis:
1775:      #include "petscsnes.h"
1776:      PetscErrorCode SNESFunction(SNES snes,Vec x,Vec f,void *ctx);

1778:      Input Parameters:
1779: +     snes - the SNES context
1780: .     x    - state at which to evaluate residual
1781: -     ctx     - optional user-defined function context, passed in with SNESSetFunction()

1783:      Output Parameter:
1784: .     f  - vector to put residual (function value)

1786:    Level: intermediate

1788: .seealso:   SNESSetFunction(), SNESGetFunction()
1789: M*/

1791: /*@C
1792:    SNESSetFunction - Sets the function evaluation routine and function
1793:    vector for use by the SNES routines in solving systems of nonlinear
1794:    equations.

1796:    Logically Collective on SNES

1798:    Input Parameters:
1799: +  snes - the SNES context
1800: .  r - vector to store function value
1801: .  f - function evaluation routine; see SNESFunction for calling sequence details
1802: -  ctx - [optional] user-defined context for private data for the
1803:          function evaluation routine (may be NULL)

1805:    Notes:
1806:    The Newton-like methods typically solve linear systems of the form
1807: $      f'(x) x = -f(x),
1808:    where f'(x) denotes the Jacobian matrix and f(x) is the function.

1810:    Level: beginner

1812: .seealso: SNESGetFunction(), SNESComputeFunction(), SNESSetJacobian(), SNESSetPicard(), SNESFunction
1813: @*/
1814: PetscErrorCode  SNESSetFunction(SNES snes,Vec r,PetscErrorCode (*f)(SNES,Vec,Vec,void*),void *ctx)
1815: {
1817:   DM             dm;

1821:   if (r) {
1824:     PetscObjectReference((PetscObject)r);
1825:     VecDestroy(&snes->vec_func);

1827:     snes->vec_func = r;
1828:   }
1829:   SNESGetDM(snes,&dm);
1830:   DMSNESSetFunction(dm,f,ctx);
1831:   return(0);
1832: }


1835: /*@C
1836:    SNESSetInitialFunction - Sets the function vector to be used as the
1837:    function norm at the initialization of the method.  In some
1838:    instances, the user has precomputed the function before calling
1839:    SNESSolve.  This function allows one to avoid a redundant call
1840:    to SNESComputeFunction in that case.

1842:    Logically Collective on SNES

1844:    Input Parameters:
1845: +  snes - the SNES context
1846: -  f - vector to store function value

1848:    Notes:
1849:    This should not be modified during the solution procedure.

1851:    This is used extensively in the SNESFAS hierarchy and in nonlinear preconditioning.

1853:    Level: developer

1855: .seealso: SNESSetFunction(), SNESComputeFunction(), SNESSetInitialFunctionNorm()
1856: @*/
1857: PetscErrorCode  SNESSetInitialFunction(SNES snes, Vec f)
1858: {
1860:   Vec            vec_func;

1866:   if (snes->npcside== PC_LEFT && snes->functype == SNES_FUNCTION_PRECONDITIONED) {
1867:     snes->vec_func_init_set = PETSC_FALSE;
1868:     return(0);
1869:   }
1870:   SNESGetFunction(snes,&vec_func,NULL,NULL);
1871:   VecCopy(f, vec_func);

1873:   snes->vec_func_init_set = PETSC_TRUE;
1874:   return(0);
1875: }

1877: /*@
1878:    SNESSetNormSchedule - Sets the SNESNormSchedule used in covergence and monitoring
1879:    of the SNES method.

1881:    Logically Collective on SNES

1883:    Input Parameters:
1884: +  snes - the SNES context
1885: -  normschedule - the frequency of norm computation

1887:    Options Database Key:
1888: .  -snes_norm_schedule <none, always, initialonly, finalonly, initalfinalonly>

1890:    Notes:
1891:    Only certain SNES methods support certain SNESNormSchedules.  Most require evaluation
1892:    of the nonlinear function and the taking of its norm at every iteration to
1893:    even ensure convergence at all.  However, methods such as custom Gauss-Seidel methods
1894:    (SNESNGS) and the like do not require the norm of the function to be computed, and therfore
1895:    may either be monitored for convergence or not.  As these are often used as nonlinear
1896:    preconditioners, monitoring the norm of their error is not a useful enterprise within
1897:    their solution.

1899:    Level: developer

1901: .seealso: SNESGetNormSchedule(), SNESComputeFunction(), VecNorm(), SNESSetFunction(), SNESSetInitialFunction(), SNESNormSchedule
1902: @*/
1903: PetscErrorCode  SNESSetNormSchedule(SNES snes, SNESNormSchedule normschedule)
1904: {
1907:   snes->normschedule = normschedule;
1908:   return(0);
1909: }


1912: /*@
1913:    SNESGetNormSchedule - Gets the SNESNormSchedule used in covergence and monitoring
1914:    of the SNES method.

1916:    Logically Collective on SNES

1918:    Input Parameters:
1919: +  snes - the SNES context
1920: -  normschedule - the type of the norm used

1922:    Level: advanced

1924: .seealso: SNESSetNormSchedule(), SNESComputeFunction(), VecNorm(), SNESSetFunction(), SNESSetInitialFunction(), SNESNormSchedule
1925: @*/
1926: PetscErrorCode  SNESGetNormSchedule(SNES snes, SNESNormSchedule *normschedule)
1927: {
1930:   *normschedule = snes->normschedule;
1931:   return(0);
1932: }


1935: /*@
1936:   SNESSetFunctionNorm - Sets the last computed residual norm.

1938:   Logically Collective on SNES

1940:   Input Parameters:
1941: + snes - the SNES context

1943: - normschedule - the frequency of norm computation

1945:   Level: developer

1947: .seealso: SNESGetNormSchedule(), SNESComputeFunction(), VecNorm(), SNESSetFunction(), SNESSetInitialFunction(), SNESNormSchedule
1948: @*/
1949: PetscErrorCode SNESSetFunctionNorm(SNES snes, PetscReal norm)
1950: {
1953:   snes->norm = norm;
1954:   return(0);
1955: }

1957: /*@
1958:   SNESGetFunctionNorm - Gets the last computed norm of the residual

1960:   Not Collective

1962:   Input Parameter:
1963: . snes - the SNES context

1965:   Output Parameter:
1966: . norm - the last computed residual norm

1968:   Level: developer

1970: .seealso: SNESSetNormSchedule(), SNESComputeFunction(), VecNorm(), SNESSetFunction(), SNESSetInitialFunction(), SNESNormSchedule
1971: @*/
1972: PetscErrorCode SNESGetFunctionNorm(SNES snes, PetscReal *norm)
1973: {
1977:   *norm = snes->norm;
1978:   return(0);
1979: }

1981: /*@
1982:   SNESGetUpdateNorm - Gets the last computed norm of the Newton update

1984:   Not Collective

1986:   Input Parameter:
1987: . snes - the SNES context

1989:   Output Parameter:
1990: . ynorm - the last computed update norm

1992:   Level: developer

1994: .seealso: SNESSetNormSchedule(), SNESComputeFunction(), SNESGetFunctionNorm()
1995: @*/
1996: PetscErrorCode SNESGetUpdateNorm(SNES snes, PetscReal *ynorm)
1997: {
2001:   *ynorm = snes->ynorm;
2002:   return(0);
2003: }

2005: /*@
2006:   SNESGetSolutionNorm - Gets the last computed norm of the solution

2008:   Not Collective

2010:   Input Parameter:
2011: . snes - the SNES context

2013:   Output Parameter:
2014: . xnorm - the last computed solution norm

2016:   Level: developer

2018: .seealso: SNESSetNormSchedule(), SNESComputeFunction(), SNESGetFunctionNorm(), SNESGetUpdateNorm()
2019: @*/
2020: PetscErrorCode SNESGetSolutionNorm(SNES snes, PetscReal *xnorm)
2021: {
2025:   *xnorm = snes->xnorm;
2026:   return(0);
2027: }

2029: /*@C
2030:    SNESSetFunctionType - Sets the SNESNormSchedule used in covergence and monitoring
2031:    of the SNES method.

2033:    Logically Collective on SNES

2035:    Input Parameters:
2036: +  snes - the SNES context
2037: -  normschedule - the frequency of norm computation

2039:    Notes:
2040:    Only certain SNES methods support certain SNESNormSchedules.  Most require evaluation
2041:    of the nonlinear function and the taking of its norm at every iteration to
2042:    even ensure convergence at all.  However, methods such as custom Gauss-Seidel methods
2043:    (SNESNGS) and the like do not require the norm of the function to be computed, and therfore
2044:    may either be monitored for convergence or not.  As these are often used as nonlinear
2045:    preconditioners, monitoring the norm of their error is not a useful enterprise within
2046:    their solution.

2048:    Level: developer

2050: .seealso: SNESGetNormSchedule(), SNESComputeFunction(), VecNorm(), SNESSetFunction(), SNESSetInitialFunction(), SNESNormSchedule
2051: @*/
2052: PetscErrorCode  SNESSetFunctionType(SNES snes, SNESFunctionType type)
2053: {
2056:   snes->functype = type;
2057:   return(0);
2058: }


2061: /*@C
2062:    SNESGetFunctionType - Gets the SNESNormSchedule used in covergence and monitoring
2063:    of the SNES method.

2065:    Logically Collective on SNES

2067:    Input Parameters:
2068: +  snes - the SNES context
2069: -  normschedule - the type of the norm used

2071:    Level: advanced

2073: .seealso: SNESSetNormSchedule(), SNESComputeFunction(), VecNorm(), SNESSetFunction(), SNESSetInitialFunction(), SNESNormSchedule
2074: @*/
2075: PetscErrorCode  SNESGetFunctionType(SNES snes, SNESFunctionType *type)
2076: {
2079:   *type = snes->functype;
2080:   return(0);
2081: }

2083: /*MC
2084:     SNESNGSFunction - function used to convey a Gauss-Seidel sweep on the nonlinear function

2086:      Synopsis:
2087:      #include <petscsnes.h>
2088: $    SNESNGSFunction(SNES snes,Vec x,Vec b,void *ctx);

2090: +  X   - solution vector
2091: .  B   - RHS vector
2092: -  ctx - optional user-defined Gauss-Seidel context

2094:    Level: intermediate

2096: .seealso:   SNESSetNGS(), SNESGetNGS()
2097: M*/

2099: /*@C
2100:    SNESSetNGS - Sets the user nonlinear Gauss-Seidel routine for
2101:    use with composed nonlinear solvers.

2103:    Input Parameters:
2104: +  snes   - the SNES context
2105: .  f - function evaluation routine to apply Gauss-Seidel see SNESNGSFunction
2106: -  ctx    - [optional] user-defined context for private data for the
2107:             smoother evaluation routine (may be NULL)

2109:    Notes:
2110:    The NGS routines are used by the composed nonlinear solver to generate
2111:     a problem appropriate update to the solution, particularly FAS.

2113:    Level: intermediate

2115: .seealso: SNESGetFunction(), SNESComputeNGS()
2116: @*/
2117: PetscErrorCode SNESSetNGS(SNES snes,PetscErrorCode (*f)(SNES,Vec,Vec,void*),void *ctx)
2118: {
2120:   DM             dm;

2124:   SNESGetDM(snes,&dm);
2125:   DMSNESSetNGS(dm,f,ctx);
2126:   return(0);
2127: }

2129: PetscErrorCode SNESPicardComputeFunction(SNES snes,Vec x,Vec f,void *ctx)
2130: {
2132:   DM             dm;
2133:   DMSNES         sdm;

2136:   SNESGetDM(snes,&dm);
2137:   DMGetDMSNES(dm,&sdm);
2138:   if (!sdm->ops->computepfunction) SETERRQ(PETSC_COMM_SELF,PETSC_ERR_ARG_WRONGSTATE, "Must call SNESSetPicard() to provide Picard function.");
2139:   if (!sdm->ops->computepjacobian) SETERRQ(PETSC_COMM_SELF,PETSC_ERR_ARG_WRONGSTATE, "Must call SNESSetPicard() to provide Picard Jacobian.");
2140:   /*  A(x)*x - b(x) */
2141:   PetscStackPush("SNES Picard user function");
2142:   (*sdm->ops->computepfunction)(snes,x,f,sdm->pctx);
2143:   PetscStackPop;
2144:   PetscStackPush("SNES Picard user Jacobian");
2145:   (*sdm->ops->computepjacobian)(snes,x,snes->jacobian,snes->jacobian_pre,sdm->pctx);
2146:   PetscStackPop;
2147:   VecScale(f,-1.0);
2148:   MatMultAdd(snes->jacobian,x,f,f);
2149:   return(0);
2150: }

2152: PetscErrorCode SNESPicardComputeJacobian(SNES snes,Vec x1,Mat J,Mat B,void *ctx)
2153: {
2155:   /* the jacobian matrix should be pre-filled in SNESPicardComputeFunction */
2156:   return(0);
2157: }

2159: /*@C
2160:    SNESSetPicard - Use SNES to solve the semilinear-system A(x) x = b(x) via a Picard type iteration (Picard linearization)

2162:    Logically Collective on SNES

2164:    Input Parameters:
2165: +  snes - the SNES context
2166: .  r - vector to store function value
2167: .  b - function evaluation routine
2168: .  Amat - matrix with which A(x) x - b(x) is to be computed
2169: .  Pmat - matrix from which preconditioner is computed (usually the same as Amat)
2170: .  J  - function to compute matrix value, see SNESJacobianFunction for details on its calling sequence
2171: -  ctx - [optional] user-defined context for private data for the
2172:          function evaluation routine (may be NULL)

2174:    Notes:
2175:     We do not recomemend using this routine. It is far better to provide the nonlinear function F() and some approximation to the Jacobian and use
2176:     an approximate Newton solver. This interface is provided to allow porting/testing a previous Picard based code in PETSc before converting it to approximate Newton.

2178:     One can call SNESSetPicard() or SNESSetFunction() (and possibly SNESSetJacobian()) but cannot call both

2180: $     Solves the equation A(x) x = b(x) via the defect correction algorithm A(x^{n}) (x^{n+1} - x^{n}) = b(x^{n}) - A(x^{n})x^{n}
2181: $     Note that when an exact solver is used this corresponds to the "classic" Picard A(x^{n}) x^{n+1} = b(x^{n}) iteration.

2183:      Run with -snes_mf_operator to solve the system with Newton's method using A(x^{n}) to construct the preconditioner.

2185:    We implement the defect correction form of the Picard iteration because it converges much more generally when inexact linear solvers are used then
2186:    the direct Picard iteration A(x^n) x^{n+1} = b(x^n)

2188:    There is some controversity over the definition of a Picard iteration for nonlinear systems but almost everyone agrees that it involves a linear solve and some
2189:    believe it is the iteration  A(x^{n}) x^{n+1} = b(x^{n}) hence we use the name Picard. If anyone has an authoritative  reference that defines the Picard iteration
2190:    different please contact us at petsc-dev@mcs.anl.gov and we'll have an entirely new argument :-).

2192:    Level: intermediate

2194: .seealso: SNESGetFunction(), SNESSetFunction(), SNESComputeFunction(), SNESSetJacobian(), SNESGetPicard(), SNESLineSearchPreCheckPicard(), SNESJacobianFunction
2195: @*/
2196: PetscErrorCode  SNESSetPicard(SNES snes,Vec r,PetscErrorCode (*b)(SNES,Vec,Vec,void*),Mat Amat, Mat Pmat, PetscErrorCode (*J)(SNES,Vec,Mat,Mat,void*),void *ctx)
2197: {
2199:   DM             dm;

2203:   SNESGetDM(snes, &dm);
2204:   DMSNESSetPicard(dm,b,J,ctx);
2205:   SNESSetFunction(snes,r,SNESPicardComputeFunction,ctx);
2206:   SNESSetJacobian(snes,Amat,Pmat,SNESPicardComputeJacobian,ctx);
2207:   return(0);
2208: }

2210: /*@C
2211:    SNESGetPicard - Returns the context for the Picard iteration

2213:    Not Collective, but Vec is parallel if SNES is parallel. Collective if Vec is requested, but has not been created yet.

2215:    Input Parameter:
2216: .  snes - the SNES context

2218:    Output Parameter:
2219: +  r - the function (or NULL)
2220: .  f - the function (or NULL); see SNESFunction for calling sequence details
2221: .  Amat - the matrix used to defined the operation A(x) x - b(x) (or NULL)
2222: .  Pmat  - the matrix from which the preconditioner will be constructed (or NULL)
2223: .  J - the function for matrix evaluation (or NULL); see SNESJacobianFunction for calling sequence details
2224: -  ctx - the function context (or NULL)

2226:    Level: advanced

2228: .seealso: SNESSetPicard(), SNESGetFunction(), SNESGetJacobian(), SNESGetDM(), SNESFunction, SNESJacobianFunction
2229: @*/
2230: PetscErrorCode  SNESGetPicard(SNES snes,Vec *r,PetscErrorCode (**f)(SNES,Vec,Vec,void*),Mat *Amat, Mat *Pmat, PetscErrorCode (**J)(SNES,Vec,Mat,Mat,void*),void **ctx)
2231: {
2233:   DM             dm;

2237:   SNESGetFunction(snes,r,NULL,NULL);
2238:   SNESGetJacobian(snes,Amat,Pmat,NULL,NULL);
2239:   SNESGetDM(snes,&dm);
2240:   DMSNESGetPicard(dm,f,J,ctx);
2241:   return(0);
2242: }

2244: /*@C
2245:    SNESSetComputeInitialGuess - Sets a routine used to compute an initial guess for the problem

2247:    Logically Collective on SNES

2249:    Input Parameters:
2250: +  snes - the SNES context
2251: .  func - function evaluation routine
2252: -  ctx - [optional] user-defined context for private data for the
2253:          function evaluation routine (may be NULL)

2255:    Calling sequence of func:
2256: $    func (SNES snes,Vec x,void *ctx);

2258: .  f - function vector
2259: -  ctx - optional user-defined function context

2261:    Level: intermediate

2263: .seealso: SNESGetFunction(), SNESComputeFunction(), SNESSetJacobian()
2264: @*/
2265: PetscErrorCode  SNESSetComputeInitialGuess(SNES snes,PetscErrorCode (*func)(SNES,Vec,void*),void *ctx)
2266: {
2269:   if (func) snes->ops->computeinitialguess = func;
2270:   if (ctx)  snes->initialguessP            = ctx;
2271:   return(0);
2272: }

2274: /* --------------------------------------------------------------- */
2275: /*@C
2276:    SNESGetRhs - Gets the vector for solving F(x) = rhs. If rhs is not set
2277:    it assumes a zero right hand side.

2279:    Logically Collective on SNES

2281:    Input Parameter:
2282: .  snes - the SNES context

2284:    Output Parameter:
2285: .  rhs - the right hand side vector or NULL if the right hand side vector is null

2287:    Level: intermediate

2289: .seealso: SNESGetSolution(), SNESGetFunction(), SNESComputeFunction(), SNESSetJacobian(), SNESSetFunction()
2290: @*/
2291: PetscErrorCode  SNESGetRhs(SNES snes,Vec *rhs)
2292: {
2296:   *rhs = snes->vec_rhs;
2297:   return(0);
2298: }

2300: /*@
2301:    SNESComputeFunction - Calls the function that has been set with SNESSetFunction().

2303:    Collective on SNES

2305:    Input Parameters:
2306: +  snes - the SNES context
2307: -  x - input vector

2309:    Output Parameter:
2310: .  y - function vector, as set by SNESSetFunction()

2312:    Notes:
2313:    SNESComputeFunction() is typically used within nonlinear solvers
2314:    implementations, so most users would not generally call this routine
2315:    themselves.

2317:    Level: developer

2319: .seealso: SNESSetFunction(), SNESGetFunction()
2320: @*/
2321: PetscErrorCode  SNESComputeFunction(SNES snes,Vec x,Vec y)
2322: {
2324:   DM             dm;
2325:   DMSNES         sdm;

2333:   VecValidValues(x,2,PETSC_TRUE);

2335:   SNESGetDM(snes,&dm);
2336:   DMGetDMSNES(dm,&sdm);
2337:   if (sdm->ops->computefunction) {
2338:     if (sdm->ops->computefunction != SNESObjectiveComputeFunctionDefaultFD) {
2339:       PetscLogEventBegin(SNES_FunctionEval,snes,x,y,0);
2340:     }
2341:     VecLockReadPush(x);
2342:     PetscStackPush("SNES user function");
2343:     (*sdm->ops->computefunction)(snes,x,y,sdm->functionctx);
2344:     PetscStackPop;
2345:     VecLockReadPop(x);
2346:     if (sdm->ops->computefunction != SNESObjectiveComputeFunctionDefaultFD) {
2347:       PetscLogEventEnd(SNES_FunctionEval,snes,x,y,0);
2348:     }
2349:   } else if (snes->vec_rhs) {
2350:     MatMult(snes->jacobian, x, y);
2351:   } else SETERRQ(PETSC_COMM_SELF,PETSC_ERR_ARG_WRONGSTATE, "Must call SNESSetFunction() or SNESSetDM() before SNESComputeFunction(), likely called from SNESSolve().");
2352:   if (snes->vec_rhs) {
2353:     VecAXPY(y,-1.0,snes->vec_rhs);
2354:   }
2355:   snes->nfuncs++;
2356:   /*
2357:      domainerror might not be set on all processes; so we tag vector locally with Inf and the next inner product or norm will
2358:      propagate the value to all processes
2359:   */
2360:   if (snes->domainerror) {
2361:     VecSetInf(y);
2362:   }
2363:   return(0);
2364: }

2366: /*@
2367:    SNESComputeNGS - Calls the Gauss-Seidel function that has been set with  SNESSetNGS().

2369:    Collective on SNES

2371:    Input Parameters:
2372: +  snes - the SNES context
2373: .  x - input vector
2374: -  b - rhs vector

2376:    Output Parameter:
2377: .  x - new solution vector

2379:    Notes:
2380:    SNESComputeNGS() is typically used within composed nonlinear solver
2381:    implementations, so most users would not generally call this routine
2382:    themselves.

2384:    Level: developer

2386: .seealso: SNESSetNGS(), SNESComputeFunction()
2387: @*/
2388: PetscErrorCode  SNESComputeNGS(SNES snes,Vec b,Vec x)
2389: {
2391:   DM             dm;
2392:   DMSNES         sdm;

2400:   if (b) {VecValidValues(b,2,PETSC_TRUE);}
2401:   PetscLogEventBegin(SNES_NGSEval,snes,x,b,0);
2402:   SNESGetDM(snes,&dm);
2403:   DMGetDMSNES(dm,&sdm);
2404:   if (sdm->ops->computegs) {
2405:     if (b) {VecLockReadPush(b);}
2406:     PetscStackPush("SNES user NGS");
2407:     (*sdm->ops->computegs)(snes,x,b,sdm->gsctx);
2408:     PetscStackPop;
2409:     if (b) {VecLockReadPop(b);}
2410:   } else SETERRQ(PETSC_COMM_SELF,PETSC_ERR_ARG_WRONGSTATE, "Must call SNESSetNGS() before SNESComputeNGS(), likely called from SNESSolve().");
2411:   PetscLogEventEnd(SNES_NGSEval,snes,x,b,0);
2412:   return(0);
2413: }

2415: PetscErrorCode SNESTestJacobian(SNES snes)
2416: {
2417:   Mat               A,B,C,D,jacobian;
2418:   Vec               x = snes->vec_sol,f = snes->vec_func;
2419:   PetscErrorCode    ierr;
2420:   PetscReal         nrm,gnorm;
2421:   PetscReal         threshold = 1.e-5;
2422:   MatType           mattype;
2423:   PetscInt          m,n,M,N;
2424:   void              *functx;
2425:   PetscBool         complete_print = PETSC_FALSE,threshold_print = PETSC_FALSE,test = PETSC_FALSE,flg;
2426:   PetscViewer       viewer,mviewer;
2427:   MPI_Comm          comm;
2428:   PetscInt          tabs;
2429:   static PetscBool  directionsprinted = PETSC_FALSE;
2430:   PetscViewerFormat format;

2433:   PetscObjectOptionsBegin((PetscObject)snes);
2434:   PetscOptionsName("-snes_test_jacobian","Compare hand-coded and finite difference Jacobians","None",&test);
2435:   PetscOptionsReal("-snes_test_jacobian", "Threshold for element difference between hand-coded and finite difference being meaningful", "None", threshold, &threshold,NULL);
2436:   PetscOptionsViewer("-snes_test_jacobian_view","View difference between hand-coded and finite difference Jacobians element entries","None",&mviewer,&format,&complete_print);
2437:   if (!complete_print) {
2438:     PetscOptionsViewer("-snes_test_jacobian_display","Display difference between hand-coded and finite difference Jacobians","None",&mviewer,&format,&complete_print);
2439:   }
2440:   /* for compatibility with PETSc 3.9 and older. */
2441:   PetscOptionsReal("-snes_test_jacobian_display_threshold", "Display difference between hand-coded and finite difference Jacobians which exceed input threshold", "None", threshold, &threshold, &threshold_print);
2442:   PetscOptionsEnd();
2443:   if (!test) return(0);

2445:   PetscObjectGetComm((PetscObject)snes,&comm);
2446:   PetscViewerASCIIGetStdout(comm,&viewer);
2447:   PetscViewerASCIIGetTab(viewer, &tabs);
2448:   PetscViewerASCIISetTab(viewer, ((PetscObject)snes)->tablevel);
2449:   PetscViewerASCIIPrintf(viewer,"  ---------- Testing Jacobian -------------\n");
2450:   if (!complete_print && !directionsprinted) {
2451:     PetscViewerASCIIPrintf(viewer,"  Run with -snes_test_jacobian_view and optionally -snes_test_jacobian <threshold> to show difference\n");
2452:     PetscViewerASCIIPrintf(viewer,"    of hand-coded and finite difference Jacobian entries greater than <threshold>.\n");
2453:   }
2454:   if (!directionsprinted) {
2455:     PetscViewerASCIIPrintf(viewer,"  Testing hand-coded Jacobian, if (for double precision runs) ||J - Jfd||_F/||J||_F is\n");
2456:     PetscViewerASCIIPrintf(viewer,"    O(1.e-8), the hand-coded Jacobian is probably correct.\n");
2457:     directionsprinted = PETSC_TRUE;
2458:   }
2459:   if (complete_print) {
2460:     PetscViewerPushFormat(mviewer,format);
2461:   }

2463:   PetscObjectTypeCompare((PetscObject)snes->jacobian,MATMFFD,&flg);
2464:   if (!flg) jacobian = snes->jacobian;
2465:   else jacobian = snes->jacobian_pre;

2467:   if (!x) {
2468:     MatCreateVecs(jacobian, &x, NULL);
2469:   } else {
2470:     PetscObjectReference((PetscObject) x);
2471:   }
2472:   if (!f) {
2473:     VecDuplicate(x, &f);
2474:   } else {
2475:     PetscObjectReference((PetscObject) f);
2476:   }
2477:   /* evaluate the function at this point because SNESComputeJacobianDefault() assumes that the function has been evaluated and put into snes->vec_func */
2478:   SNESComputeFunction(snes,x,f);
2479:   VecDestroy(&f);

2481:   while (jacobian) {
2482:     PetscObjectBaseTypeCompareAny((PetscObject)jacobian,&flg,MATSEQAIJ,MATMPIAIJ,MATSEQDENSE,MATMPIDENSE,MATSEQBAIJ,MATMPIBAIJ,MATSEQSBAIJ,MATMPISBAIJ,"");
2483:     if (flg) {
2484:       A    = jacobian;
2485:       PetscObjectReference((PetscObject)A);
2486:     } else {
2487:       MatComputeOperator(jacobian,MATAIJ,&A);
2488:     }

2490:     MatGetType(A,&mattype);
2491:     MatGetSize(A,&M,&N);
2492:     MatGetLocalSize(A,&m,&n);

2494:     MatCreate(PetscObjectComm((PetscObject)A),&B);
2495:     MatSetType(B,mattype);
2496:     MatSetSizes(B,m,n,M,N);
2497:     MatSetBlockSizesFromMats(B,A,A);
2498:     MatSetUp(B);
2499:     MatSetOption(B,MAT_NEW_NONZERO_ALLOCATION_ERR,PETSC_FALSE);

2501:     SNESGetFunction(snes,NULL,NULL,&functx);
2502:     SNESComputeJacobianDefault(snes,x,B,B,functx);

2504:     MatDuplicate(B,MAT_COPY_VALUES,&D);
2505:     MatAYPX(D,-1.0,A,DIFFERENT_NONZERO_PATTERN);
2506:     MatNorm(D,NORM_FROBENIUS,&nrm);
2507:     MatNorm(A,NORM_FROBENIUS,&gnorm);
2508:     MatDestroy(&D);
2509:     if (!gnorm) gnorm = 1; /* just in case */
2510:     PetscViewerASCIIPrintf(viewer,"  ||J - Jfd||_F/||J||_F = %g, ||J - Jfd||_F = %g\n",(double)(nrm/gnorm),(double)nrm);

2512:     if (complete_print) {
2513:       PetscViewerASCIIPrintf(viewer,"  Hand-coded Jacobian ----------\n");
2514:       MatView(jacobian,mviewer);
2515:       PetscViewerASCIIPrintf(viewer,"  Finite difference Jacobian ----------\n");
2516:       MatView(B,mviewer);
2517:     }

2519:     if (threshold_print || complete_print) {
2520:       PetscInt          Istart, Iend, *ccols, bncols, cncols, j, row;
2521:       PetscScalar       *cvals;
2522:       const PetscInt    *bcols;
2523:       const PetscScalar *bvals;

2525:       MatCreate(PetscObjectComm((PetscObject)A),&C);
2526:       MatSetType(C,mattype);
2527:       MatSetSizes(C,m,n,M,N);
2528:       MatSetBlockSizesFromMats(C,A,A);
2529:       MatSetUp(C);
2530:       MatSetOption(C,MAT_NEW_NONZERO_ALLOCATION_ERR,PETSC_FALSE);

2532:       MatAYPX(B,-1.0,A,DIFFERENT_NONZERO_PATTERN);
2533:       MatGetOwnershipRange(B,&Istart,&Iend);

2535:       for (row = Istart; row < Iend; row++) {
2536:         MatGetRow(B,row,&bncols,&bcols,&bvals);
2537:         PetscMalloc2(bncols,&ccols,bncols,&cvals);
2538:         for (j = 0, cncols = 0; j < bncols; j++) {
2539:           if (PetscAbsScalar(bvals[j]) > threshold) {
2540:             ccols[cncols] = bcols[j];
2541:             cvals[cncols] = bvals[j];
2542:             cncols += 1;
2543:           }
2544:         }
2545:         if (cncols) {
2546:           MatSetValues(C,1,&row,cncols,ccols,cvals,INSERT_VALUES);
2547:         }
2548:         MatRestoreRow(B,row,&bncols,&bcols,&bvals);
2549:         PetscFree2(ccols,cvals);
2550:       }
2551:       MatAssemblyBegin(C,MAT_FINAL_ASSEMBLY);
2552:       MatAssemblyEnd(C,MAT_FINAL_ASSEMBLY);
2553:       PetscViewerASCIIPrintf(viewer,"  Hand-coded minus finite-difference Jacobian with tolerance %g ----------\n",(double)threshold);
2554:       MatView(C,complete_print ? mviewer : viewer);
2555:       MatDestroy(&C);
2556:     }
2557:     MatDestroy(&A);
2558:     MatDestroy(&B);

2560:     if (jacobian != snes->jacobian_pre) {
2561:       jacobian = snes->jacobian_pre;
2562:       PetscViewerASCIIPrintf(viewer,"  ---------- Testing Jacobian for preconditioner -------------\n");
2563:     }
2564:     else jacobian = NULL;
2565:   }
2566:   VecDestroy(&x);
2567:   if (complete_print) {
2568:     PetscViewerPopFormat(mviewer);
2569:   }
2570:   if (mviewer) { PetscViewerDestroy(&mviewer); }
2571:   PetscViewerASCIISetTab(viewer,tabs);
2572:   return(0);
2573: }

2575: /*@
2576:    SNESComputeJacobian - Computes the Jacobian matrix that has been set with SNESSetJacobian().

2578:    Collective on SNES

2580:    Input Parameters:
2581: +  snes - the SNES context
2582: -  x - input vector

2584:    Output Parameters:
2585: +  A - Jacobian matrix
2586: -  B - optional preconditioning matrix

2588:   Options Database Keys:
2589: +    -snes_lag_preconditioner <lag>
2590: .    -snes_lag_jacobian <lag>
2591: .    -snes_test_jacobian - compare the user provided Jacobian with one compute via finite differences to check for errors
2592: .    -snes_test_jacobian_display - display the user provided Jacobian, the finite difference Jacobian and the difference between them to help users detect the location of errors in the user provided Jacobian
2593: .    -snes_test_jacobian_display_threshold <numerical value>  - display entries in the difference between the user provided Jacobian and finite difference Jacobian that are greater than a certain value to help users detect errors
2594: .    -snes_compare_explicit - Compare the computed Jacobian to the finite difference Jacobian and output the differences
2595: .    -snes_compare_explicit_draw  - Compare the computed Jacobian to the finite difference Jacobian and draw the result
2596: .    -snes_compare_explicit_contour  - Compare the computed Jacobian to the finite difference Jacobian and draw a contour plot with the result
2597: .    -snes_compare_operator  - Make the comparison options above use the operator instead of the preconditioning matrix
2598: .    -snes_compare_coloring - Compute the finite difference Jacobian using coloring and display norms of difference
2599: .    -snes_compare_coloring_display - Compute the finite differece Jacobian using coloring and display verbose differences
2600: .    -snes_compare_coloring_threshold - Display only those matrix entries that differ by more than a given threshold
2601: .    -snes_compare_coloring_threshold_atol - Absolute tolerance for difference in matrix entries to be displayed by -snes_compare_coloring_threshold
2602: .    -snes_compare_coloring_threshold_rtol - Relative tolerance for difference in matrix entries to be displayed by -snes_compare_coloring_threshold
2603: .    -snes_compare_coloring_draw - Compute the finite differece Jacobian using coloring and draw differences
2604: -    -snes_compare_coloring_draw_contour - Compute the finite differece Jacobian using coloring and show contours of matrices and differences


2607:    Notes:
2608:    Most users should not need to explicitly call this routine, as it
2609:    is used internally within the nonlinear solvers.

2611:    Developer Notes:
2612:     This has duplicative ways of checking the accuracy of the user provided Jacobian (see the options above). This is for historical reasons, the routine SNESTestJacobian() use to used
2613:       for with the SNESType of test that has been removed.

2615:    Level: developer

2617: .seealso:  SNESSetJacobian(), KSPSetOperators(), MatStructure, SNESSetLagPreconditioner(), SNESSetLagJacobian()
2618: @*/
2619: PetscErrorCode  SNESComputeJacobian(SNES snes,Vec X,Mat A,Mat B)
2620: {
2622:   PetscBool      flag;
2623:   DM             dm;
2624:   DMSNES         sdm;
2625:   KSP            ksp;

2631:   VecValidValues(X,2,PETSC_TRUE);
2632:   SNESGetDM(snes,&dm);
2633:   DMGetDMSNES(dm,&sdm);

2635:   if (!sdm->ops->computejacobian) SETERRQ(PetscObjectComm((PetscObject)snes),PETSC_ERR_USER,"Must call SNESSetJacobian(), DMSNESSetJacobian(), DMDASNESSetJacobianLocal(), etc");

2637:   /* make sure that MatAssemblyBegin/End() is called on A matrix if it is matrix free */

2639:   if (snes->lagjacobian == -2) {
2640:     snes->lagjacobian = -1;

2642:     PetscInfo(snes,"Recomputing Jacobian/preconditioner because lag is -2 (means compute Jacobian, but then never again) \n");
2643:   } else if (snes->lagjacobian == -1) {
2644:     PetscInfo(snes,"Reusing Jacobian/preconditioner because lag is -1\n");
2645:     PetscObjectTypeCompare((PetscObject)A,MATMFFD,&flag);
2646:     if (flag) {
2647:       MatAssemblyBegin(A,MAT_FINAL_ASSEMBLY);
2648:       MatAssemblyEnd(A,MAT_FINAL_ASSEMBLY);
2649:     }
2650:     return(0);
2651:   } else if (snes->lagjacobian > 1 && (snes->iter + snes->jac_iter) % snes->lagjacobian) {
2652:     PetscInfo2(snes,"Reusing Jacobian/preconditioner because lag is %D and SNES iteration is %D\n",snes->lagjacobian,snes->iter);
2653:     PetscObjectTypeCompare((PetscObject)A,MATMFFD,&flag);
2654:     if (flag) {
2655:       MatAssemblyBegin(A,MAT_FINAL_ASSEMBLY);
2656:       MatAssemblyEnd(A,MAT_FINAL_ASSEMBLY);
2657:     }
2658:     return(0);
2659:   }
2660:   if (snes->npc && snes->npcside== PC_LEFT) {
2661:     MatAssemblyBegin(A,MAT_FINAL_ASSEMBLY);
2662:     MatAssemblyEnd(A,MAT_FINAL_ASSEMBLY);
2663:     return(0);
2664:   }

2666:   PetscLogEventBegin(SNES_JacobianEval,snes,X,A,B);
2667:   VecLockReadPush(X);
2668:   PetscStackPush("SNES user Jacobian function");
2669:   (*sdm->ops->computejacobian)(snes,X,A,B,sdm->jacobianctx);
2670:   PetscStackPop;
2671:   VecLockReadPop(X);
2672:   PetscLogEventEnd(SNES_JacobianEval,snes,X,A,B);

2674:   /* attach latest linearization point to the preconditioning matrix */
2675:   PetscObjectCompose((PetscObject)B,"__SNES_latest_X",(PetscObject)X);

2677:   /* the next line ensures that snes->ksp exists */
2678:   SNESGetKSP(snes,&ksp);
2679:   if (snes->lagpreconditioner == -2) {
2680:     PetscInfo(snes,"Rebuilding preconditioner exactly once since lag is -2\n");
2681:     KSPSetReusePreconditioner(snes->ksp,PETSC_FALSE);
2682:     snes->lagpreconditioner = -1;
2683:   } else if (snes->lagpreconditioner == -1) {
2684:     PetscInfo(snes,"Reusing preconditioner because lag is -1\n");
2685:     KSPSetReusePreconditioner(snes->ksp,PETSC_TRUE);
2686:   } else if (snes->lagpreconditioner > 1 && (snes->iter + snes->pre_iter) % snes->lagpreconditioner) {
2687:     PetscInfo2(snes,"Reusing preconditioner because lag is %D and SNES iteration is %D\n",snes->lagpreconditioner,snes->iter);
2688:     KSPSetReusePreconditioner(snes->ksp,PETSC_TRUE);
2689:   } else {
2690:     PetscInfo(snes,"Rebuilding preconditioner\n");
2691:     KSPSetReusePreconditioner(snes->ksp,PETSC_FALSE);
2692:   }

2694:   SNESTestJacobian(snes);
2695:   /* make sure user returned a correct Jacobian and preconditioner */
2698:   {
2699:     PetscBool flag = PETSC_FALSE,flag_draw = PETSC_FALSE,flag_contour = PETSC_FALSE,flag_operator = PETSC_FALSE;
2700:     PetscOptionsGetViewer(PetscObjectComm((PetscObject)snes),((PetscObject) snes)->options,((PetscObject)snes)->prefix,"-snes_compare_explicit",NULL,NULL,&flag);
2701:     PetscOptionsGetViewer(PetscObjectComm((PetscObject)snes),((PetscObject) snes)->options,((PetscObject)snes)->prefix,"-snes_compare_explicit_draw",NULL,NULL,&flag_draw);
2702:     PetscOptionsGetViewer(PetscObjectComm((PetscObject)snes),((PetscObject) snes)->options,((PetscObject)snes)->prefix,"-snes_compare_explicit_draw_contour",NULL,NULL,&flag_contour);
2703:     PetscOptionsGetViewer(PetscObjectComm((PetscObject)snes),((PetscObject) snes)->options,((PetscObject)snes)->prefix,"-snes_compare_operator",NULL,NULL,&flag_operator);
2704:     if (flag || flag_draw || flag_contour) {
2705:       Mat          Bexp_mine = NULL,Bexp,FDexp;
2706:       PetscViewer  vdraw,vstdout;
2707:       PetscBool    flg;
2708:       if (flag_operator) {
2709:         MatComputeOperator(A,MATAIJ,&Bexp_mine);
2710:         Bexp = Bexp_mine;
2711:       } else {
2712:         /* See if the preconditioning matrix can be viewed and added directly */
2713:         PetscObjectBaseTypeCompareAny((PetscObject)B,&flg,MATSEQAIJ,MATMPIAIJ,MATSEQDENSE,MATMPIDENSE,MATSEQBAIJ,MATMPIBAIJ,MATSEQSBAIJ,MATMPIBAIJ,"");
2714:         if (flg) Bexp = B;
2715:         else {
2716:           /* If the "preconditioning" matrix is itself MATSHELL or some other type without direct support */
2717:           MatComputeOperator(B,MATAIJ,&Bexp_mine);
2718:           Bexp = Bexp_mine;
2719:         }
2720:       }
2721:       MatConvert(Bexp,MATSAME,MAT_INITIAL_MATRIX,&FDexp);
2722:       SNESComputeJacobianDefault(snes,X,FDexp,FDexp,NULL);
2723:       PetscViewerASCIIGetStdout(PetscObjectComm((PetscObject)snes),&vstdout);
2724:       if (flag_draw || flag_contour) {
2725:         PetscViewerDrawOpen(PetscObjectComm((PetscObject)snes),0,"Explicit Jacobians",PETSC_DECIDE,PETSC_DECIDE,300,300,&vdraw);
2726:         if (flag_contour) {PetscViewerPushFormat(vdraw,PETSC_VIEWER_DRAW_CONTOUR);}
2727:       } else vdraw = NULL;
2728:       PetscViewerASCIIPrintf(vstdout,"Explicit %s\n",flag_operator ? "Jacobian" : "preconditioning Jacobian");
2729:       if (flag) {MatView(Bexp,vstdout);}
2730:       if (vdraw) {MatView(Bexp,vdraw);}
2731:       PetscViewerASCIIPrintf(vstdout,"Finite difference Jacobian\n");
2732:       if (flag) {MatView(FDexp,vstdout);}
2733:       if (vdraw) {MatView(FDexp,vdraw);}
2734:       MatAYPX(FDexp,-1.0,Bexp,SAME_NONZERO_PATTERN);
2735:       PetscViewerASCIIPrintf(vstdout,"User-provided matrix minus finite difference Jacobian\n");
2736:       if (flag) {MatView(FDexp,vstdout);}
2737:       if (vdraw) {              /* Always use contour for the difference */
2738:         PetscViewerPushFormat(vdraw,PETSC_VIEWER_DRAW_CONTOUR);
2739:         MatView(FDexp,vdraw);
2740:         PetscViewerPopFormat(vdraw);
2741:       }
2742:       if (flag_contour) {PetscViewerPopFormat(vdraw);}
2743:       PetscViewerDestroy(&vdraw);
2744:       MatDestroy(&Bexp_mine);
2745:       MatDestroy(&FDexp);
2746:     }
2747:   }
2748:   {
2749:     PetscBool flag = PETSC_FALSE,flag_display = PETSC_FALSE,flag_draw = PETSC_FALSE,flag_contour = PETSC_FALSE,flag_threshold = PETSC_FALSE;
2750:     PetscReal threshold_atol = PETSC_SQRT_MACHINE_EPSILON,threshold_rtol = 10*PETSC_SQRT_MACHINE_EPSILON;
2751:     PetscOptionsGetViewer(PetscObjectComm((PetscObject)snes),((PetscObject)snes)->options,((PetscObject)snes)->prefix,"-snes_compare_coloring",NULL,NULL,&flag);
2752:     PetscOptionsGetViewer(PetscObjectComm((PetscObject)snes),((PetscObject)snes)->options,((PetscObject)snes)->prefix,"-snes_compare_coloring_display",NULL,NULL,&flag_display);
2753:     PetscOptionsGetViewer(PetscObjectComm((PetscObject)snes),((PetscObject)snes)->options,((PetscObject)snes)->prefix,"-snes_compare_coloring_draw",NULL,NULL,&flag_draw);
2754:     PetscOptionsGetViewer(PetscObjectComm((PetscObject)snes),((PetscObject)snes)->options,((PetscObject)snes)->prefix,"-snes_compare_coloring_draw_contour",NULL,NULL,&flag_contour);
2755:     PetscOptionsGetViewer(PetscObjectComm((PetscObject)snes),((PetscObject)snes)->options,((PetscObject)snes)->prefix,"-snes_compare_coloring_threshold",NULL,NULL,&flag_threshold);
2756:     if (flag_threshold) {
2757:       PetscOptionsGetReal(((PetscObject)snes)->options,((PetscObject)snes)->prefix,"-snes_compare_coloring_threshold_rtol",&threshold_rtol,NULL);
2758:       PetscOptionsGetReal(((PetscObject)snes)->options,((PetscObject)snes)->prefix,"-snes_compare_coloring_threshold_atol",&threshold_atol,NULL);
2759:     }
2760:     if (flag || flag_display || flag_draw || flag_contour || flag_threshold) {
2761:       Mat            Bfd;
2762:       PetscViewer    vdraw,vstdout;
2763:       MatColoring    coloring;
2764:       ISColoring     iscoloring;
2765:       MatFDColoring  matfdcoloring;
2766:       PetscErrorCode (*func)(SNES,Vec,Vec,void*);
2767:       void           *funcctx;
2768:       PetscReal      norm1,norm2,normmax;

2770:       MatDuplicate(B,MAT_DO_NOT_COPY_VALUES,&Bfd);
2771:       MatColoringCreate(Bfd,&coloring);
2772:       MatColoringSetType(coloring,MATCOLORINGSL);
2773:       MatColoringSetFromOptions(coloring);
2774:       MatColoringApply(coloring,&iscoloring);
2775:       MatColoringDestroy(&coloring);
2776:       MatFDColoringCreate(Bfd,iscoloring,&matfdcoloring);
2777:       MatFDColoringSetFromOptions(matfdcoloring);
2778:       MatFDColoringSetUp(Bfd,iscoloring,matfdcoloring);
2779:       ISColoringDestroy(&iscoloring);

2781:       /* This method of getting the function is currently unreliable since it doesn't work for DM local functions. */
2782:       SNESGetFunction(snes,NULL,&func,&funcctx);
2783:       MatFDColoringSetFunction(matfdcoloring,(PetscErrorCode (*)(void))func,funcctx);
2784:       PetscObjectSetOptionsPrefix((PetscObject)matfdcoloring,((PetscObject)snes)->prefix);
2785:       PetscObjectAppendOptionsPrefix((PetscObject)matfdcoloring,"coloring_");
2786:       MatFDColoringSetFromOptions(matfdcoloring);
2787:       MatFDColoringApply(Bfd,matfdcoloring,X,snes);
2788:       MatFDColoringDestroy(&matfdcoloring);

2790:       PetscViewerASCIIGetStdout(PetscObjectComm((PetscObject)snes),&vstdout);
2791:       if (flag_draw || flag_contour) {
2792:         PetscViewerDrawOpen(PetscObjectComm((PetscObject)snes),0,"Colored Jacobians",PETSC_DECIDE,PETSC_DECIDE,300,300,&vdraw);
2793:         if (flag_contour) {PetscViewerPushFormat(vdraw,PETSC_VIEWER_DRAW_CONTOUR);}
2794:       } else vdraw = NULL;
2795:       PetscViewerASCIIPrintf(vstdout,"Explicit preconditioning Jacobian\n");
2796:       if (flag_display) {MatView(B,vstdout);}
2797:       if (vdraw) {MatView(B,vdraw);}
2798:       PetscViewerASCIIPrintf(vstdout,"Colored Finite difference Jacobian\n");
2799:       if (flag_display) {MatView(Bfd,vstdout);}
2800:       if (vdraw) {MatView(Bfd,vdraw);}
2801:       MatAYPX(Bfd,-1.0,B,SAME_NONZERO_PATTERN);
2802:       MatNorm(Bfd,NORM_1,&norm1);
2803:       MatNorm(Bfd,NORM_FROBENIUS,&norm2);
2804:       MatNorm(Bfd,NORM_MAX,&normmax);
2805:       PetscViewerASCIIPrintf(vstdout,"User-provided matrix minus finite difference Jacobian, norm1=%g normFrob=%g normmax=%g\n",(double)norm1,(double)norm2,(double)normmax);
2806:       if (flag_display) {MatView(Bfd,vstdout);}
2807:       if (vdraw) {              /* Always use contour for the difference */
2808:         PetscViewerPushFormat(vdraw,PETSC_VIEWER_DRAW_CONTOUR);
2809:         MatView(Bfd,vdraw);
2810:         PetscViewerPopFormat(vdraw);
2811:       }
2812:       if (flag_contour) {PetscViewerPopFormat(vdraw);}

2814:       if (flag_threshold) {
2815:         PetscInt bs,rstart,rend,i;
2816:         MatGetBlockSize(B,&bs);
2817:         MatGetOwnershipRange(B,&rstart,&rend);
2818:         for (i=rstart; i<rend; i++) {
2819:           const PetscScalar *ba,*ca;
2820:           const PetscInt    *bj,*cj;
2821:           PetscInt          bn,cn,j,maxentrycol = -1,maxdiffcol = -1,maxrdiffcol = -1;
2822:           PetscReal         maxentry = 0,maxdiff = 0,maxrdiff = 0;
2823:           MatGetRow(B,i,&bn,&bj,&ba);
2824:           MatGetRow(Bfd,i,&cn,&cj,&ca);
2825:           if (bn != cn) SETERRQ(((PetscObject)A)->comm,PETSC_ERR_PLIB,"Unexpected different nonzero pattern in -snes_compare_coloring_threshold");
2826:           for (j=0; j<bn; j++) {
2827:             PetscReal rdiff = PetscAbsScalar(ca[j]) / (threshold_atol + threshold_rtol*PetscAbsScalar(ba[j]));
2828:             if (PetscAbsScalar(ba[j]) > PetscAbs(maxentry)) {
2829:               maxentrycol = bj[j];
2830:               maxentry    = PetscRealPart(ba[j]);
2831:             }
2832:             if (PetscAbsScalar(ca[j]) > PetscAbs(maxdiff)) {
2833:               maxdiffcol = bj[j];
2834:               maxdiff    = PetscRealPart(ca[j]);
2835:             }
2836:             if (rdiff > maxrdiff) {
2837:               maxrdiffcol = bj[j];
2838:               maxrdiff    = rdiff;
2839:             }
2840:           }
2841:           if (maxrdiff > 1) {
2842:             PetscViewerASCIIPrintf(vstdout,"row %D (maxentry=%g at %D, maxdiff=%g at %D, maxrdiff=%g at %D):",i,(double)maxentry,maxentrycol,(double)maxdiff,maxdiffcol,(double)maxrdiff,maxrdiffcol);
2843:             for (j=0; j<bn; j++) {
2844:               PetscReal rdiff;
2845:               rdiff = PetscAbsScalar(ca[j]) / (threshold_atol + threshold_rtol*PetscAbsScalar(ba[j]));
2846:               if (rdiff > 1) {
2847:                 PetscViewerASCIIPrintf(vstdout," (%D,%g:%g)",bj[j],(double)PetscRealPart(ba[j]),(double)PetscRealPart(ca[j]));
2848:               }
2849:             }
2850:             PetscViewerASCIIPrintf(vstdout,"\n",i,maxentry,maxdiff,maxrdiff);
2851:           }
2852:           MatRestoreRow(B,i,&bn,&bj,&ba);
2853:           MatRestoreRow(Bfd,i,&cn,&cj,&ca);
2854:         }
2855:       }
2856:       PetscViewerDestroy(&vdraw);
2857:       MatDestroy(&Bfd);
2858:     }
2859:   }
2860:   return(0);
2861: }

2863: /*MC
2864:     SNESJacobianFunction - Function used to convey the nonlinear Jacobian of the function to be solved by SNES

2866:      Synopsis:
2867:      #include "petscsnes.h"
2868:      PetscErrorCode SNESJacobianFunction(SNES snes,Vec x,Mat Amat,Mat Pmat,void *ctx);

2870: +  x - input vector
2871: .  Amat - the matrix that defines the (approximate) Jacobian
2872: .  Pmat - the matrix to be used in constructing the preconditioner, usually the same as Amat.
2873: -  ctx - [optional] user-defined Jacobian context

2875:    Level: intermediate

2877: .seealso:   SNESSetFunction(), SNESGetFunction(), SNESSetJacobian(), SNESGetJacobian()
2878: M*/

2880: /*@C
2881:    SNESSetJacobian - Sets the function to compute Jacobian as well as the
2882:    location to store the matrix.

2884:    Logically Collective on SNES

2886:    Input Parameters:
2887: +  snes - the SNES context
2888: .  Amat - the matrix that defines the (approximate) Jacobian
2889: .  Pmat - the matrix to be used in constructing the preconditioner, usually the same as Amat.
2890: .  J - Jacobian evaluation routine (if NULL then SNES retains any previously set value), see SNESJacobianFunction for details
2891: -  ctx - [optional] user-defined context for private data for the
2892:          Jacobian evaluation routine (may be NULL) (if NULL then SNES retains any previously set value)

2894:    Notes:
2895:    If the Amat matrix and Pmat matrix are different you must call MatAssemblyBegin/End() on
2896:    each matrix.

2898:    If you know the operator Amat has a null space you can use MatSetNullSpace() and MatSetTransposeNullSpace() to supply the null
2899:    space to Amat and the KSP solvers will automatically use that null space as needed during the solution process.

2901:    If using SNESComputeJacobianDefaultColor() to assemble a Jacobian, the ctx argument
2902:    must be a MatFDColoring.

2904:    Other defect-correction schemes can be used by computing a different matrix in place of the Jacobian.  One common
2905:    example is to use the "Picard linearization" which only differentiates through the highest order parts of each term.

2907:    Level: beginner

2909: .seealso: KSPSetOperators(), SNESSetFunction(), MatMFFDComputeJacobian(), SNESComputeJacobianDefaultColor(), MatStructure, J,
2910:           SNESSetPicard(), SNESJacobianFunction
2911: @*/
2912: PetscErrorCode  SNESSetJacobian(SNES snes,Mat Amat,Mat Pmat,PetscErrorCode (*J)(SNES,Vec,Mat,Mat,void*),void *ctx)
2913: {
2915:   DM             dm;

2923:   SNESGetDM(snes,&dm);
2924:   DMSNESSetJacobian(dm,J,ctx);
2925:   if (Amat) {
2926:     PetscObjectReference((PetscObject)Amat);
2927:     MatDestroy(&snes->jacobian);

2929:     snes->jacobian = Amat;
2930:   }
2931:   if (Pmat) {
2932:     PetscObjectReference((PetscObject)Pmat);
2933:     MatDestroy(&snes->jacobian_pre);

2935:     snes->jacobian_pre = Pmat;
2936:   }
2937:   return(0);
2938: }

2940: /*@C
2941:    SNESGetJacobian - Returns the Jacobian matrix and optionally the user
2942:    provided context for evaluating the Jacobian.

2944:    Not Collective, but Mat object will be parallel if SNES object is

2946:    Input Parameter:
2947: .  snes - the nonlinear solver context

2949:    Output Parameters:
2950: +  Amat - location to stash (approximate) Jacobian matrix (or NULL)
2951: .  Pmat - location to stash matrix used to compute the preconditioner (or NULL)
2952: .  J - location to put Jacobian function (or NULL), see SNESJacobianFunction for details on its calling sequence
2953: -  ctx - location to stash Jacobian ctx (or NULL)

2955:    Level: advanced

2957: .seealso: SNESSetJacobian(), SNESComputeJacobian(), SNESJacobianFunction, SNESGetFunction()
2958: @*/
2959: PetscErrorCode SNESGetJacobian(SNES snes,Mat *Amat,Mat *Pmat,PetscErrorCode (**J)(SNES,Vec,Mat,Mat,void*),void **ctx)
2960: {
2962:   DM             dm;
2963:   DMSNES         sdm;

2967:   if (Amat) *Amat = snes->jacobian;
2968:   if (Pmat) *Pmat = snes->jacobian_pre;
2969:   SNESGetDM(snes,&dm);
2970:   DMGetDMSNES(dm,&sdm);
2971:   if (J) *J = sdm->ops->computejacobian;
2972:   if (ctx) *ctx = sdm->jacobianctx;
2973:   return(0);
2974: }

2976: /*@
2977:    SNESSetUp - Sets up the internal data structures for the later use
2978:    of a nonlinear solver.

2980:    Collective on SNES

2982:    Input Parameters:
2983: .  snes - the SNES context

2985:    Notes:
2986:    For basic use of the SNES solvers the user need not explicitly call
2987:    SNESSetUp(), since these actions will automatically occur during
2988:    the call to SNESSolve().  However, if one wishes to control this
2989:    phase separately, SNESSetUp() should be called after SNESCreate()
2990:    and optional routines of the form SNESSetXXX(), but before SNESSolve().

2992:    Level: advanced

2994: .seealso: SNESCreate(), SNESSolve(), SNESDestroy()
2995: @*/
2996: PetscErrorCode  SNESSetUp(SNES snes)
2997: {
2999:   DM             dm;
3000:   DMSNES         sdm;
3001:   SNESLineSearch linesearch, pclinesearch;
3002:   void           *lsprectx,*lspostctx;
3003:   PetscErrorCode (*precheck)(SNESLineSearch,Vec,Vec,PetscBool*,void*);
3004:   PetscErrorCode (*postcheck)(SNESLineSearch,Vec,Vec,Vec,PetscBool*,PetscBool*,void*);
3005:   PetscErrorCode (*func)(SNES,Vec,Vec,void*);
3006:   Vec            f,fpc;
3007:   void           *funcctx;
3008:   PetscErrorCode (*jac)(SNES,Vec,Mat,Mat,void*);
3009:   void           *jacctx,*appctx;
3010:   Mat            j,jpre;

3014:   if (snes->setupcalled) return(0);
3015:   PetscLogEventBegin(SNES_Setup,snes,0,0,0);

3017:   if (!((PetscObject)snes)->type_name) {
3018:     SNESSetType(snes,SNESNEWTONLS);
3019:   }

3021:   SNESGetFunction(snes,&snes->vec_func,NULL,NULL);

3023:   SNESGetDM(snes,&dm);
3024:   DMGetDMSNES(dm,&sdm);
3025:   if (!sdm->ops->computefunction) SETERRQ(PetscObjectComm((PetscObject)dm),PETSC_ERR_ARG_WRONGSTATE,"Function never provided to SNES object");
3026:   if (!sdm->ops->computejacobian) {
3027:     DMSNESSetJacobian(dm,SNESComputeJacobianDefaultColor,NULL);
3028:   }
3029:   if (!snes->vec_func) {
3030:     DMCreateGlobalVector(dm,&snes->vec_func);
3031:   }

3033:   if (!snes->ksp) {
3034:     SNESGetKSP(snes, &snes->ksp);
3035:   }

3037:   if (snes->linesearch) {
3038:     SNESGetLineSearch(snes, &snes->linesearch);
3039:     SNESLineSearchSetFunction(snes->linesearch,SNESComputeFunction);
3040:   }

3042:   if (snes->npc && (snes->npcside== PC_LEFT)) {
3043:     snes->mf          = PETSC_TRUE;
3044:     snes->mf_operator = PETSC_FALSE;
3045:   }

3047:   if (snes->npc) {
3048:     /* copy the DM over */
3049:     SNESGetDM(snes,&dm);
3050:     SNESSetDM(snes->npc,dm);

3052:     SNESGetFunction(snes,&f,&func,&funcctx);
3053:     VecDuplicate(f,&fpc);
3054:     SNESSetFunction(snes->npc,fpc,func,funcctx);
3055:     SNESGetJacobian(snes,&j,&jpre,&jac,&jacctx);
3056:     SNESSetJacobian(snes->npc,j,jpre,jac,jacctx);
3057:     SNESGetApplicationContext(snes,&appctx);
3058:     SNESSetApplicationContext(snes->npc,appctx);
3059:     VecDestroy(&fpc);

3061:     /* copy the function pointers over */
3062:     PetscObjectCopyFortranFunctionPointers((PetscObject)snes,(PetscObject)snes->npc);

3064:     /* default to 1 iteration */
3065:     SNESSetTolerances(snes->npc,0.0,0.0,0.0,1,snes->npc->max_funcs);
3066:     if (snes->npcside==PC_RIGHT) {
3067:       SNESSetNormSchedule(snes->npc,SNES_NORM_FINAL_ONLY);
3068:     } else {
3069:       SNESSetNormSchedule(snes->npc,SNES_NORM_NONE);
3070:     }
3071:     SNESSetFromOptions(snes->npc);

3073:     /* copy the line search context over */
3074:     if (snes->linesearch && snes->npc->linesearch) {
3075:       SNESGetLineSearch(snes,&linesearch);
3076:       SNESGetLineSearch(snes->npc,&pclinesearch);
3077:       SNESLineSearchGetPreCheck(linesearch,&precheck,&lsprectx);
3078:       SNESLineSearchGetPostCheck(linesearch,&postcheck,&lspostctx);
3079:       SNESLineSearchSetPreCheck(pclinesearch,precheck,lsprectx);
3080:       SNESLineSearchSetPostCheck(pclinesearch,postcheck,lspostctx);
3081:       PetscObjectCopyFortranFunctionPointers((PetscObject)linesearch, (PetscObject)pclinesearch);
3082:     }
3083:   }
3084:   if (snes->mf) {
3085:     SNESSetUpMatrixFree_Private(snes, snes->mf_operator, snes->mf_version);
3086:   }
3087:   if (snes->ops->usercompute && !snes->user) {
3088:     (*snes->ops->usercompute)(snes,(void**)&snes->user);
3089:   }

3091:   snes->jac_iter = 0;
3092:   snes->pre_iter = 0;

3094:   if (snes->ops->setup) {
3095:     (*snes->ops->setup)(snes);
3096:   }

3098:   if (snes->npc && (snes->npcside== PC_LEFT)) {
3099:     if (snes->functype == SNES_FUNCTION_PRECONDITIONED) {
3100:       if (snes->linesearch){
3101:         SNESGetLineSearch(snes,&linesearch);
3102:         SNESLineSearchSetFunction(linesearch,SNESComputeFunctionDefaultNPC);
3103:       }
3104:     }
3105:   }
3106:   PetscLogEventEnd(SNES_Setup,snes,0,0,0);
3107:   snes->setupcalled = PETSC_TRUE;
3108:   return(0);
3109: }

3111: /*@
3112:    SNESReset - Resets a SNES context to the snessetupcalled = 0 state and removes any allocated Vecs and Mats

3114:    Collective on SNES

3116:    Input Parameter:
3117: .  snes - iterative context obtained from SNESCreate()

3119:    Level: intermediate

3121:    Notes:
3122:     Also calls the application context destroy routine set with SNESSetComputeApplicationContext()

3124: .seealso: SNESCreate(), SNESSetUp(), SNESSolve()
3125: @*/
3126: PetscErrorCode  SNESReset(SNES snes)
3127: {

3132:   if (snes->ops->userdestroy && snes->user) {
3133:     (*snes->ops->userdestroy)((void**)&snes->user);
3134:     snes->user = NULL;
3135:   }
3136:   if (snes->npc) {
3137:     SNESReset(snes->npc);
3138:   }

3140:   if (snes->ops->reset) {
3141:     (*snes->ops->reset)(snes);
3142:   }
3143:   if (snes->ksp) {
3144:     KSPReset(snes->ksp);
3145:   }

3147:   if (snes->linesearch) {
3148:     SNESLineSearchReset(snes->linesearch);
3149:   }

3151:   VecDestroy(&snes->vec_rhs);
3152:   VecDestroy(&snes->vec_sol);
3153:   VecDestroy(&snes->vec_sol_update);
3154:   VecDestroy(&snes->vec_func);
3155:   MatDestroy(&snes->jacobian);
3156:   MatDestroy(&snes->jacobian_pre);
3157:   VecDestroyVecs(snes->nwork,&snes->work);
3158:   VecDestroyVecs(snes->nvwork,&snes->vwork);

3160:   snes->alwayscomputesfinalresidual = PETSC_FALSE;

3162:   snes->nwork       = snes->nvwork = 0;
3163:   snes->setupcalled = PETSC_FALSE;
3164:   return(0);
3165: }

3167: /*@
3168:    SNESDestroy - Destroys the nonlinear solver context that was created
3169:    with SNESCreate().

3171:    Collective on SNES

3173:    Input Parameter:
3174: .  snes - the SNES context

3176:    Level: beginner

3178: .seealso: SNESCreate(), SNESSolve()
3179: @*/
3180: PetscErrorCode  SNESDestroy(SNES *snes)
3181: {

3185:   if (!*snes) return(0);
3187:   if (--((PetscObject)(*snes))->refct > 0) {*snes = 0; return(0);}

3189:   SNESReset((*snes));
3190:   SNESDestroy(&(*snes)->npc);

3192:   /* if memory was published with SAWs then destroy it */
3193:   PetscObjectSAWsViewOff((PetscObject)*snes);
3194:   if ((*snes)->ops->destroy) {(*((*snes))->ops->destroy)((*snes));}

3196:   if ((*snes)->dm) {DMCoarsenHookRemove((*snes)->dm,DMCoarsenHook_SNESVecSol,DMRestrictHook_SNESVecSol,*snes);}
3197:   DMDestroy(&(*snes)->dm);
3198:   KSPDestroy(&(*snes)->ksp);
3199:   SNESLineSearchDestroy(&(*snes)->linesearch);

3201:   PetscFree((*snes)->kspconvctx);
3202:   if ((*snes)->ops->convergeddestroy) {
3203:     (*(*snes)->ops->convergeddestroy)((*snes)->cnvP);
3204:   }
3205:   if ((*snes)->conv_hist_alloc) {
3206:     PetscFree2((*snes)->conv_hist,(*snes)->conv_hist_its);
3207:   }
3208:   SNESMonitorCancel((*snes));
3209:   PetscHeaderDestroy(snes);
3210:   return(0);
3211: }

3213: /* ----------- Routines to set solver parameters ---------- */

3215: /*@
3216:    SNESSetLagPreconditioner - Determines when the preconditioner is rebuilt in the nonlinear solve.

3218:    Logically Collective on SNES

3220:    Input Parameters:
3221: +  snes - the SNES context
3222: -  lag - -1 indicates NEVER rebuild, 1 means rebuild every time the Jacobian is computed within a single nonlinear solve, 2 means every second time
3223:          the Jacobian is built etc. -2 indicates rebuild preconditioner at next chance but then never rebuild after that

3225:    Options Database Keys:
3226: .    -snes_lag_preconditioner <lag>

3228:    Notes:
3229:    The default is 1
3230:    The preconditioner is ALWAYS built in the first iteration of a nonlinear solve unless lag is -1
3231:    If  -1 is used before the very first nonlinear solve the preconditioner is still built because there is no previous preconditioner to use

3233:    Level: intermediate

3235: .seealso: SNESSetTrustRegionTolerance(), SNESGetLagPreconditioner(), SNESSetLagJacobian(), SNESGetLagJacobian()

3237: @*/
3238: PetscErrorCode  SNESSetLagPreconditioner(SNES snes,PetscInt lag)
3239: {
3242:   if (lag < -2) SETERRQ(PETSC_COMM_SELF,PETSC_ERR_ARG_OUTOFRANGE,"Lag must be -2, -1, 1 or greater");
3243:   if (!lag) SETERRQ(PETSC_COMM_SELF,PETSC_ERR_ARG_OUTOFRANGE,"Lag cannot be 0");
3245:   snes->lagpreconditioner = lag;
3246:   return(0);
3247: }

3249: /*@
3250:    SNESSetGridSequence - sets the number of steps of grid sequencing that SNES does

3252:    Logically Collective on SNES

3254:    Input Parameters:
3255: +  snes - the SNES context
3256: -  steps - the number of refinements to do, defaults to 0

3258:    Options Database Keys:
3259: .    -snes_grid_sequence <steps>

3261:    Level: intermediate

3263:    Notes:
3264:    Use SNESGetSolution() to extract the fine grid solution after grid sequencing.

3266: .seealso: SNESSetTrustRegionTolerance(), SNESGetLagPreconditioner(), SNESSetLagJacobian(), SNESGetLagJacobian(), SNESGetGridSequence()

3268: @*/
3269: PetscErrorCode  SNESSetGridSequence(SNES snes,PetscInt steps)
3270: {
3274:   snes->gridsequence = steps;
3275:   return(0);
3276: }

3278: /*@
3279:    SNESGetGridSequence - gets the number of steps of grid sequencing that SNES does

3281:    Logically Collective on SNES

3283:    Input Parameter:
3284: .  snes - the SNES context

3286:    Output Parameter:
3287: .  steps - the number of refinements to do, defaults to 0

3289:    Options Database Keys:
3290: .    -snes_grid_sequence <steps>

3292:    Level: intermediate

3294:    Notes:
3295:    Use SNESGetSolution() to extract the fine grid solution after grid sequencing.

3297: .seealso: SNESSetTrustRegionTolerance(), SNESGetLagPreconditioner(), SNESSetLagJacobian(), SNESGetLagJacobian(), SNESSetGridSequence()

3299: @*/
3300: PetscErrorCode  SNESGetGridSequence(SNES snes,PetscInt *steps)
3301: {
3304:   *steps = snes->gridsequence;
3305:   return(0);
3306: }

3308: /*@
3309:    SNESGetLagPreconditioner - Indicates how often the preconditioner is rebuilt

3311:    Not Collective

3313:    Input Parameter:
3314: .  snes - the SNES context

3316:    Output Parameter:
3317: .   lag - -1 indicates NEVER rebuild, 1 means rebuild every time the Jacobian is computed within a single nonlinear solve, 2 means every second time
3318:          the Jacobian is built etc. -2 indicates rebuild preconditioner at next chance but then never rebuild after that

3320:    Options Database Keys:
3321: .    -snes_lag_preconditioner <lag>

3323:    Notes:
3324:    The default is 1
3325:    The preconditioner is ALWAYS built in the first iteration of a nonlinear solve unless lag is -1

3327:    Level: intermediate

3329: .seealso: SNESSetTrustRegionTolerance(), SNESSetLagPreconditioner()

3331: @*/
3332: PetscErrorCode  SNESGetLagPreconditioner(SNES snes,PetscInt *lag)
3333: {
3336:   *lag = snes->lagpreconditioner;
3337:   return(0);
3338: }

3340: /*@
3341:    SNESSetLagJacobian - Determines when the Jacobian is rebuilt in the nonlinear solve. See SNESSetLagPreconditioner() for determining how
3342:      often the preconditioner is rebuilt.

3344:    Logically Collective on SNES

3346:    Input Parameters:
3347: +  snes - the SNES context
3348: -  lag - -1 indicates NEVER rebuild, 1 means rebuild every time the Jacobian is computed within a single nonlinear solve, 2 means every second time
3349:          the Jacobian is built etc. -2 means rebuild at next chance but then never again

3351:    Options Database Keys:
3352: .    -snes_lag_jacobian <lag>

3354:    Notes:
3355:    The default is 1
3356:    The Jacobian is ALWAYS built in the first iteration of a nonlinear solve unless lag is -1
3357:    If  -1 is used before the very first nonlinear solve the CODE WILL FAIL! because no Jacobian is used, use -2 to indicate you want it recomputed
3358:    at the next Newton step but never again (unless it is reset to another value)

3360:    Level: intermediate

3362: .seealso: SNESSetTrustRegionTolerance(), SNESGetLagPreconditioner(), SNESSetLagPreconditioner(), SNESGetLagJacobian()

3364: @*/
3365: PetscErrorCode  SNESSetLagJacobian(SNES snes,PetscInt lag)
3366: {
3369:   if (lag < -2) SETERRQ(PETSC_COMM_SELF,PETSC_ERR_ARG_OUTOFRANGE,"Lag must be -2, -1, 1 or greater");
3370:   if (!lag) SETERRQ(PETSC_COMM_SELF,PETSC_ERR_ARG_OUTOFRANGE,"Lag cannot be 0");
3372:   snes->lagjacobian = lag;
3373:   return(0);
3374: }

3376: /*@
3377:    SNESGetLagJacobian - Indicates how often the Jacobian is rebuilt. See SNESGetLagPreconditioner() to determine when the preconditioner is rebuilt

3379:    Not Collective

3381:    Input Parameter:
3382: .  snes - the SNES context

3384:    Output Parameter:
3385: .   lag - -1 indicates NEVER rebuild, 1 means rebuild every time the Jacobian is computed within a single nonlinear solve, 2 means every second time
3386:          the Jacobian is built etc.

3388:    Options Database Keys:
3389: .    -snes_lag_jacobian <lag>

3391:    Notes:
3392:    The default is 1
3393:    The jacobian is ALWAYS built in the first iteration of a nonlinear solve unless lag is -1

3395:    Level: intermediate

3397: .seealso: SNESSetTrustRegionTolerance(), SNESSetLagJacobian(), SNESSetLagPreconditioner(), SNESGetLagPreconditioner()

3399: @*/
3400: PetscErrorCode  SNESGetLagJacobian(SNES snes,PetscInt *lag)
3401: {
3404:   *lag = snes->lagjacobian;
3405:   return(0);
3406: }

3408: /*@
3409:    SNESSetLagJacobianPersists - Set whether or not the Jacobian lagging persists through multiple solves

3411:    Logically collective on SNES

3413:    Input Parameter:
3414: +  snes - the SNES context
3415: -   flg - jacobian lagging persists if true

3417:    Options Database Keys:
3418: .    -snes_lag_jacobian_persists <flg>

3420:    Notes:
3421:     This is useful both for nonlinear preconditioning, where it's appropriate to have the Jacobian be stale by
3422:    several solves, and for implicit time-stepping, where Jacobian lagging in the inner nonlinear solve over several
3423:    timesteps may present huge efficiency gains.

3425:    Level: developer

3427: .seealso: SNESSetLagPreconditionerPersists(), SNESSetLagJacobian(), SNESGetLagJacobian(), SNESGetNPC()

3429: @*/
3430: PetscErrorCode  SNESSetLagJacobianPersists(SNES snes,PetscBool flg)
3431: {
3435:   snes->lagjac_persist = flg;
3436:   return(0);
3437: }

3439: /*@
3440:    SNESSetLagPreconditionerPersists - Set whether or not the preconditioner lagging persists through multiple solves

3442:    Logically Collective on SNES

3444:    Input Parameter:
3445: +  snes - the SNES context
3446: -   flg - preconditioner lagging persists if true

3448:    Options Database Keys:
3449: .    -snes_lag_jacobian_persists <flg>

3451:    Notes:
3452:     This is useful both for nonlinear preconditioning, where it's appropriate to have the preconditioner be stale
3453:    by several solves, and for implicit time-stepping, where preconditioner lagging in the inner nonlinear solve over
3454:    several timesteps may present huge efficiency gains.

3456:    Level: developer

3458: .seealso: SNESSetLagJacobianPersists(), SNESSetLagJacobian(), SNESGetLagJacobian(), SNESGetNPC()

3460: @*/
3461: PetscErrorCode  SNESSetLagPreconditionerPersists(SNES snes,PetscBool flg)
3462: {
3466:   snes->lagpre_persist = flg;
3467:   return(0);
3468: }

3470: /*@
3471:    SNESSetForceIteration - force SNESSolve() to take at least one iteration regardless of the initial residual norm

3473:    Logically Collective on SNES

3475:    Input Parameters:
3476: +  snes - the SNES context
3477: -  force - PETSC_TRUE require at least one iteration

3479:    Options Database Keys:
3480: .    -snes_force_iteration <force> - Sets forcing an iteration

3482:    Notes:
3483:    This is used sometimes with TS to prevent TS from detecting a false steady state solution

3485:    Level: intermediate

3487: .seealso: SNESSetTrustRegionTolerance(), SNESSetDivergenceTolerance()
3488: @*/
3489: PetscErrorCode  SNESSetForceIteration(SNES snes,PetscBool force)
3490: {
3493:   snes->forceiteration = force;
3494:   return(0);
3495: }

3497: /*@
3498:    SNESGetForceIteration - Whether or not to force SNESSolve() take at least one iteration regardless of the initial residual norm

3500:    Logically Collective on SNES

3502:    Input Parameters:
3503: .  snes - the SNES context

3505:    Output Parameter:
3506: .  force - PETSC_TRUE requires at least one iteration.

3508:    Level: intermediate

3510: .seealso: SNESSetForceIteration(), SNESSetTrustRegionTolerance(), SNESSetDivergenceTolerance()
3511: @*/
3512: PetscErrorCode  SNESGetForceIteration(SNES snes,PetscBool *force)
3513: {
3516:   *force = snes->forceiteration;
3517:   return(0);
3518: }

3520: /*@
3521:    SNESSetTolerances - Sets various parameters used in convergence tests.

3523:    Logically Collective on SNES

3525:    Input Parameters:
3526: +  snes - the SNES context
3527: .  abstol - absolute convergence tolerance
3528: .  rtol - relative convergence tolerance
3529: .  stol -  convergence tolerance in terms of the norm of the change in the solution between steps,  || delta x || < stol*|| x ||
3530: .  maxit - maximum number of iterations
3531: -  maxf - maximum number of function evaluations (-1 indicates no limit)

3533:    Options Database Keys:
3534: +    -snes_atol <abstol> - Sets abstol
3535: .    -snes_rtol <rtol> - Sets rtol
3536: .    -snes_stol <stol> - Sets stol
3537: .    -snes_max_it <maxit> - Sets maxit
3538: -    -snes_max_funcs <maxf> - Sets maxf

3540:    Notes:
3541:    The default maximum number of iterations is 50.
3542:    The default maximum number of function evaluations is 1000.

3544:    Level: intermediate

3546: .seealso: SNESSetTrustRegionTolerance(), SNESSetDivergenceTolerance(), SNESSetForceIteration()
3547: @*/
3548: PetscErrorCode  SNESSetTolerances(SNES snes,PetscReal abstol,PetscReal rtol,PetscReal stol,PetscInt maxit,PetscInt maxf)
3549: {

3558:   if (abstol != PETSC_DEFAULT) {
3559:     if (abstol < 0.0) SETERRQ1(PetscObjectComm((PetscObject)snes),PETSC_ERR_ARG_OUTOFRANGE,"Absolute tolerance %g must be non-negative",(double)abstol);
3560:     snes->abstol = abstol;
3561:   }
3562:   if (rtol != PETSC_DEFAULT) {
3563:     if (rtol < 0.0 || 1.0 <= rtol) SETERRQ1(PetscObjectComm((PetscObject)snes),PETSC_ERR_ARG_OUTOFRANGE,"Relative tolerance %g must be non-negative and less than 1.0",(double)rtol);
3564:     snes->rtol = rtol;
3565:   }
3566:   if (stol != PETSC_DEFAULT) {
3567:     if (stol < 0.0) SETERRQ1(PetscObjectComm((PetscObject)snes),PETSC_ERR_ARG_OUTOFRANGE,"Step tolerance %g must be non-negative",(double)stol);
3568:     snes->stol = stol;
3569:   }
3570:   if (maxit != PETSC_DEFAULT) {
3571:     if (maxit < 0) SETERRQ1(PetscObjectComm((PetscObject)snes),PETSC_ERR_ARG_OUTOFRANGE,"Maximum number of iterations %D must be non-negative",maxit);
3572:     snes->max_its = maxit;
3573:   }
3574:   if (maxf != PETSC_DEFAULT) {
3575:     if (maxf < -1) SETERRQ1(PetscObjectComm((PetscObject)snes),PETSC_ERR_ARG_OUTOFRANGE,"Maximum number of function evaluations %D must be -1 or nonnegative",maxf);
3576:     snes->max_funcs = maxf;
3577:   }
3578:   snes->tolerancesset = PETSC_TRUE;
3579:   return(0);
3580: }

3582: /*@
3583:    SNESSetDivergenceTolerance - Sets the divergence tolerance used for the SNES divergence test.

3585:    Logically Collective on SNES

3587:    Input Parameters:
3588: +  snes - the SNES context
3589: -  divtol - the divergence tolerance. Use -1 to deactivate the test.

3591:    Options Database Keys:
3592: .    -snes_divergence_tolerance <divtol> - Sets divtol

3594:    Notes:
3595:    The default divergence tolerance is 1e4.

3597:    Level: intermediate

3599: .seealso: SNESSetTolerances(), SNESGetDivergenceTolerance
3600: @*/
3601: PetscErrorCode  SNESSetDivergenceTolerance(SNES snes,PetscReal divtol)
3602: {

3607:   if (divtol != PETSC_DEFAULT) {
3608:     snes->divtol = divtol;
3609:   }
3610:   else {
3611:     snes->divtol = 1.0e4;
3612:   }
3613:   return(0);
3614: }

3616: /*@
3617:    SNESGetTolerances - Gets various parameters used in convergence tests.

3619:    Not Collective

3621:    Input Parameters:
3622: +  snes - the SNES context
3623: .  atol - absolute convergence tolerance
3624: .  rtol - relative convergence tolerance
3625: .  stol -  convergence tolerance in terms of the norm
3626:            of the change in the solution between steps
3627: .  maxit - maximum number of iterations
3628: -  maxf - maximum number of function evaluations

3630:    Notes:
3631:    The user can specify NULL for any parameter that is not needed.

3633:    Level: intermediate

3635: .seealso: SNESSetTolerances()
3636: @*/
3637: PetscErrorCode  SNESGetTolerances(SNES snes,PetscReal *atol,PetscReal *rtol,PetscReal *stol,PetscInt *maxit,PetscInt *maxf)
3638: {
3641:   if (atol)  *atol  = snes->abstol;
3642:   if (rtol)  *rtol  = snes->rtol;
3643:   if (stol)  *stol  = snes->stol;
3644:   if (maxit) *maxit = snes->max_its;
3645:   if (maxf)  *maxf  = snes->max_funcs;
3646:   return(0);
3647: }

3649: /*@
3650:    SNESGetDivergenceTolerance - Gets divergence tolerance used in divergence test.

3652:    Not Collective

3654:    Input Parameters:
3655: +  snes - the SNES context
3656: -  divtol - divergence tolerance

3658:    Level: intermediate

3660: .seealso: SNESSetDivergenceTolerance()
3661: @*/
3662: PetscErrorCode  SNESGetDivergenceTolerance(SNES snes,PetscReal *divtol)
3663: {
3666:   if (divtol) *divtol = snes->divtol;
3667:   return(0);
3668: }

3670: /*@
3671:    SNESSetTrustRegionTolerance - Sets the trust region parameter tolerance.

3673:    Logically Collective on SNES

3675:    Input Parameters:
3676: +  snes - the SNES context
3677: -  tol - tolerance

3679:    Options Database Key:
3680: .  -snes_trtol <tol> - Sets tol

3682:    Level: intermediate

3684: .seealso: SNESSetTolerances()
3685: @*/
3686: PetscErrorCode  SNESSetTrustRegionTolerance(SNES snes,PetscReal tol)
3687: {
3691:   snes->deltatol = tol;
3692:   return(0);
3693: }

3695: /*
3696:    Duplicate the lg monitors for SNES from KSP; for some reason with
3697:    dynamic libraries things don't work under Sun4 if we just use
3698:    macros instead of functions
3699: */
3700: PetscErrorCode  SNESMonitorLGResidualNorm(SNES snes,PetscInt it,PetscReal norm,void *ctx)
3701: {

3706:   KSPMonitorLGResidualNorm((KSP)snes,it,norm,ctx);
3707:   return(0);
3708: }

3710: PetscErrorCode  SNESMonitorLGCreate(MPI_Comm comm,const char host[],const char label[],int x,int y,int m,int n,PetscDrawLG *lgctx)
3711: {

3715:   KSPMonitorLGResidualNormCreate(comm,host,label,x,y,m,n,lgctx);
3716:   return(0);
3717: }

3719: PETSC_INTERN PetscErrorCode  SNESMonitorRange_Private(SNES,PetscInt,PetscReal*);

3721: PetscErrorCode  SNESMonitorLGRange(SNES snes,PetscInt n,PetscReal rnorm,void *monctx)
3722: {
3723:   PetscDrawLG      lg;
3724:   PetscErrorCode   ierr;
3725:   PetscReal        x,y,per;
3726:   PetscViewer      v = (PetscViewer)monctx;
3727:   static PetscReal prev; /* should be in the context */
3728:   PetscDraw        draw;

3732:   PetscViewerDrawGetDrawLG(v,0,&lg);
3733:   if (!n) {PetscDrawLGReset(lg);}
3734:   PetscDrawLGGetDraw(lg,&draw);
3735:   PetscDrawSetTitle(draw,"Residual norm");
3736:   x    = (PetscReal)n;
3737:   if (rnorm > 0.0) y = PetscLog10Real(rnorm);
3738:   else y = -15.0;
3739:   PetscDrawLGAddPoint(lg,&x,&y);
3740:   if (n < 20 || !(n % 5) || snes->reason) {
3741:     PetscDrawLGDraw(lg);
3742:     PetscDrawLGSave(lg);
3743:   }

3745:   PetscViewerDrawGetDrawLG(v,1,&lg);
3746:   if (!n) {PetscDrawLGReset(lg);}
3747:   PetscDrawLGGetDraw(lg,&draw);
3748:   PetscDrawSetTitle(draw,"% elemts > .2*max elemt");
3749:    SNESMonitorRange_Private(snes,n,&per);
3750:   x    = (PetscReal)n;
3751:   y    = 100.0*per;
3752:   PetscDrawLGAddPoint(lg,&x,&y);
3753:   if (n < 20 || !(n % 5) || snes->reason) {
3754:     PetscDrawLGDraw(lg);
3755:     PetscDrawLGSave(lg);
3756:   }

3758:   PetscViewerDrawGetDrawLG(v,2,&lg);
3759:   if (!n) {prev = rnorm;PetscDrawLGReset(lg);}
3760:   PetscDrawLGGetDraw(lg,&draw);
3761:   PetscDrawSetTitle(draw,"(norm -oldnorm)/oldnorm");
3762:   x    = (PetscReal)n;
3763:   y    = (prev - rnorm)/prev;
3764:   PetscDrawLGAddPoint(lg,&x,&y);
3765:   if (n < 20 || !(n % 5) || snes->reason) {
3766:     PetscDrawLGDraw(lg);
3767:     PetscDrawLGSave(lg);
3768:   }

3770:   PetscViewerDrawGetDrawLG(v,3,&lg);
3771:   if (!n) {PetscDrawLGReset(lg);}
3772:   PetscDrawLGGetDraw(lg,&draw);
3773:   PetscDrawSetTitle(draw,"(norm -oldnorm)/oldnorm*(% > .2 max)");
3774:   x    = (PetscReal)n;
3775:   y    = (prev - rnorm)/(prev*per);
3776:   if (n > 2) { /*skip initial crazy value */
3777:     PetscDrawLGAddPoint(lg,&x,&y);
3778:   }
3779:   if (n < 20 || !(n % 5) || snes->reason) {
3780:     PetscDrawLGDraw(lg);
3781:     PetscDrawLGSave(lg);
3782:   }
3783:   prev = rnorm;
3784:   return(0);
3785: }

3787: /*@
3788:    SNESMonitor - runs the user provided monitor routines, if they exist

3790:    Collective on SNES

3792:    Input Parameters:
3793: +  snes - nonlinear solver context obtained from SNESCreate()
3794: .  iter - iteration number
3795: -  rnorm - relative norm of the residual

3797:    Notes:
3798:    This routine is called by the SNES implementations.
3799:    It does not typically need to be called by the user.

3801:    Level: developer

3803: .seealso: SNESMonitorSet()
3804: @*/
3805: PetscErrorCode  SNESMonitor(SNES snes,PetscInt iter,PetscReal rnorm)
3806: {
3808:   PetscInt       i,n = snes->numbermonitors;

3811:   VecLockReadPush(snes->vec_sol);
3812:   for (i=0; i<n; i++) {
3813:     (*snes->monitor[i])(snes,iter,rnorm,snes->monitorcontext[i]);
3814:   }
3815:   VecLockReadPop(snes->vec_sol);
3816:   return(0);
3817: }

3819: /* ------------ Routines to set performance monitoring options ----------- */

3821: /*MC
3822:     SNESMonitorFunction - functional form passed to SNESMonitorSet() to monitor convergence of nonlinear solver

3824:      Synopsis:
3825:      #include <petscsnes.h>
3826: $    PetscErrorCode SNESMonitorFunction(SNES snes,PetscInt its, PetscReal norm,void *mctx)

3828: +    snes - the SNES context
3829: .    its - iteration number
3830: .    norm - 2-norm function value (may be estimated)
3831: -    mctx - [optional] monitoring context

3833:    Level: advanced

3835: .seealso:   SNESMonitorSet(), SNESMonitorGet()
3836: M*/

3838: /*@C
3839:    SNESMonitorSet - Sets an ADDITIONAL function that is to be used at every
3840:    iteration of the nonlinear solver to display the iteration's
3841:    progress.

3843:    Logically Collective on SNES

3845:    Input Parameters:
3846: +  snes - the SNES context
3847: .  f - the monitor function, see SNESMonitorFunction for the calling sequence
3848: .  mctx - [optional] user-defined context for private data for the
3849:           monitor routine (use NULL if no context is desired)
3850: -  monitordestroy - [optional] routine that frees monitor context
3851:           (may be NULL)

3853:    Options Database Keys:
3854: +    -snes_monitor        - sets SNESMonitorDefault()
3855: .    -snes_monitor_lg_residualnorm    - sets line graph monitor,
3856:                             uses SNESMonitorLGCreate()
3857: -    -snes_monitor_cancel - cancels all monitors that have
3858:                             been hardwired into a code by
3859:                             calls to SNESMonitorSet(), but
3860:                             does not cancel those set via
3861:                             the options database.

3863:    Notes:
3864:    Several different monitoring routines may be set by calling
3865:    SNESMonitorSet() multiple times; all will be called in the
3866:    order in which they were set.

3868:    Fortran Notes:
3869:     Only a single monitor function can be set for each SNES object

3871:    Level: intermediate

3873: .seealso: SNESMonitorDefault(), SNESMonitorCancel(), SNESMonitorFunction
3874: @*/
3875: PetscErrorCode  SNESMonitorSet(SNES snes,PetscErrorCode (*f)(SNES,PetscInt,PetscReal,void*),void *mctx,PetscErrorCode (*monitordestroy)(void**))
3876: {
3877:   PetscInt       i;
3879:   PetscBool      identical;

3883:   for (i=0; i<snes->numbermonitors;i++) {
3884:     PetscMonitorCompare((PetscErrorCode (*)(void))f,mctx,monitordestroy,(PetscErrorCode (*)(void))snes->monitor[i],snes->monitorcontext[i],snes->monitordestroy[i],&identical);
3885:     if (identical) return(0);
3886:   }
3887:   if (snes->numbermonitors >= MAXSNESMONITORS) SETERRQ(PETSC_COMM_SELF,PETSC_ERR_ARG_OUTOFRANGE,"Too many monitors set");
3888:   snes->monitor[snes->numbermonitors]          = f;
3889:   snes->monitordestroy[snes->numbermonitors]   = monitordestroy;
3890:   snes->monitorcontext[snes->numbermonitors++] = (void*)mctx;
3891:   return(0);
3892: }

3894: /*@
3895:    SNESMonitorCancel - Clears all the monitor functions for a SNES object.

3897:    Logically Collective on SNES

3899:    Input Parameters:
3900: .  snes - the SNES context

3902:    Options Database Key:
3903: .  -snes_monitor_cancel - cancels all monitors that have been hardwired
3904:     into a code by calls to SNESMonitorSet(), but does not cancel those
3905:     set via the options database

3907:    Notes:
3908:    There is no way to clear one specific monitor from a SNES object.

3910:    Level: intermediate

3912: .seealso: SNESMonitorDefault(), SNESMonitorSet()
3913: @*/
3914: PetscErrorCode  SNESMonitorCancel(SNES snes)
3915: {
3917:   PetscInt       i;

3921:   for (i=0; i<snes->numbermonitors; i++) {
3922:     if (snes->monitordestroy[i]) {
3923:       (*snes->monitordestroy[i])(&snes->monitorcontext[i]);
3924:     }
3925:   }
3926:   snes->numbermonitors = 0;
3927:   return(0);
3928: }

3930: /*MC
3931:     SNESConvergenceTestFunction - functional form used for testing of convergence of nonlinear solver

3933:      Synopsis:
3934:      #include <petscsnes.h>
3935: $     PetscErrorCode SNESConvergenceTest(SNES snes,PetscInt it,PetscReal xnorm,PetscReal gnorm,PetscReal f,SNESConvergedReason *reason,void *cctx)

3937: +    snes - the SNES context
3938: .    it - current iteration (0 is the first and is before any Newton step)
3939: .    cctx - [optional] convergence context
3940: .    reason - reason for convergence/divergence
3941: .    xnorm - 2-norm of current iterate
3942: .    gnorm - 2-norm of current step
3943: -    f - 2-norm of function

3945:    Level: intermediate

3947: .seealso:   SNESSetConvergenceTest(), SNESGetConvergenceTest()
3948: M*/

3950: /*@C
3951:    SNESSetConvergenceTest - Sets the function that is to be used
3952:    to test for convergence of the nonlinear iterative solution.

3954:    Logically Collective on SNES

3956:    Input Parameters:
3957: +  snes - the SNES context
3958: .  SNESConvergenceTestFunction - routine to test for convergence
3959: .  cctx - [optional] context for private data for the convergence routine  (may be NULL)
3960: -  destroy - [optional] destructor for the context (may be NULL; PETSC_NULL_FUNCTION in Fortran)

3962:    Level: advanced

3964: .seealso: SNESConvergedDefault(), SNESConvergedSkip(), SNESConvergenceTestFunction
3965: @*/
3966: PetscErrorCode  SNESSetConvergenceTest(SNES snes,PetscErrorCode (*SNESConvergenceTestFunction)(SNES,PetscInt,PetscReal,PetscReal,PetscReal,SNESConvergedReason*,void*),void *cctx,PetscErrorCode (*destroy)(void*))
3967: {

3972:   if (!SNESConvergenceTestFunction) SNESConvergenceTestFunction = SNESConvergedSkip;
3973:   if (snes->ops->convergeddestroy) {
3974:     (*snes->ops->convergeddestroy)(snes->cnvP);
3975:   }
3976:   snes->ops->converged        = SNESConvergenceTestFunction;
3977:   snes->ops->convergeddestroy = destroy;
3978:   snes->cnvP                  = cctx;
3979:   return(0);
3980: }

3982: /*@
3983:    SNESGetConvergedReason - Gets the reason the SNES iteration was stopped.

3985:    Not Collective

3987:    Input Parameter:
3988: .  snes - the SNES context

3990:    Output Parameter:
3991: .  reason - negative value indicates diverged, positive value converged, see SNESConvergedReason or the
3992:             manual pages for the individual convergence tests for complete lists

3994:    Options Database:
3995: .   -snes_converged_reason - prints the reason to standard out

3997:    Level: intermediate

3999:    Notes:
4000:     Should only be called after the call the SNESSolve() is complete, if it is called earlier it returns the value SNES__CONVERGED_ITERATING.

4002: .seealso: SNESSetConvergenceTest(), SNESSetConvergedReason(), SNESConvergedReason
4003: @*/
4004: PetscErrorCode SNESGetConvergedReason(SNES snes,SNESConvergedReason *reason)
4005: {
4009:   *reason = snes->reason;
4010:   return(0);
4011: }

4013: /*@
4014:    SNESSetConvergedReason - Sets the reason the SNES iteration was stopped.

4016:    Not Collective

4018:    Input Parameters:
4019: +  snes - the SNES context
4020: -  reason - negative value indicates diverged, positive value converged, see SNESConvergedReason or the
4021:             manual pages for the individual convergence tests for complete lists

4023:    Level: intermediate

4025: .seealso: SNESGetConvergedReason(), SNESSetConvergenceTest(), SNESConvergedReason
4026: @*/
4027: PetscErrorCode SNESSetConvergedReason(SNES snes,SNESConvergedReason reason)
4028: {
4031:   snes->reason = reason;
4032:   return(0);
4033: }

4035: /*@
4036:    SNESSetConvergenceHistory - Sets the array used to hold the convergence history.

4038:    Logically Collective on SNES

4040:    Input Parameters:
4041: +  snes - iterative context obtained from SNESCreate()
4042: .  a   - array to hold history, this array will contain the function norms computed at each step
4043: .  its - integer array holds the number of linear iterations for each solve.
4044: .  na  - size of a and its
4045: -  reset - PETSC_TRUE indicates each new nonlinear solve resets the history counter to zero,
4046:            else it continues storing new values for new nonlinear solves after the old ones

4048:    Notes:
4049:    If 'a' and 'its' are NULL then space is allocated for the history. If 'na' PETSC_DECIDE or PETSC_DEFAULT then a
4050:    default array of length 10000 is allocated.

4052:    This routine is useful, e.g., when running a code for purposes
4053:    of accurate performance monitoring, when no I/O should be done
4054:    during the section of code that is being timed.

4056:    Level: intermediate

4058: .seealso: SNESGetConvergenceHistory()

4060: @*/
4061: PetscErrorCode  SNESSetConvergenceHistory(SNES snes,PetscReal a[],PetscInt its[],PetscInt na,PetscBool reset)
4062: {

4069:   if (!a) {
4070:     if (na == PETSC_DECIDE || na == PETSC_DEFAULT) na = 1000;
4071:     PetscCalloc2(na,&a,na,&its);
4072:     snes->conv_hist_alloc = PETSC_TRUE;
4073:   }
4074:   snes->conv_hist       = a;
4075:   snes->conv_hist_its   = its;
4076:   snes->conv_hist_max   = na;
4077:   snes->conv_hist_len   = 0;
4078:   snes->conv_hist_reset = reset;
4079:   return(0);
4080: }

4082: #if defined(PETSC_HAVE_MATLAB_ENGINE)
4083: #include <engine.h>   /* MATLAB include file */
4084: #include <mex.h>      /* MATLAB include file */

4086: PETSC_EXTERN mxArray *SNESGetConvergenceHistoryMatlab(SNES snes)
4087: {
4088:   mxArray   *mat;
4089:   PetscInt  i;
4090:   PetscReal *ar;

4093:   mat = mxCreateDoubleMatrix(snes->conv_hist_len,1,mxREAL);
4094:   ar  = (PetscReal*) mxGetData(mat);
4095:   for (i=0; i<snes->conv_hist_len; i++) ar[i] = snes->conv_hist[i];
4096:   PetscFunctionReturn(mat);
4097: }
4098: #endif

4100: /*@C
4101:    SNESGetConvergenceHistory - Gets the array used to hold the convergence history.

4103:    Not Collective

4105:    Input Parameter:
4106: .  snes - iterative context obtained from SNESCreate()

4108:    Output Parameters:
4109: +  a   - array to hold history
4110: .  its - integer array holds the number of linear iterations (or
4111:          negative if not converged) for each solve.
4112: -  na  - size of a and its

4114:    Notes:
4115:     The calling sequence for this routine in Fortran is
4116: $   call SNESGetConvergenceHistory(SNES snes, integer na, integer ierr)

4118:    This routine is useful, e.g., when running a code for purposes
4119:    of accurate performance monitoring, when no I/O should be done
4120:    during the section of code that is being timed.

4122:    Level: intermediate

4124: .seealso: SNESSetConvergencHistory()

4126: @*/
4127: PetscErrorCode  SNESGetConvergenceHistory(SNES snes,PetscReal *a[],PetscInt *its[],PetscInt *na)
4128: {
4131:   if (a)   *a   = snes->conv_hist;
4132:   if (its) *its = snes->conv_hist_its;
4133:   if (na)  *na  = snes->conv_hist_len;
4134:   return(0);
4135: }

4137: /*@C
4138:   SNESSetUpdate - Sets the general-purpose update function called
4139:   at the beginning of every iteration of the nonlinear solve. Specifically
4140:   it is called just before the Jacobian is "evaluated".

4142:   Logically Collective on SNES

4144:   Input Parameters:
4145: + snes - The nonlinear solver context
4146: - func - The function

4148:   Calling sequence of func:
4149: $ func (SNES snes, PetscInt step);

4151: . step - The current step of the iteration

4153:   Level: advanced

4155:   Note: This is NOT what one uses to update the ghost points before a function evaluation, that should be done at the beginning of your FormFunction()
4156:         This is not used by most users.

4158: .seealso SNESSetJacobian(), SNESSolve()
4159: @*/
4160: PetscErrorCode  SNESSetUpdate(SNES snes, PetscErrorCode (*func)(SNES, PetscInt))
4161: {
4164:   snes->ops->update = func;
4165:   return(0);
4166: }

4168: /*
4169:    SNESScaleStep_Private - Scales a step so that its length is less than the
4170:    positive parameter delta.

4172:     Input Parameters:
4173: +   snes - the SNES context
4174: .   y - approximate solution of linear system
4175: .   fnorm - 2-norm of current function
4176: -   delta - trust region size

4178:     Output Parameters:
4179: +   gpnorm - predicted function norm at the new point, assuming local
4180:     linearization.  The value is zero if the step lies within the trust
4181:     region, and exceeds zero otherwise.
4182: -   ynorm - 2-norm of the step

4184:     Note:
4185:     For non-trust region methods such as SNESNEWTONLS, the parameter delta
4186:     is set to be the maximum allowable step size.

4188: */
4189: PetscErrorCode SNESScaleStep_Private(SNES snes,Vec y,PetscReal *fnorm,PetscReal *delta,PetscReal *gpnorm,PetscReal *ynorm)
4190: {
4191:   PetscReal      nrm;
4192:   PetscScalar    cnorm;


4200:   VecNorm(y,NORM_2,&nrm);
4201:   if (nrm > *delta) {
4202:     nrm     = *delta/nrm;
4203:     *gpnorm = (1.0 - nrm)*(*fnorm);
4204:     cnorm   = nrm;
4205:     VecScale(y,cnorm);
4206:     *ynorm  = *delta;
4207:   } else {
4208:     *gpnorm = 0.0;
4209:     *ynorm  = nrm;
4210:   }
4211:   return(0);
4212: }

4214: /*@
4215:    SNESReasonView - Displays the reason a SNES solve converged or diverged to a viewer

4217:    Collective on SNES

4219:    Parameter:
4220: +  snes - iterative context obtained from SNESCreate()
4221: -  viewer - the viewer to display the reason


4224:    Options Database Keys:
4225: .  -snes_converged_reason - print reason for converged or diverged, also prints number of iterations

4227:    Level: beginner

4229: .seealso: SNESCreate(), SNESSetUp(), SNESDestroy(), SNESSetTolerances(), SNESConvergedDefault()

4231: @*/
4232: PetscErrorCode  SNESReasonView(SNES snes,PetscViewer viewer)
4233: {
4234:   PetscViewerFormat format;
4235:   PetscBool         isAscii;
4236:   PetscErrorCode    ierr;

4239:   PetscObjectTypeCompare((PetscObject)viewer,PETSCVIEWERASCII,&isAscii);
4240:   if (isAscii) {
4241:     PetscViewerGetFormat(viewer, &format);
4242:     PetscViewerASCIIAddTab(viewer,((PetscObject)snes)->tablevel);
4243:     if (format == PETSC_VIEWER_ASCII_INFO_DETAIL) {
4244:       DM                dm;
4245:       Vec               u;
4246:       PetscDS           prob;
4247:       PetscInt          Nf, f;
4248:       PetscErrorCode (**exactSol)(PetscInt, PetscReal, const PetscReal[], PetscInt, PetscScalar[], void *);
4249:       void            **exactCtx;
4250:       PetscReal         error;

4252:       SNESGetDM(snes, &dm);
4253:       SNESGetSolution(snes, &u);
4254:       DMGetDS(dm, &prob);
4255:       PetscDSGetNumFields(prob, &Nf);
4256:       PetscMalloc2(Nf, &exactSol, Nf, &exactCtx);
4257:       for (f = 0; f < Nf; ++f) {PetscDSGetExactSolution(prob, f, &exactSol[f], &exactCtx[f]);}
4258:       DMComputeL2Diff(dm, 0.0, exactSol, exactCtx, u, &error);
4259:       PetscFree2(exactSol, exactCtx);
4260:       if (error < 1.0e-11) {PetscViewerASCIIPrintf(viewer, "L_2 Error: < 1.0e-11\n");}
4261:       else                 {PetscViewerASCIIPrintf(viewer, "L_2 Error: %g\n", error);}
4262:     }
4263:     if (snes->reason > 0) {
4264:       if (((PetscObject) snes)->prefix) {
4265:         PetscViewerASCIIPrintf(viewer,"Nonlinear %s solve converged due to %s iterations %D\n",((PetscObject) snes)->prefix,SNESConvergedReasons[snes->reason],snes->iter);
4266:       } else {
4267:         PetscViewerASCIIPrintf(viewer,"Nonlinear solve converged due to %s iterations %D\n",SNESConvergedReasons[snes->reason],snes->iter);
4268:       }
4269:     } else {
4270:       if (((PetscObject) snes)->prefix) {
4271:         PetscViewerASCIIPrintf(viewer,"Nonlinear %s solve did not converge due to %s iterations %D\n",((PetscObject) snes)->prefix,SNESConvergedReasons[snes->reason],snes->iter);
4272:       } else {
4273:         PetscViewerASCIIPrintf(viewer,"Nonlinear solve did not converge due to %s iterations %D\n",SNESConvergedReasons[snes->reason],snes->iter);
4274:       }
4275:     }
4276:     PetscViewerASCIISubtractTab(viewer,((PetscObject)snes)->tablevel);
4277:   }
4278:   return(0);
4279: }

4281: /*@C
4282:   SNESReasonViewFromOptions - Processes command line options to determine if/how a SNESReason is to be viewed.

4284:   Collective on SNES

4286:   Input Parameters:
4287: . snes   - the SNES object

4289:   Level: intermediate

4291: @*/
4292: PetscErrorCode SNESReasonViewFromOptions(SNES snes)
4293: {
4294:   PetscErrorCode    ierr;
4295:   PetscViewer       viewer;
4296:   PetscBool         flg;
4297:   static PetscBool  incall = PETSC_FALSE;
4298:   PetscViewerFormat format;

4301:   if (incall) return(0);
4302:   incall = PETSC_TRUE;
4303:   PetscOptionsGetViewer(PetscObjectComm((PetscObject)snes),((PetscObject)snes)->options,((PetscObject)snes)->prefix,"-snes_converged_reason",&viewer,&format,&flg);
4304:   if (flg) {
4305:     PetscViewerPushFormat(viewer,format);
4306:     SNESReasonView(snes,viewer);
4307:     PetscViewerPopFormat(viewer);
4308:     PetscViewerDestroy(&viewer);
4309:   }
4310:   incall = PETSC_FALSE;
4311:   return(0);
4312: }

4314: /*@
4315:    SNESSolve - Solves a nonlinear system F(x) = b.
4316:    Call SNESSolve() after calling SNESCreate() and optional routines of the form SNESSetXXX().

4318:    Collective on SNES

4320:    Input Parameters:
4321: +  snes - the SNES context
4322: .  b - the constant part of the equation F(x) = b, or NULL to use zero.
4323: -  x - the solution vector.

4325:    Notes:
4326:    The user should initialize the vector,x, with the initial guess
4327:    for the nonlinear solve prior to calling SNESSolve.  In particular,
4328:    to employ an initial guess of zero, the user should explicitly set
4329:    this vector to zero by calling VecSet().

4331:    Level: beginner

4333: .seealso: SNESCreate(), SNESDestroy(), SNESSetFunction(), SNESSetJacobian(), SNESSetGridSequence(), SNESGetSolution()
4334: @*/
4335: PetscErrorCode  SNESSolve(SNES snes,Vec b,Vec x)
4336: {
4337:   PetscErrorCode    ierr;
4338:   PetscBool         flg;
4339:   PetscInt          grid;
4340:   Vec               xcreated = NULL;
4341:   DM                dm;


4350:   /* High level operations using the nonlinear solver */
4351:   {
4352:     PetscViewer       viewer;
4353:     PetscViewerFormat format;
4354:     PetscInt          num;
4355:     PetscBool         flg;
4356:     static PetscBool  incall = PETSC_FALSE;

4358:     if (!incall) {
4359:       /* Estimate the convergence rate of the discretization */
4360:       PetscOptionsGetViewer(PetscObjectComm((PetscObject) snes),((PetscObject)snes)->options, ((PetscObject) snes)->prefix, "-snes_convergence_estimate", &viewer, &format, &flg);
4361:       if (flg) {
4362:         PetscConvEst conv;
4363:         DM           dm;
4364:         PetscReal   *alpha; /* Convergence rate of the solution error for each field in the L_2 norm */
4365:         PetscInt     Nf;

4367:         incall = PETSC_TRUE;
4368:         SNESGetDM(snes, &dm);
4369:         DMGetNumFields(dm, &Nf);
4370:         PetscCalloc1(Nf, &alpha);
4371:         PetscConvEstCreate(PetscObjectComm((PetscObject) snes), &conv);
4372:         PetscConvEstSetSolver(conv, snes);
4373:         PetscConvEstSetFromOptions(conv);
4374:         PetscConvEstSetUp(conv);
4375:         PetscConvEstGetConvRate(conv, alpha);
4376:         PetscViewerPushFormat(viewer, format);
4377:         PetscConvEstRateView(conv, alpha, viewer);
4378:         PetscViewerPopFormat(viewer);
4379:         PetscViewerDestroy(&viewer);
4380:         PetscConvEstDestroy(&conv);
4381:         PetscFree(alpha);
4382:         incall = PETSC_FALSE;
4383:       }
4384:       /* Adaptively refine the initial grid */
4385:       num  = 1;
4386:       PetscOptionsGetInt(NULL, ((PetscObject) snes)->prefix, "-snes_adapt_initial", &num, &flg);
4387:       if (flg) {
4388:         DMAdaptor adaptor;

4390:         incall = PETSC_TRUE;
4391:         DMAdaptorCreate(PETSC_COMM_WORLD, &adaptor);
4392:         DMAdaptorSetSolver(adaptor, snes);
4393:         DMAdaptorSetSequenceLength(adaptor, num);
4394:         DMAdaptorSetFromOptions(adaptor);
4395:         DMAdaptorSetUp(adaptor);
4396:         DMAdaptorAdapt(adaptor, x, DM_ADAPTATION_INITIAL, &dm, &x);
4397:         DMAdaptorDestroy(&adaptor);
4398:         incall = PETSC_FALSE;
4399:       }
4400:       /* Use grid sequencing to adapt */
4401:       num  = 0;
4402:       PetscOptionsGetInt(NULL, ((PetscObject) snes)->prefix, "-snes_adapt_sequence", &num, NULL);
4403:       if (num) {
4404:         DMAdaptor adaptor;

4406:         incall = PETSC_TRUE;
4407:         DMAdaptorCreate(PETSC_COMM_WORLD, &adaptor);
4408:         DMAdaptorSetSolver(adaptor, snes);
4409:         DMAdaptorSetSequenceLength(adaptor, num);
4410:         DMAdaptorSetFromOptions(adaptor);
4411:         DMAdaptorSetUp(adaptor);
4412:         DMAdaptorAdapt(adaptor, x, DM_ADAPTATION_SEQUENTIAL, &dm, &x);
4413:         DMAdaptorDestroy(&adaptor);
4414:         incall = PETSC_FALSE;
4415:       }
4416:     }
4417:   }
4418:   if (!x) {
4419:     SNESGetDM(snes,&dm);
4420:     DMCreateGlobalVector(dm,&xcreated);
4421:     x    = xcreated;
4422:   }
4423:   SNESViewFromOptions(snes,NULL,"-snes_view_pre");

4425:   for (grid=0; grid<snes->gridsequence; grid++) {PetscViewerASCIIPushTab(PETSC_VIEWER_STDOUT_(PetscObjectComm((PetscObject)snes)));}
4426:   for (grid=0; grid<snes->gridsequence+1; grid++) {

4428:     /* set solution vector */
4429:     if (!grid) {PetscObjectReference((PetscObject)x);}
4430:     VecDestroy(&snes->vec_sol);
4431:     snes->vec_sol = x;
4432:     SNESGetDM(snes,&dm);

4434:     /* set affine vector if provided */
4435:     if (b) { PetscObjectReference((PetscObject)b); }
4436:     VecDestroy(&snes->vec_rhs);
4437:     snes->vec_rhs = b;

4439:     if (snes->vec_rhs && (snes->vec_func == snes->vec_rhs)) SETERRQ(PETSC_COMM_SELF,PETSC_ERR_ARG_IDN,"Right hand side vector cannot be function vector");
4440:     if (snes->vec_func == snes->vec_sol) SETERRQ(PETSC_COMM_SELF,PETSC_ERR_ARG_IDN,"Solution vector cannot be function vector");
4441:     if (snes->vec_rhs  == snes->vec_sol) SETERRQ(PETSC_COMM_SELF,PETSC_ERR_ARG_IDN,"Solution vector cannot be right hand side vector");
4442:     if (!snes->vec_sol_update /* && snes->vec_sol */) {
4443:       VecDuplicate(snes->vec_sol,&snes->vec_sol_update);
4444:       PetscLogObjectParent((PetscObject)snes,(PetscObject)snes->vec_sol_update);
4445:     }
4446:     DMShellSetGlobalVector(dm,snes->vec_sol);
4447:     SNESSetUp(snes);

4449:     if (!grid) {
4450:       if (snes->ops->computeinitialguess) {
4451:         (*snes->ops->computeinitialguess)(snes,snes->vec_sol,snes->initialguessP);
4452:       }
4453:     }

4455:     if (snes->conv_hist_reset) snes->conv_hist_len = 0;
4456:     if (snes->counters_reset) {snes->nfuncs = 0; snes->linear_its = 0; snes->numFailures = 0;}

4458:     PetscLogEventBegin(SNES_Solve,snes,0,0,0);
4459:     (*snes->ops->solve)(snes);
4460:     PetscLogEventEnd(SNES_Solve,snes,0,0,0);
4461:     if (!snes->reason) SETERRQ(PETSC_COMM_SELF,PETSC_ERR_PLIB,"Internal error, solver returned without setting converged reason");
4462:     snes->domainerror = PETSC_FALSE; /* clear the flag if it has been set */

4464:     if (snes->lagjac_persist) snes->jac_iter += snes->iter;
4465:     if (snes->lagpre_persist) snes->pre_iter += snes->iter;

4467:     PetscOptionsGetViewer(PetscObjectComm((PetscObject)snes),((PetscObject)snes)->options,((PetscObject)snes)->prefix,"-snes_test_local_min",NULL,NULL,&flg);
4468:     if (flg && !PetscPreLoadingOn) { SNESTestLocalMin(snes); }
4469:     SNESReasonViewFromOptions(snes);

4471:     if (snes->errorifnotconverged && snes->reason < 0) SETERRQ(PetscObjectComm((PetscObject)snes),PETSC_ERR_NOT_CONVERGED,"SNESSolve has not converged");
4472:     if (snes->reason < 0) break;
4473:     if (grid <  snes->gridsequence) {
4474:       DM  fine;
4475:       Vec xnew;
4476:       Mat interp;

4478:       DMRefine(snes->dm,PetscObjectComm((PetscObject)snes),&fine);
4479:       if (!fine) SETERRQ(PetscObjectComm((PetscObject)snes),PETSC_ERR_ARG_INCOMP,"DMRefine() did not perform any refinement, cannot continue grid sequencing");
4480:       DMCreateInterpolation(snes->dm,fine,&interp,NULL);
4481:       DMCreateGlobalVector(fine,&xnew);
4482:       MatInterpolate(interp,x,xnew);
4483:       DMInterpolate(snes->dm,interp,fine);
4484:       MatDestroy(&interp);
4485:       x    = xnew;

4487:       SNESReset(snes);
4488:       SNESSetDM(snes,fine);
4489:       SNESResetFromOptions(snes);
4490:       DMDestroy(&fine);
4491:       PetscViewerASCIIPopTab(PETSC_VIEWER_STDOUT_(PetscObjectComm((PetscObject)snes)));
4492:     }
4493:   }
4494:   SNESViewFromOptions(snes,NULL,"-snes_view");
4495:   VecViewFromOptions(snes->vec_sol,(PetscObject)snes,"-snes_view_solution");

4497:   VecDestroy(&xcreated);
4498:   PetscObjectSAWsBlock((PetscObject)snes);
4499:   return(0);
4500: }

4502: /* --------- Internal routines for SNES Package --------- */

4504: /*@C
4505:    SNESSetType - Sets the method for the nonlinear solver.

4507:    Collective on SNES

4509:    Input Parameters:
4510: +  snes - the SNES context
4511: -  type - a known method

4513:    Options Database Key:
4514: .  -snes_type <type> - Sets the method; use -help for a list
4515:    of available methods (for instance, newtonls or newtontr)

4517:    Notes:
4518:    See "petsc/include/petscsnes.h" for available methods (for instance)
4519: +    SNESNEWTONLS - Newton's method with line search
4520:      (systems of nonlinear equations)
4521: -    SNESNEWTONTR - Newton's method with trust region
4522:      (systems of nonlinear equations)

4524:   Normally, it is best to use the SNESSetFromOptions() command and then
4525:   set the SNES solver type from the options database rather than by using
4526:   this routine.  Using the options database provides the user with
4527:   maximum flexibility in evaluating the many nonlinear solvers.
4528:   The SNESSetType() routine is provided for those situations where it
4529:   is necessary to set the nonlinear solver independently of the command
4530:   line or options database.  This might be the case, for example, when
4531:   the choice of solver changes during the execution of the program,
4532:   and the user's application is taking responsibility for choosing the
4533:   appropriate method.

4535:     Developer Notes:
4536:     SNESRegister() adds a constructor for a new SNESType to SNESList, SNESSetType() locates
4537:     the constructor in that list and calls it to create the spexific object.

4539:   Level: intermediate

4541: .seealso: SNESType, SNESCreate(), SNESDestroy(), SNESGetType(), SNESSetFromOptions()

4543: @*/
4544: PetscErrorCode  SNESSetType(SNES snes,SNESType type)
4545: {
4546:   PetscErrorCode ierr,(*r)(SNES);
4547:   PetscBool      match;


4553:   PetscObjectTypeCompare((PetscObject)snes,type,&match);
4554:   if (match) return(0);

4556:   PetscFunctionListFind(SNESList,type,&r);
4557:   if (!r) SETERRQ1(PETSC_COMM_SELF,PETSC_ERR_ARG_UNKNOWN_TYPE,"Unable to find requested SNES type %s",type);
4558:   /* Destroy the previous private SNES context */
4559:   if (snes->ops->destroy) {
4560:     (*(snes)->ops->destroy)(snes);
4561:     snes->ops->destroy = NULL;
4562:   }
4563:   /* Reinitialize function pointers in SNESOps structure */
4564:   snes->ops->setup          = 0;
4565:   snes->ops->solve          = 0;
4566:   snes->ops->view           = 0;
4567:   snes->ops->setfromoptions = 0;
4568:   snes->ops->destroy        = 0;

4570:   /* It may happen the user has customized the line search before calling SNESSetType */
4571:   if (((PetscObject)snes)->type_name) {
4572:     SNESLineSearchDestroy(&snes->linesearch);
4573:   }

4575:   /* Call the SNESCreate_XXX routine for this particular Nonlinear solver */
4576:   snes->setupcalled = PETSC_FALSE;

4578:   PetscObjectChangeTypeName((PetscObject)snes,type);
4579:   (*r)(snes);
4580:   return(0);
4581: }

4583: /*@C
4584:    SNESGetType - Gets the SNES method type and name (as a string).

4586:    Not Collective

4588:    Input Parameter:
4589: .  snes - nonlinear solver context

4591:    Output Parameter:
4592: .  type - SNES method (a character string)

4594:    Level: intermediate

4596: @*/
4597: PetscErrorCode  SNESGetType(SNES snes,SNESType *type)
4598: {
4602:   *type = ((PetscObject)snes)->type_name;
4603:   return(0);
4604: }

4606: /*@
4607:   SNESSetSolution - Sets the solution vector for use by the SNES routines.

4609:   Logically Collective on SNES

4611:   Input Parameters:
4612: + snes - the SNES context obtained from SNESCreate()
4613: - u    - the solution vector

4615:   Level: beginner

4617: @*/
4618: PetscErrorCode SNESSetSolution(SNES snes, Vec u)
4619: {
4620:   DM             dm;

4626:   PetscObjectReference((PetscObject) u);
4627:   VecDestroy(&snes->vec_sol);

4629:   snes->vec_sol = u;

4631:   SNESGetDM(snes, &dm);
4632:   DMShellSetGlobalVector(dm, u);
4633:   return(0);
4634: }

4636: /*@
4637:    SNESGetSolution - Returns the vector where the approximate solution is
4638:    stored. This is the fine grid solution when using SNESSetGridSequence().

4640:    Not Collective, but Vec is parallel if SNES is parallel

4642:    Input Parameter:
4643: .  snes - the SNES context

4645:    Output Parameter:
4646: .  x - the solution

4648:    Level: intermediate

4650: .seealso:  SNESGetSolutionUpdate(), SNESGetFunction()
4651: @*/
4652: PetscErrorCode  SNESGetSolution(SNES snes,Vec *x)
4653: {
4657:   *x = snes->vec_sol;
4658:   return(0);
4659: }

4661: /*@
4662:    SNESGetSolutionUpdate - Returns the vector where the solution update is
4663:    stored.

4665:    Not Collective, but Vec is parallel if SNES is parallel

4667:    Input Parameter:
4668: .  snes - the SNES context

4670:    Output Parameter:
4671: .  x - the solution update

4673:    Level: advanced

4675: .seealso: SNESGetSolution(), SNESGetFunction()
4676: @*/
4677: PetscErrorCode  SNESGetSolutionUpdate(SNES snes,Vec *x)
4678: {
4682:   *x = snes->vec_sol_update;
4683:   return(0);
4684: }

4686: /*@C
4687:    SNESGetFunction - Returns the vector where the function is stored.

4689:    Not Collective, but Vec is parallel if SNES is parallel. Collective if Vec is requested, but has not been created yet.

4691:    Input Parameter:
4692: .  snes - the SNES context

4694:    Output Parameter:
4695: +  r - the vector that is used to store residuals (or NULL if you don't want it)
4696: .  f - the function (or NULL if you don't want it); see SNESFunction for calling sequence details
4697: -  ctx - the function context (or NULL if you don't want it)

4699:    Level: advanced

4701:     Notes: The vector r DOES NOT, in general contain the current value of the SNES nonlinear function

4703: .seealso: SNESSetFunction(), SNESGetSolution(), SNESFunction
4704: @*/
4705: PetscErrorCode  SNESGetFunction(SNES snes,Vec *r,PetscErrorCode (**f)(SNES,Vec,Vec,void*),void **ctx)
4706: {
4708:   DM             dm;

4712:   if (r) {
4713:     if (!snes->vec_func) {
4714:       if (snes->vec_rhs) {
4715:         VecDuplicate(snes->vec_rhs,&snes->vec_func);
4716:       } else if (snes->vec_sol) {
4717:         VecDuplicate(snes->vec_sol,&snes->vec_func);
4718:       } else if (snes->dm) {
4719:         DMCreateGlobalVector(snes->dm,&snes->vec_func);
4720:       }
4721:     }
4722:     *r = snes->vec_func;
4723:   }
4724:   SNESGetDM(snes,&dm);
4725:   DMSNESGetFunction(dm,f,ctx);
4726:   return(0);
4727: }

4729: /*@C
4730:    SNESGetNGS - Returns the NGS function and context.

4732:    Input Parameter:
4733: .  snes - the SNES context

4735:    Output Parameter:
4736: +  f - the function (or NULL) see SNESNGSFunction for details
4737: -  ctx    - the function context (or NULL)

4739:    Level: advanced

4741: .seealso: SNESSetNGS(), SNESGetFunction()
4742: @*/

4744: PetscErrorCode SNESGetNGS (SNES snes, PetscErrorCode (**f)(SNES, Vec, Vec, void*), void ** ctx)
4745: {
4747:   DM             dm;

4751:   SNESGetDM(snes,&dm);
4752:   DMSNESGetNGS(dm,f,ctx);
4753:   return(0);
4754: }

4756: /*@C
4757:    SNESSetOptionsPrefix - Sets the prefix used for searching for all
4758:    SNES options in the database.

4760:    Logically Collective on SNES

4762:    Input Parameter:
4763: +  snes - the SNES context
4764: -  prefix - the prefix to prepend to all option names

4766:    Notes:
4767:    A hyphen (-) must NOT be given at the beginning of the prefix name.
4768:    The first character of all runtime options is AUTOMATICALLY the hyphen.

4770:    Level: advanced

4772: .seealso: SNESSetFromOptions()
4773: @*/
4774: PetscErrorCode  SNESSetOptionsPrefix(SNES snes,const char prefix[])
4775: {

4780:   PetscObjectSetOptionsPrefix((PetscObject)snes,prefix);
4781:   if (!snes->ksp) {SNESGetKSP(snes,&snes->ksp);}
4782:   if (snes->linesearch) {
4783:     SNESGetLineSearch(snes,&snes->linesearch);
4784:     PetscObjectSetOptionsPrefix((PetscObject)snes->linesearch,prefix);
4785:   }
4786:   KSPSetOptionsPrefix(snes->ksp,prefix);
4787:   return(0);
4788: }

4790: /*@C
4791:    SNESAppendOptionsPrefix - Appends to the prefix used for searching for all
4792:    SNES options in the database.

4794:    Logically Collective on SNES

4796:    Input Parameters:
4797: +  snes - the SNES context
4798: -  prefix - the prefix to prepend to all option names

4800:    Notes:
4801:    A hyphen (-) must NOT be given at the beginning of the prefix name.
4802:    The first character of all runtime options is AUTOMATICALLY the hyphen.

4804:    Level: advanced

4806: .seealso: SNESGetOptionsPrefix()
4807: @*/
4808: PetscErrorCode  SNESAppendOptionsPrefix(SNES snes,const char prefix[])
4809: {

4814:   PetscObjectAppendOptionsPrefix((PetscObject)snes,prefix);
4815:   if (!snes->ksp) {SNESGetKSP(snes,&snes->ksp);}
4816:   if (snes->linesearch) {
4817:     SNESGetLineSearch(snes,&snes->linesearch);
4818:     PetscObjectAppendOptionsPrefix((PetscObject)snes->linesearch,prefix);
4819:   }
4820:   KSPAppendOptionsPrefix(snes->ksp,prefix);
4821:   return(0);
4822: }

4824: /*@C
4825:    SNESGetOptionsPrefix - Sets the prefix used for searching for all
4826:    SNES options in the database.

4828:    Not Collective

4830:    Input Parameter:
4831: .  snes - the SNES context

4833:    Output Parameter:
4834: .  prefix - pointer to the prefix string used

4836:    Notes:
4837:     On the fortran side, the user should pass in a string 'prefix' of
4838:    sufficient length to hold the prefix.

4840:    Level: advanced

4842: .seealso: SNESAppendOptionsPrefix()
4843: @*/
4844: PetscErrorCode  SNESGetOptionsPrefix(SNES snes,const char *prefix[])
4845: {

4850:   PetscObjectGetOptionsPrefix((PetscObject)snes,prefix);
4851:   return(0);
4852: }


4855: /*@C
4856:   SNESRegister - Adds a method to the nonlinear solver package.

4858:    Not collective

4860:    Input Parameters:
4861: +  name_solver - name of a new user-defined solver
4862: -  routine_create - routine to create method context

4864:    Notes:
4865:    SNESRegister() may be called multiple times to add several user-defined solvers.

4867:    Sample usage:
4868: .vb
4869:    SNESRegister("my_solver",MySolverCreate);
4870: .ve

4872:    Then, your solver can be chosen with the procedural interface via
4873: $     SNESSetType(snes,"my_solver")
4874:    or at runtime via the option
4875: $     -snes_type my_solver

4877:    Level: advanced

4879:     Note: If your function is not being put into a shared library then use SNESRegister() instead

4881: .seealso: SNESRegisterAll(), SNESRegisterDestroy()

4883:   Level: advanced
4884: @*/
4885: PetscErrorCode  SNESRegister(const char sname[],PetscErrorCode (*function)(SNES))
4886: {

4890:   SNESInitializePackage();
4891:   PetscFunctionListAdd(&SNESList,sname,function);
4892:   return(0);
4893: }

4895: PetscErrorCode  SNESTestLocalMin(SNES snes)
4896: {
4898:   PetscInt       N,i,j;
4899:   Vec            u,uh,fh;
4900:   PetscScalar    value;
4901:   PetscReal      norm;

4904:   SNESGetSolution(snes,&u);
4905:   VecDuplicate(u,&uh);
4906:   VecDuplicate(u,&fh);

4908:   /* currently only works for sequential */
4909:   PetscPrintf(PETSC_COMM_WORLD,"Testing FormFunction() for local min\n");
4910:   VecGetSize(u,&N);
4911:   for (i=0; i<N; i++) {
4912:     VecCopy(u,uh);
4913:     PetscPrintf(PETSC_COMM_WORLD,"i = %D\n",i);
4914:     for (j=-10; j<11; j++) {
4915:       value = PetscSign(j)*PetscExpReal(PetscAbs(j)-10.0);
4916:       VecSetValue(uh,i,value,ADD_VALUES);
4917:       SNESComputeFunction(snes,uh,fh);
4918:       VecNorm(fh,NORM_2,&norm);
4919:       PetscPrintf(PETSC_COMM_WORLD,"       j norm %D %18.16e\n",j,norm);
4920:       value = -value;
4921:       VecSetValue(uh,i,value,ADD_VALUES);
4922:     }
4923:   }
4924:   VecDestroy(&uh);
4925:   VecDestroy(&fh);
4926:   return(0);
4927: }

4929: /*@
4930:    SNESKSPSetUseEW - Sets SNES use Eisenstat-Walker method for
4931:    computing relative tolerance for linear solvers within an inexact
4932:    Newton method.

4934:    Logically Collective on SNES

4936:    Input Parameters:
4937: +  snes - SNES context
4938: -  flag - PETSC_TRUE or PETSC_FALSE

4940:     Options Database:
4941: +  -snes_ksp_ew - use Eisenstat-Walker method for determining linear system convergence
4942: .  -snes_ksp_ew_version ver - version of  Eisenstat-Walker method
4943: .  -snes_ksp_ew_rtol0 <rtol0> - Sets rtol0
4944: .  -snes_ksp_ew_rtolmax <rtolmax> - Sets rtolmax
4945: .  -snes_ksp_ew_gamma <gamma> - Sets gamma
4946: .  -snes_ksp_ew_alpha <alpha> - Sets alpha
4947: .  -snes_ksp_ew_alpha2 <alpha2> - Sets alpha2
4948: -  -snes_ksp_ew_threshold <threshold> - Sets threshold

4950:    Notes:
4951:    Currently, the default is to use a constant relative tolerance for
4952:    the inner linear solvers.  Alternatively, one can use the
4953:    Eisenstat-Walker method, where the relative convergence tolerance
4954:    is reset at each Newton iteration according progress of the nonlinear
4955:    solver.

4957:    Level: advanced

4959:    Reference:
4960:    S. C. Eisenstat and H. F. Walker, "Choosing the forcing terms in an
4961:    inexact Newton method", SISC 17 (1), pp.16-32, 1996.

4963: .seealso: SNESKSPGetUseEW(), SNESKSPGetParametersEW(), SNESKSPSetParametersEW()
4964: @*/
4965: PetscErrorCode  SNESKSPSetUseEW(SNES snes,PetscBool flag)
4966: {
4970:   snes->ksp_ewconv = flag;
4971:   return(0);
4972: }

4974: /*@
4975:    SNESKSPGetUseEW - Gets if SNES is using Eisenstat-Walker method
4976:    for computing relative tolerance for linear solvers within an
4977:    inexact Newton method.

4979:    Not Collective

4981:    Input Parameter:
4982: .  snes - SNES context

4984:    Output Parameter:
4985: .  flag - PETSC_TRUE or PETSC_FALSE

4987:    Notes:
4988:    Currently, the default is to use a constant relative tolerance for
4989:    the inner linear solvers.  Alternatively, one can use the
4990:    Eisenstat-Walker method, where the relative convergence tolerance
4991:    is reset at each Newton iteration according progress of the nonlinear
4992:    solver.

4994:    Level: advanced

4996:    Reference:
4997:    S. C. Eisenstat and H. F. Walker, "Choosing the forcing terms in an
4998:    inexact Newton method", SISC 17 (1), pp.16-32, 1996.

5000: .seealso: SNESKSPSetUseEW(), SNESKSPGetParametersEW(), SNESKSPSetParametersEW()
5001: @*/
5002: PetscErrorCode  SNESKSPGetUseEW(SNES snes, PetscBool  *flag)
5003: {
5007:   *flag = snes->ksp_ewconv;
5008:   return(0);
5009: }

5011: /*@
5012:    SNESKSPSetParametersEW - Sets parameters for Eisenstat-Walker
5013:    convergence criteria for the linear solvers within an inexact
5014:    Newton method.

5016:    Logically Collective on SNES

5018:    Input Parameters:
5019: +    snes - SNES context
5020: .    version - version 1, 2 (default is 2) or 3
5021: .    rtol_0 - initial relative tolerance (0 <= rtol_0 < 1)
5022: .    rtol_max - maximum relative tolerance (0 <= rtol_max < 1)
5023: .    gamma - multiplicative factor for version 2 rtol computation
5024:              (0 <= gamma2 <= 1)
5025: .    alpha - power for version 2 rtol computation (1 < alpha <= 2)
5026: .    alpha2 - power for safeguard
5027: -    threshold - threshold for imposing safeguard (0 < threshold < 1)

5029:    Note:
5030:    Version 3 was contributed by Luis Chacon, June 2006.

5032:    Use PETSC_DEFAULT to retain the default for any of the parameters.

5034:    Level: advanced

5036:    Reference:
5037:    S. C. Eisenstat and H. F. Walker, "Choosing the forcing terms in an
5038:    inexact Newton method", Utah State University Math. Stat. Dept. Res.
5039:    Report 6/94/75, June, 1994, to appear in SIAM J. Sci. Comput.

5041: .seealso: SNESKSPSetUseEW(), SNESKSPGetUseEW(), SNESKSPGetParametersEW()
5042: @*/
5043: PetscErrorCode  SNESKSPSetParametersEW(SNES snes,PetscInt version,PetscReal rtol_0,PetscReal rtol_max,PetscReal gamma,PetscReal alpha,PetscReal alpha2,PetscReal threshold)
5044: {
5045:   SNESKSPEW *kctx;

5049:   kctx = (SNESKSPEW*)snes->kspconvctx;
5050:   if (!kctx) SETERRQ(PETSC_COMM_SELF,PETSC_ERR_ARG_WRONGSTATE,"No Eisenstat-Walker context existing");

5059:   if (version != PETSC_DEFAULT)   kctx->version   = version;
5060:   if (rtol_0 != PETSC_DEFAULT)    kctx->rtol_0    = rtol_0;
5061:   if (rtol_max != PETSC_DEFAULT)  kctx->rtol_max  = rtol_max;
5062:   if (gamma != PETSC_DEFAULT)     kctx->gamma     = gamma;
5063:   if (alpha != PETSC_DEFAULT)     kctx->alpha     = alpha;
5064:   if (alpha2 != PETSC_DEFAULT)    kctx->alpha2    = alpha2;
5065:   if (threshold != PETSC_DEFAULT) kctx->threshold = threshold;

5067:   if (kctx->version < 1 || kctx->version > 3) SETERRQ1(PETSC_COMM_SELF,PETSC_ERR_ARG_OUTOFRANGE,"Only versions 1, 2 and 3 are supported: %D",kctx->version);
5068:   if (kctx->rtol_0 < 0.0 || kctx->rtol_0 >= 1.0) SETERRQ1(PETSC_COMM_SELF,PETSC_ERR_ARG_OUTOFRANGE,"0.0 <= rtol_0 < 1.0: %g",(double)kctx->rtol_0);
5069:   if (kctx->rtol_max < 0.0 || kctx->rtol_max >= 1.0) SETERRQ1(PETSC_COMM_SELF,PETSC_ERR_ARG_OUTOFRANGE,"0.0 <= rtol_max (%g) < 1.0\n",(double)kctx->rtol_max);
5070:   if (kctx->gamma < 0.0 || kctx->gamma > 1.0) SETERRQ1(PETSC_COMM_SELF,PETSC_ERR_ARG_OUTOFRANGE,"0.0 <= gamma (%g) <= 1.0\n",(double)kctx->gamma);
5071:   if (kctx->alpha <= 1.0 || kctx->alpha > 2.0) SETERRQ1(PETSC_COMM_SELF,PETSC_ERR_ARG_OUTOFRANGE,"1.0 < alpha (%g) <= 2.0\n",(double)kctx->alpha);
5072:   if (kctx->threshold <= 0.0 || kctx->threshold >= 1.0) SETERRQ1(PETSC_COMM_SELF,PETSC_ERR_ARG_OUTOFRANGE,"0.0 < threshold (%g) < 1.0\n",(double)kctx->threshold);
5073:   return(0);
5074: }

5076: /*@
5077:    SNESKSPGetParametersEW - Gets parameters for Eisenstat-Walker
5078:    convergence criteria for the linear solvers within an inexact
5079:    Newton method.

5081:    Not Collective

5083:    Input Parameters:
5084:      snes - SNES context

5086:    Output Parameters:
5087: +    version - version 1, 2 (default is 2) or 3
5088: .    rtol_0 - initial relative tolerance (0 <= rtol_0 < 1)
5089: .    rtol_max - maximum relative tolerance (0 <= rtol_max < 1)
5090: .    gamma - multiplicative factor for version 2 rtol computation (0 <= gamma2 <= 1)
5091: .    alpha - power for version 2 rtol computation (1 < alpha <= 2)
5092: .    alpha2 - power for safeguard
5093: -    threshold - threshold for imposing safeguard (0 < threshold < 1)

5095:    Level: advanced

5097: .seealso: SNESKSPSetUseEW(), SNESKSPGetUseEW(), SNESKSPSetParametersEW()
5098: @*/
5099: PetscErrorCode  SNESKSPGetParametersEW(SNES snes,PetscInt *version,PetscReal *rtol_0,PetscReal *rtol_max,PetscReal *gamma,PetscReal *alpha,PetscReal *alpha2,PetscReal *threshold)
5100: {
5101:   SNESKSPEW *kctx;

5105:   kctx = (SNESKSPEW*)snes->kspconvctx;
5106:   if (!kctx) SETERRQ(PETSC_COMM_SELF,PETSC_ERR_ARG_WRONGSTATE,"No Eisenstat-Walker context existing");
5107:   if (version)   *version   = kctx->version;
5108:   if (rtol_0)    *rtol_0    = kctx->rtol_0;
5109:   if (rtol_max)  *rtol_max  = kctx->rtol_max;
5110:   if (gamma)     *gamma     = kctx->gamma;
5111:   if (alpha)     *alpha     = kctx->alpha;
5112:   if (alpha2)    *alpha2    = kctx->alpha2;
5113:   if (threshold) *threshold = kctx->threshold;
5114:   return(0);
5115: }

5117:  PetscErrorCode KSPPreSolve_SNESEW(KSP ksp, Vec b, Vec x, SNES snes)
5118: {
5120:   SNESKSPEW      *kctx = (SNESKSPEW*)snes->kspconvctx;
5121:   PetscReal      rtol  = PETSC_DEFAULT,stol;

5124:   if (!snes->ksp_ewconv) return(0);
5125:   if (!snes->iter) {
5126:     rtol = kctx->rtol_0; /* first time in, so use the original user rtol */
5127:     VecNorm(snes->vec_func,NORM_2,&kctx->norm_first);
5128:   }
5129:   else {
5130:     if (kctx->version == 1) {
5131:       rtol = (snes->norm - kctx->lresid_last)/kctx->norm_last;
5132:       if (rtol < 0.0) rtol = -rtol;
5133:       stol = PetscPowReal(kctx->rtol_last,kctx->alpha2);
5134:       if (stol > kctx->threshold) rtol = PetscMax(rtol,stol);
5135:     } else if (kctx->version == 2) {
5136:       rtol = kctx->gamma * PetscPowReal(snes->norm/kctx->norm_last,kctx->alpha);
5137:       stol = kctx->gamma * PetscPowReal(kctx->rtol_last,kctx->alpha);
5138:       if (stol > kctx->threshold) rtol = PetscMax(rtol,stol);
5139:     } else if (kctx->version == 3) { /* contributed by Luis Chacon, June 2006. */
5140:       rtol = kctx->gamma * PetscPowReal(snes->norm/kctx->norm_last,kctx->alpha);
5141:       /* safeguard: avoid sharp decrease of rtol */
5142:       stol = kctx->gamma*PetscPowReal(kctx->rtol_last,kctx->alpha);
5143:       stol = PetscMax(rtol,stol);
5144:       rtol = PetscMin(kctx->rtol_0,stol);
5145:       /* safeguard: avoid oversolving */
5146:       stol = kctx->gamma*(kctx->norm_first*snes->rtol)/snes->norm;
5147:       stol = PetscMax(rtol,stol);
5148:       rtol = PetscMin(kctx->rtol_0,stol);
5149:     } else SETERRQ1(PETSC_COMM_SELF,PETSC_ERR_ARG_OUTOFRANGE,"Only versions 1, 2 or 3 are supported: %D",kctx->version);
5150:   }
5151:   /* safeguard: avoid rtol greater than one */
5152:   rtol = PetscMin(rtol,kctx->rtol_max);
5153:   KSPSetTolerances(ksp,rtol,PETSC_DEFAULT,PETSC_DEFAULT,PETSC_DEFAULT);
5154:   PetscInfo3(snes,"iter %D, Eisenstat-Walker (version %D) KSP rtol=%g\n",snes->iter,kctx->version,(double)rtol);
5155:   return(0);
5156: }

5158: PetscErrorCode KSPPostSolve_SNESEW(KSP ksp, Vec b, Vec x, SNES snes)
5159: {
5161:   SNESKSPEW      *kctx = (SNESKSPEW*)snes->kspconvctx;
5162:   PCSide         pcside;
5163:   Vec            lres;

5166:   if (!snes->ksp_ewconv) return(0);
5167:   KSPGetTolerances(ksp,&kctx->rtol_last,0,0,0);
5168:   kctx->norm_last = snes->norm;
5169:   if (kctx->version == 1) {
5170:     PC        pc;
5171:     PetscBool isNone;

5173:     KSPGetPC(ksp, &pc);
5174:     PetscObjectTypeCompare((PetscObject) pc, PCNONE, &isNone);
5175:     KSPGetPCSide(ksp,&pcside);
5176:      if (pcside == PC_RIGHT || isNone) { /* XXX Should we also test KSP_UNPRECONDITIONED_NORM ? */
5177:       /* KSP residual is true linear residual */
5178:       KSPGetResidualNorm(ksp,&kctx->lresid_last);
5179:     } else {
5180:       /* KSP residual is preconditioned residual */
5181:       /* compute true linear residual norm */
5182:       VecDuplicate(b,&lres);
5183:       MatMult(snes->jacobian,x,lres);
5184:       VecAYPX(lres,-1.0,b);
5185:       VecNorm(lres,NORM_2,&kctx->lresid_last);
5186:       VecDestroy(&lres);
5187:     }
5188:   }
5189:   return(0);
5190: }

5192: /*@
5193:    SNESGetKSP - Returns the KSP context for a SNES solver.

5195:    Not Collective, but if SNES object is parallel, then KSP object is parallel

5197:    Input Parameter:
5198: .  snes - the SNES context

5200:    Output Parameter:
5201: .  ksp - the KSP context

5203:    Notes:
5204:    The user can then directly manipulate the KSP context to set various
5205:    options, etc.  Likewise, the user can then extract and manipulate the
5206:    PC contexts as well.

5208:    Level: beginner

5210: .seealso: KSPGetPC(), SNESCreate(), KSPCreate(), SNESSetKSP()
5211: @*/
5212: PetscErrorCode  SNESGetKSP(SNES snes,KSP *ksp)
5213: {


5220:   if (!snes->ksp) {
5221:     PetscBool monitor = PETSC_FALSE;

5223:     KSPCreate(PetscObjectComm((PetscObject)snes),&snes->ksp);
5224:     PetscObjectIncrementTabLevel((PetscObject)snes->ksp,(PetscObject)snes,1);
5225:     PetscLogObjectParent((PetscObject)snes,(PetscObject)snes->ksp);

5227:     KSPSetPreSolve(snes->ksp,(PetscErrorCode (*)(KSP,Vec,Vec,void*))KSPPreSolve_SNESEW,snes);
5228:     KSPSetPostSolve(snes->ksp,(PetscErrorCode (*)(KSP,Vec,Vec,void*))KSPPostSolve_SNESEW,snes);

5230:     PetscOptionsGetBool(((PetscObject)snes)->options,((PetscObject)snes)->prefix,"-ksp_monitor_snes",&monitor,NULL);
5231:     if (monitor) {
5232:       KSPMonitorSet(snes->ksp,KSPMonitorSNES,snes,NULL);
5233:     }
5234:     monitor = PETSC_FALSE;
5235:     PetscOptionsGetBool(((PetscObject)snes)->options,((PetscObject)snes)->prefix,"-ksp_monitor_snes_lg",&monitor,NULL);
5236:     if (monitor) {
5237:       PetscObject *objs;
5238:       KSPMonitorSNESLGResidualNormCreate(PetscObjectComm((PetscObject)snes),NULL,NULL,PETSC_DECIDE,PETSC_DECIDE,600,600,&objs);
5239:       objs[0] = (PetscObject) snes;
5240:       KSPMonitorSet(snes->ksp,(PetscErrorCode (*)(KSP,PetscInt,PetscReal,void*))KSPMonitorSNESLGResidualNorm,objs,(PetscErrorCode (*)(void**))KSPMonitorSNESLGResidualNormDestroy);
5241:     }
5242:     PetscObjectSetOptions((PetscObject)snes->ksp,((PetscObject)snes)->options);
5243:   }
5244:   *ksp = snes->ksp;
5245:   return(0);
5246: }


5249:  #include <petsc/private/dmimpl.h>
5250: /*@
5251:    SNESSetDM - Sets the DM that may be used by some nonlinear solvers or their underlying preconditioners

5253:    Logically Collective on SNES

5255:    Input Parameters:
5256: +  snes - the nonlinear solver context
5257: -  dm - the dm, cannot be NULL

5259:    Notes:
5260:    A DM can only be used for solving one problem at a time because information about the problem is stored on the DM,
5261:    even when not using interfaces like DMSNESSetFunction().  Use DMClone() to get a distinct DM when solving different
5262:    problems using the same function space.

5264:    Level: intermediate

5266: .seealso: SNESGetDM(), KSPSetDM(), KSPGetDM()
5267: @*/
5268: PetscErrorCode  SNESSetDM(SNES snes,DM dm)
5269: {
5271:   KSP            ksp;
5272:   DMSNES         sdm;

5277:   PetscObjectReference((PetscObject)dm);
5278:   if (snes->dm) {               /* Move the DMSNES context over to the new DM unless the new DM already has one */
5279:     if (snes->dm->dmsnes && !dm->dmsnes) {
5280:       DMCopyDMSNES(snes->dm,dm);
5281:       DMGetDMSNES(snes->dm,&sdm);
5282:       if (sdm->originaldm == snes->dm) sdm->originaldm = dm; /* Grant write privileges to the replacement DM */
5283:     }
5284:     DMCoarsenHookRemove(snes->dm,DMCoarsenHook_SNESVecSol,DMRestrictHook_SNESVecSol,snes);
5285:     DMDestroy(&snes->dm);
5286:   }
5287:   snes->dm     = dm;
5288:   snes->dmAuto = PETSC_FALSE;

5290:   SNESGetKSP(snes,&ksp);
5291:   KSPSetDM(ksp,dm);
5292:   KSPSetDMActive(ksp,PETSC_FALSE);
5293:   if (snes->npc) {
5294:     SNESSetDM(snes->npc, snes->dm);
5295:     SNESSetNPCSide(snes,snes->npcside);
5296:   }
5297:   return(0);
5298: }

5300: /*@
5301:    SNESGetDM - Gets the DM that may be used by some preconditioners

5303:    Not Collective but DM obtained is parallel on SNES

5305:    Input Parameter:
5306: . snes - the preconditioner context

5308:    Output Parameter:
5309: .  dm - the dm

5311:    Level: intermediate

5313: .seealso: SNESSetDM(), KSPSetDM(), KSPGetDM()
5314: @*/
5315: PetscErrorCode  SNESGetDM(SNES snes,DM *dm)
5316: {

5321:   if (!snes->dm) {
5322:     DMShellCreate(PetscObjectComm((PetscObject)snes),&snes->dm);
5323:     snes->dmAuto = PETSC_TRUE;
5324:   }
5325:   *dm = snes->dm;
5326:   return(0);
5327: }

5329: /*@
5330:   SNESSetNPC - Sets the nonlinear preconditioner to be used.

5332:   Collective on SNES

5334:   Input Parameters:
5335: + snes - iterative context obtained from SNESCreate()
5336: - pc   - the preconditioner object

5338:   Notes:
5339:   Use SNESGetNPC() to retrieve the preconditioner context (for example,
5340:   to configure it using the API).

5342:   Level: developer

5344: .seealso: SNESGetNPC(), SNESHasNPC()
5345: @*/
5346: PetscErrorCode SNESSetNPC(SNES snes, SNES pc)
5347: {

5354:   PetscObjectReference((PetscObject) pc);
5355:   SNESDestroy(&snes->npc);
5356:   snes->npc = pc;
5357:   PetscLogObjectParent((PetscObject)snes, (PetscObject)snes->npc);
5358:   return(0);
5359: }

5361: /*@
5362:   SNESGetNPC - Creates a nonlinear preconditioning solver (SNES) to be used to precondition the nonlinear solver.

5364:   Not Collective; but any changes to the obtained SNES object must be applied collectively

5366:   Input Parameter:
5367: . snes - iterative context obtained from SNESCreate()

5369:   Output Parameter:
5370: . pc - preconditioner context

5372:   Options Database:
5373: . -npc_snes_type <type> - set the type of the SNES to use as the nonlinear preconditioner

5375:   Notes:
5376:     If a SNES was previously set with SNESSetNPC() then that SNES is returned, otherwise a new SNES object is created.

5378:     The (preconditioner) SNES returned automatically inherits the same nonlinear function and Jacobian supplied to the original
5379:     SNES during SNESSetUp()

5381:   Level: developer

5383: .seealso: SNESSetNPC(), SNESHasNPC(), SNES, SNESCreate()
5384: @*/
5385: PetscErrorCode SNESGetNPC(SNES snes, SNES *pc)
5386: {
5388:   const char     *optionsprefix;

5393:   if (!snes->npc) {
5394:     SNESCreate(PetscObjectComm((PetscObject)snes),&snes->npc);
5395:     PetscObjectIncrementTabLevel((PetscObject)snes->npc,(PetscObject)snes,1);
5396:     PetscLogObjectParent((PetscObject)snes,(PetscObject)snes->npc);
5397:     SNESGetOptionsPrefix(snes,&optionsprefix);
5398:     SNESSetOptionsPrefix(snes->npc,optionsprefix);
5399:     SNESAppendOptionsPrefix(snes->npc,"npc_");
5400:     SNESSetCountersReset(snes->npc,PETSC_FALSE);
5401:   }
5402:   *pc = snes->npc;
5403:   return(0);
5404: }

5406: /*@
5407:   SNESHasNPC - Returns whether a nonlinear preconditioner exists

5409:   Not Collective

5411:   Input Parameter:
5412: . snes - iterative context obtained from SNESCreate()

5414:   Output Parameter:
5415: . has_npc - whether the SNES has an NPC or not

5417:   Level: developer

5419: .seealso: SNESSetNPC(), SNESGetNPC()
5420: @*/
5421: PetscErrorCode SNESHasNPC(SNES snes, PetscBool *has_npc)
5422: {
5425:   *has_npc = (PetscBool) (snes->npc ? PETSC_TRUE : PETSC_FALSE);
5426:   return(0);
5427: }

5429: /*@
5430:     SNESSetNPCSide - Sets the preconditioning side.

5432:     Logically Collective on SNES

5434:     Input Parameter:
5435: .   snes - iterative context obtained from SNESCreate()

5437:     Output Parameter:
5438: .   side - the preconditioning side, where side is one of
5439: .vb
5440:       PC_LEFT - left preconditioning
5441:       PC_RIGHT - right preconditioning (default for most nonlinear solvers)
5442: .ve

5444:     Options Database Keys:
5445: .   -snes_pc_side <right,left>

5447:     Notes:
5448:     SNESNRICHARDSON and SNESNCG only support left preconditioning.

5450:     Level: intermediate

5452: .seealso: SNESGetNPCSide(), KSPSetPCSide()
5453: @*/
5454: PetscErrorCode  SNESSetNPCSide(SNES snes,PCSide side)
5455: {
5459:   snes->npcside= side;
5460:   return(0);
5461: }

5463: /*@
5464:     SNESGetNPCSide - Gets the preconditioning side.

5466:     Not Collective

5468:     Input Parameter:
5469: .   snes - iterative context obtained from SNESCreate()

5471:     Output Parameter:
5472: .   side - the preconditioning side, where side is one of
5473: .vb
5474:       PC_LEFT - left preconditioning
5475:       PC_RIGHT - right preconditioning (default for most nonlinear solvers)
5476: .ve

5478:     Level: intermediate

5480: .seealso: SNESSetNPCSide(), KSPGetPCSide()
5481: @*/
5482: PetscErrorCode  SNESGetNPCSide(SNES snes,PCSide *side)
5483: {
5487:   *side = snes->npcside;
5488:   return(0);
5489: }

5491: /*@
5492:   SNESSetLineSearch - Sets the linesearch on the SNES instance.

5494:   Collective on SNES

5496:   Input Parameters:
5497: + snes - iterative context obtained from SNESCreate()
5498: - linesearch   - the linesearch object

5500:   Notes:
5501:   Use SNESGetLineSearch() to retrieve the preconditioner context (for example,
5502:   to configure it using the API).

5504:   Level: developer

5506: .seealso: SNESGetLineSearch()
5507: @*/
5508: PetscErrorCode SNESSetLineSearch(SNES snes, SNESLineSearch linesearch)
5509: {

5516:   PetscObjectReference((PetscObject) linesearch);
5517:   SNESLineSearchDestroy(&snes->linesearch);

5519:   snes->linesearch = linesearch;

5521:   PetscLogObjectParent((PetscObject)snes, (PetscObject)snes->linesearch);
5522:   return(0);
5523: }

5525: /*@
5526:   SNESGetLineSearch - Returns a pointer to the line search context set with SNESSetLineSearch()
5527:   or creates a default line search instance associated with the SNES and returns it.

5529:   Not Collective

5531:   Input Parameter:
5532: . snes - iterative context obtained from SNESCreate()

5534:   Output Parameter:
5535: . linesearch - linesearch context

5537:   Level: beginner

5539: .seealso: SNESSetLineSearch(), SNESLineSearchCreate()
5540: @*/
5541: PetscErrorCode SNESGetLineSearch(SNES snes, SNESLineSearch *linesearch)
5542: {
5544:   const char     *optionsprefix;

5549:   if (!snes->linesearch) {
5550:     SNESGetOptionsPrefix(snes, &optionsprefix);
5551:     SNESLineSearchCreate(PetscObjectComm((PetscObject)snes), &snes->linesearch);
5552:     SNESLineSearchSetSNES(snes->linesearch, snes);
5553:     SNESLineSearchAppendOptionsPrefix(snes->linesearch, optionsprefix);
5554:     PetscObjectIncrementTabLevel((PetscObject) snes->linesearch, (PetscObject) snes, 1);
5555:     PetscLogObjectParent((PetscObject)snes, (PetscObject)snes->linesearch);
5556:   }
5557:   *linesearch = snes->linesearch;
5558:   return(0);
5559: }